MATLAB Source Codes


  1. advection_pde, a MATLAB code which solves the advection partial differential equation (PDE) dudt + c * dudx = 0 in one spatial dimension, with a constant velocity c, and periodic boundary conditions, using the FTCS method, forward time difference, centered space difference.
  2. advection_pde_test
  3. allen_cahn_pde, a MATLAB code which sets up and solves the Allen-Cahn reaction-diffusion system of partial differential equations (PDE) in 1 space dimension and time.
  4. allen_cahn_pde_test
  5. allen_cahn_pde_etdrk4_test a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Allen-Cahn system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
  6. allen_cahn_pde_etdrk4_test
  7. allen_cahn_pde_euler a MATLAB code which uses the Euler method to solve the Allen-Cahn PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
  8. allen_cahn_pde_euler_test
  9. alpert_rule, a MATLAB code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
  10. alpert_rule_test
  11. analemma, a MATLAB code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, based on a C program by Brian Tung.
  12. analemma_test
  13. anishchenko_ode, a MATLAB code which sets up and solves the Anishchenko ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  14. anishchenko_ode_test
  15. annulus_distance, a MATLAB code which estimates the typical distance between a pair of points randomly selected inside a circular annulus.
  16. annulus_distance_test
  17. annulus_grid, a MATLAB code which computes a grid of points over the interior of a circular annulus.
  18. annulus_grid_test
  19. annulus_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of a circular annulus centered at the origin.
  20. annulus_integrals_test
  21. annulus_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.
  22. annulus_monte_carlo_test
  23. annulus_rule, a MATLAB code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
  24. annulus_rule_test
  25. approx_bernstein, a MATLAB code which interactively approximates a function f(x) in the interval [a,b] by constructing a Bernstein polynomial.
  26. approx_bernstein_test
  27. approx_chebyshev, a MATLAB code which interactively approximates a function f(x) in the interval [a,b] by constructing a Chebyshev polynomial interpolant that is often a good estimate of the minmax polynomial.
  28. approx_chebyshev_test
  29. approx_leastsquares, a MATLAB code which interactively approximates a function f(x) in the interval [a,b] by constructing an m-degree polynomial which minimizes the square root of the sum of the squares of the error with n sample data points.
  30. approx_leastsquares_test
  31. arclength, a MATLAB code which estimates the arclength of curves of the form (x,f(x)) or (x(t),y(t)).
  32. arclength_test
  33. arenstorf_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which defines a stable periodic orbit of a spacecraft around the Earth and the Moon.
  34. arenstorf_ode_test
  35. args, a function which shows how to count and report command line arguments;
  36. args_test
  37. arneodo_ode, a MATLAB code which sets up and solves the Arneodo ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  38. arneodo_ode_test
  39. arpack_test, a MATLAB code which calls arpack(), which computes eigenvalues and eigenvectors of large sparse matrices, accessible via the built-in eigs() command;
  40. artery_pde, a MATLAB code which solves a partial differential equation (PDE) that models the displacement of arterial walls under pressure.
  41. artery_pde_test
  42. asa_2011_geometry, a MATLAB code which was used during labs, demonstrations, and lectures associated with the Geometry Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.
  43. asa_2011_geometry_test
  44. asa_2011_graphs, a MATLAB code which was used during labs, demonstrations, and lectures associated with the Graph Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.
  45. asa_2011_images, a MATLAB code which was used during labs, demonstrations, and lectures associated with the Image Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.
  46. asa005, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
  47. asa005_test
  48. asa006, a MATLAB code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
  49. asa006_test
  50. asa007, a MATLAB code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
  51. asa007_test
  52. asa032, a MATLAB code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
  53. asa032_test
  54. asa047, a MATLAB code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
  55. asa047_test
  56. asa053, a MATLAB code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
  57. asa053_test
  58. asa058, a MATLAB code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
  59. asa058_test
  60. asa063, a MATLAB code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
  61. asa063_test
  62. asa066, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the normal probability distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.
  63. asa066_test
  64. asa076, a MATLAB code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
  65. asa076_test
  66. asa082, a MATLAB code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
  67. asa082_test
  68. asa091, a MATLAB code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
  69. asa091_test
  70. asa103, a MATLAB code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
  71. asa103_test
  72. asa109, a MATLAB code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
  73. asa109_test
  74. asa111, a MATLAB code which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.
  75. asa111_test
  76. asa113, a MATLAB code which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.
  77. asa113_test
  78. asa121, a MATLAB code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
  79. asa121_test
  80. asa136, a MATLAB code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
  81. asa136_test
  82. asa144, a MATLAB code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
  83. asa144_test
  84. asa147, a MATLAB code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
  85. asa147_test
  86. asa152, a MATLAB code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152.
  87. asa152_test
  88. asa159, a MATLAB code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
  89. asa159_test
  90. asa172, a MATLAB code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
  91. asa172_test
  92. asa183, a MATLAB code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
  93. asa183_test
  94. asa226, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
  95. asa226_test
  96. asa239, a MATLAB code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
  97. asa239_test
  98. asa241, a MATLAB code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
  99. asa241_test
  100. asa243, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
  101. asa243_test
  102. asa245, a MATLAB code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
  103. asa245_test
  104. asa266, a MATLAB code which evaluates various properties of the Dirichlet Probability Density Function (PDF); This is a version of Applied Statistics Algorithm 266.
  105. asa266_test
  106. asa299, a MATLAB code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
  107. asa299_test
  108. asa310, a MATLAB code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
  109. asa310_test
  110. asa314, a MATLAB code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
  111. asa314_test
  112. atbash, a MATLAB code which applies the Atbash substitution cipher to a string of text.
  113. atbash_test
  114. atkinson, a MATLAB code which contains examples from the text 'Elementary Numerical Analysis', by Atkinson.
  115. atkinson_test
  116. autocatalytic_ode, a MATLAB code which sets up and solves the autocatalytic ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  117. autocatalytic_ode_test
  118. axon_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) for the Hodgkin-Huxley model of an axon.
  119. axon_ode_test
  120. backtrack_binary_rc, a MATLAB code which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).
  121. backtrack_binary_rc_test
  122. backward_euler, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using fsolve() for the implicit equation.
  123. backward_euler_test
  124. backward_euler_fixed, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a fixed point iteration for the implicit equation.
  125. backward_euler_fixed_test
  126. ball_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit ball in 3D.
  127. ball_distance_test
  128. ball_grid, a MATLAB code which computes a grid of points over the interior of the unit ball in 3D.
  129. ball_grid_test
  130. ball_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
  131. ball_integrals_test
  132. ball_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
  133. ball_monte_carlo_test
  134. ball_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit positive ball in 3D.
  135. ball_positive_distance_test
  136. bank, a MATLAB code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
  137. bank_test
  138. barycentric_interp_1d, a MATLAB code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.
  139. barycentric_interp_1d_test
  140. bdf2, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
  141. bdf2_test
  142. bellman_ford, a MATLAB code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
  143. bellman_ford_test
  144. bernstein_approximation, a MATLAB code which looks at some simple cases of approximation of a function f(x) by a Bernstein polynomial.
  145. bernstein_approximation_test
  146. bernstein_polynomial, a MATLAB code which evaluates the Bernstein polynomials;
  147. bernstein_polynomial_test
  148. besselj, a MATLAB code which evaluates Bessel J functions of noninteger order;
  149. besselj_test
  150. besselzero, a MATLAB code which computes the zeros of Bessel functions j or y, by Greg van Winckel and Jason Nicholson.
  151. besselzero_test
  152. beta_nc, a MATLAB code which evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
  153. beta_nc_test
  154. bezier_surface, a MATLAB code which reads, writes, prints and manipulates the data that defines a Bezier surface;
  155. bezier_surface_test
  156. bezier_surface_display, a MATLAB code which displays a Bezier surface;
  157. bezier_surface_display_test
  158. bicg, a MATLAB code which implements the biconjugate gradient method (BICG), which estimates the solution of a large sparse nonsymmetric linear system.
  159. bicg_test
  160. biharmonic_cheby1d, a MATLAB code which uses Chebyshev methods to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
  161. biharmonic_cheby1d_test
  162. biharmonic_fd1d, a MATLAB code which applies the finite difference method to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
  163. biharmonic_fd1d_test
  164. biharmonic_fd2d, a MATLAB code which deals with the biharmonic equation in two dimensions, whose simplest form is uxxxx + 2uxxyy + uyyyy = f.
  165. biharmonic_fd2d_test
  166. biochemical_linear_ode, a MATLAB code which sets up and solves a linear biochemical ordinary differential equation (ODE).
  167. biochemical_linear_ode_test
  168. biochemical_nonlinear_ode, a MATLAB code which sets up and solves a nonlinear biochemical ordinary differential equation (ODE).
  169. biochemical_nonlinear_ode_test
  170. bioconvection_ode, a MATLAB code which approximates solutions to a system of ordinary differential equations (ODE) which model a bioconvection problem, and which are related to the Lorenz system.
  171. bioconvection_ode_test
  172. bird_egg, a MATLAB code which evaluates some formulas for the shapes of bird eggs.
  173. bird_egg_test
  174. bisection, a MATLAB code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
  175. bisection_test
  176. bisection_integer, a MATLAB code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [a,b].
  177. bisection_integer_test
  178. bisection_rc, a MATLAB code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [a,b]. The procedure is written using reverse communication (RC).
  179. bisection_rc_test
  180. black_scholes, a MATLAB code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
  181. black_scholes_test
  182. blend, a MATLAB code which carries out 1D/2D/3D blending interpolation;
  183. blend_test
  184. blood_pressure_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which models the variation in blood pressure in the human artery.
  185. blood_pressure_ode_test
  186. blowup_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) y'=y^2. whose solution "blows up" in finite time.
  187. blowup_ode_test
  188. boat, a MATLAB code which considers the boat tiling puzzle, a smaller version of the eternity puzzle. The boat puzzle specifies a region R composed of 756 30-60-90 triangles, and a set of 21 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  189. boat_test
  190. boat_cplex_test a BASH code which calls cplex(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
  191. boat_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
  192. boomerang, a MATLAB code which considers the boomerang tiling puzzle, a smaller version of the eternity puzzle. The puzzle specifies a region R composed of 2376 30-60-90 triangles, and a set of 66 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  193. boomerang_test
  194. boomerang_cplex_test a BASH code which calls cplex(), to read the LP file defining the boomerang tiling problem, solve the linear programming problem, and write the solution to a file.
  195. boundary_locus, a MATLAB code which uses the boundary locus method to display the region of absolute stability for a solver of ordinary differential equations (ODE).
  196. boundary_locus_test
  197. boundary_locus2, a MATLAB code which uses the boundary locus method to plot the boundary of the absolute stability region for a solver of ordinary differential equations (ODE), based on a procedure by Randall Leveque.
  198. boundary_locus2_test
  199. boundary_word_drafter, a MATLAB code which describes the outline of an object on a grid of drafters, or 30-60-90 triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
  200. boundary_word_drafter_test
  201. boundary_word_equilateral, a MATLAB code which describes the outline of an object on a grid of equilateral triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
  202. boundary_word_equilateral_test
  203. boundary_word_hexagon, a MATLAB code which describes the outline of an object on a grid of hexagons, using a string of symbols that represent the sequence of steps tracing out the boundary.
  204. boundary_word_hexagon_test
  205. boundary_word_right, a MATLAB code which describes the outline of an object on a grid of isoceles right triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
  206. boundary_word_right_test
  207. boundary_word_square, a MATLAB code which describes the outline of an object on a grid of squares, using a string of symbols that represent the sequence of steps tracing out the boundary.
  208. boundary_word_square_test
  209. box_behnken, a MATLAB code which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;
  210. box_behnken_test
  211. box_display, a MATLAB code which displays a box plot, over integer pairs of data, of a function defined by two formulas.
  212. box_display_test
  213. box_distance, a MATLAB code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a 3D box.
  214. box_distance_test
  215. box_games, a MATLAB code which assists in the display of game boards (checkers, cellular automatons, Conway's game of life);
  216. box_games_test
  217. box_plot, a MATLAB code which displays a box plot of data that consists of pairs of integers;
  218. box_plot_test
  219. brownian_motion_simulation, a MATLAB code which simulates Brownian motion in an M dimensional region.
  220. brownian_motion_simulation_test
  221. broyden, a MATLAB code which implements the Broyden iterative method for nonlinear equations, by Tim Kelley.
  222. broyden_test
  223. brusselator_ode, a MATLAB code which sets up and solves the Brusselator ordinary differential equation (ODE) system.
  224. brusselator_ode_test
  225. buckling_spring, a MATLAB code which plots solutions of the buckling spring equations.
  226. buckling_spring_test
  227. burgers_pde_etdrk4, a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Burgers PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
  228. burgers_pde_etdrk4_test
  229. burgers_solution, a MATLAB code which evaluates exact solutions of the time-dependent 1D viscous Burgers equation.
  230. burgers_solution_test
  231. burgers_steady_viscous, a MATLAB code which solves the steady (time-independent) viscous Burgers equation using the finite difference method (FDM) applied to the conservative form of the equation, using the Newton method to solve the resulting nonlinear system.
  232. burgers_steady_viscous_test
  233. burgers_time_inviscid, a MATLAB code which solves the time-dependent inviscid Burgers equation using the finite difference method (FDM), and one of six solution methods.
  234. burgers_time_inviscid_test
  235. burgers_time_viscous, a MATLAB code which solves the time-dependent viscous Burgers equation using the finite difference method (FDM) applied to the conservative form of the equation.
  236. burgers_time_viscous_test
  237. bvec, a MATLAB code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
  238. bvec_test
  239. bvp_fd, a MATLAB code which demonstrates the use of the finite difference method (FDM) to solve a boundary value problem (BVP).
  240. bvp_fd_test
  241. bvp_shooting_test, a MATLAB code which demonstrates the use of the shooting method to solve a boundary value problem (BVP).
  242. bvp4c_test, a MATLAB code which calls bvp4c(), which solves boundary value problems (BVP) in one spatial dimension.
  243. bwlabel_test, a MATLAB code which calls bwlabel(), which is a built-in MATLAB function, which is given a binary matrix, and organizes the 1 values into labeled clusters, using 4-way or 8-way connectivity.
  244. c8lib, a MATLAB code which implements certain elementary functions for complex 64 bit ("C8") variables;
  245. c8lib_test
  246. caesar, a MATLAB code which applies a Caesar Shift Cipher to a string of text.
  247. caesar_test
  248. calpak, a MATLAB code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
  249. calpak_test
  250. capacitor_2d_test, a MATLAB code which plots data from a model of a 2D capacitor, computed by FreeFem++() and transferred using the ffmatlib() library.
  251. capacitor_3d_test, a MATLAB code which plots data from a model of a 3D capacitor, computed by FreeFem++() and transferred using the ffmatlib() library.
  252. casino_simulation, a MATLAB code which simulates a casino game that gives you 20% of your bet for heads, and only takes 17% for tails. How much will you end up winning?
  253. casino_simulation_test
  254. cauchy_method, a MATLAB code which solves one or more ordinary differential equations (ODE) using the Cauchy method.
  255. cauchy_method_test
  256. cauchy_principal_value, a MATLAB code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
  257. cauchy_principal_value_test
  258. caustic, a MATLAB code which generates an image of a caustic, by drawing n equally spaced points in a circle, and then connecting specific pairs of points using a spacing parameter m.
  259. caustic_test
  260. cavity_flow_display, a MATLAB code which displays a single velocity field solution for the driven cavity;
  261. cavity_flow_display_test
  262. cavity_flow_movie, a MATLAB code which animates the velocity solutions for the driven cavity;
  263. cavity_flow_movie_test
  264. cc_display, a MATLAB code which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
  265. cc_display_test
  266. ccl_test, a MATLAB code which estimates the Lebesgue constants for sets of points in [-1,+1] computed in several ways. The program is probably of limited interest except as an example of an application of the lebesgue_constant() function.
  267. ccn_rule, a MATLAB code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
  268. ccn_rule_test
  269. ccs_io a MATLAB code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
  270. ccs_io_test
  271. ccs_to_st a MATLAB code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
  272. ccs_to_st_test
  273. ccvt_reflect, a MATLAB code which calculates a Constrained Centroidal Voronoi Tessellation (CCVT) for points constrained to lie in a box, with some points pushed towards the boundary;
  274. ccvt_reflect_test
  275. cellular_automaton, a MATLAB code which prints or plots the evolution of Cellular Automaton rule #30.
  276. cellular_automaton_test
  277. cg, a MATLAB code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is symmetric positive definite (SPD).
  278. cg_test
  279. cg_lab_triangles, a collection of programs associated with a computer lab assignment on computational geometry and triangles;
  280. cg_lab_triangles_test
  281. cg_ne, a MATLAB code which implements the conjugate gradient method (CG) for the normal equations, where the matrix A is not symmetric positive definite (SPD). In this case, it is attempted to set up and solve the normal equations A'*A*x=A'*b.
  282. cg_ne_test
  283. cg_rc, a MATLAB code which implements the conjugate gradient (CG) method for solving a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
  284. cg_rc_test
  285. cg_squared, a MATLAB code which implements the conjugate gradient squared (CGS) method for solving a nonsymmetric sparse linear system A*x=b.
  286. cg_squared_test
  287. chain_letter_tree, a MATLAB code which analyzes a similarity matrix for 11 versions of a single chain letter and produces a dendrogram or tree diagram that suggests the degrees of relatedness and the evolutionary history of the letters.
  288. change_diophantine, a MATLAB code which sets up a Diophantine equation to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
  289. change_diophantine_test
  290. change_dynamic, a MATLAB code which uses dynamic programming to solve the change making problem, in which a given sum is to be formed using coins of various denominations.
  291. change_dynamic_test
  292. change_greedy, a MATLAB code which uses the greedy method to seek a solution to the change making problem, which tries to match a given amount by selecting coins of various denominations.
  293. change_greedy_test
  294. change_polynomial, a MATLAB code which uses a polynomial multiplication algorithm to count the ways of making various sums using a given number of coins.
  295. change_polynomial_test
  296. chebyshev, a MATLAB code which computes the Chebyshev interpolant/approximant to a given function over an interval.
  297. chebyshev_test
  298. chebyshev_interp_1d, a MATLAB code which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).
  299. chebyshev_interp_1d_test
  300. chebyshev_matrix, a MATLAB code which defines the Chebyshev differentiation matrix, by Lloyd Trefethen.
  301. chebyshev_matrix_test
  302. chebyshev_polynomial, a MATLAB code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x).
  303. chebyshev_polynomial_test
  304. chebyshev_series, a MATLAB code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
  305. chebyshev_series_test
  306. chebyshev1_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Chebyshev type 1 quadrature rules.
  307. chebyshev1_exactness_test
  308. chebyshev1_rule, a MATLAB code which computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
  309. chebyshev1_rule_test
  310. chebyshev2_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Chebyshev type 2 quadrature rules.
  311. chebyshev2_exactness_test
  312. chebyshev2_rule, a MATLAB code which computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
  313. chebyshev2_rule_test
  314. chen_ode, a MATLAB code which sets up and solves the Chen system of ordinary differential equations (ODE).
  315. chen_ode_test
  316. cheney_kincaid, a MATLAB code which contains examples from the text 'Numerical Mathematics and Computing', by Cheney and Kincaid.
  317. cheney_kincaid_test
  318. chinese_remainder_theorem, a MATLAB code which demonstrates the Chinese remainder theorem, for reconstructing a number based on its remainders against a set of bases.
  319. chinese_remainder_theorem_test
  320. chirikov_iteration, a MATLAB code which applies the Chirikov map repeatedly to a given (x,y) initial condition.
  321. chirikov_iteration_test
  322. chladni_figures, a MATLAB code which creates Chladni figures of the eigenmodes of a thin vibrating plate, by Martin Gander and Felix Kwok.
  323. chladni_figures_test
  324. chrominoes, a MATLAB code which searches for tilings of a polygonal region using polyominoes, in which a coloring scheme is used to reduce the problem size and quickly eliminate certain arrangements.
  325. chrominoes_test
  326. chrpak, a MATLAB code which manipulates characters and strings;
  327. chrpak_test
  328. chuckaluck_simulation, a MATLAB code which simulates the Chuck-a-Luck gambling game.
  329. chuckaluck_simulation_test
  330. circle_arc_grid, a MATLAB code which computes grid points along a circular arc.
  331. circle_arc_grid_test
  332. circle_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the unit circle in 2D.
  333. circle_distance_test
  334. circle_grid_display a MATLAB code which reads a matrix of integers, and draws a corresponding grid of circles filled with color.
  335. circle_grid_display_test
  336. circle_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
  337. circle_integrals_test
  338. circle_map, a MATLAB code which illustrates how a matrix maps points on the unit circle to an ellipse.
  339. circle_map_test
  340. circle_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
  341. circle_monte_carlo_test
  342. circle_positive_distance, a MATLAB code which estimates the mean and variance of the distance between a random pair of points on the circumference of the unit positive circle in 2D.
  343. circle_positive_distance_test
  344. circle_rule, a MATLAB code which computes quadrature rules for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
  345. circle_rule_test
  346. circle_segment, a MATLAB code which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.
  347. circle_segment_test
  348. circles, a MATLAB code which draws one or more circles, while controlling the center locations, radii, colors, edge colors, and transparency, by Chad Greene.
  349. circles_test
  350. cities, a MATLAB code which works with city-to-city distance matrices;
  351. cities_test
  352. clausen, a MATLAB code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
  353. clausen_test
  354. clenshaw_curtis_rule, a MATLAB code which implements a Clenshaw Curtis quadrature rule;
  355. clenshaw_curtis_rule_test
  356. clock_solitaire_simulation, a MATLAB code which simulates the game of clock solitaire. The deck is dealt into 13 piles of 4 cards each. Repeatedly, the top card a pile is removed, and its rank indicates the next pile to consider. Game continues until an empty pile is reached. The game is won if all piles are empty. The quantity of interest is the probability of winning.
  357. clock_solitaire_simulation_test
  358. cnoise, a MATLAB code which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
  359. cnoise_test
  360. cobweb_plot, a MATLAB code which displays a cobweb plot illustrating the process of function iteration.
  361. cobweb_plot_test
  362. coin_simulation, a MATLAB code which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.
  363. coin_simulation_test
  364. collatz, a MATLAB code which computes and analyzes the Collatz sequence, also known as the hailstone sequence or 3n+1 sequence;
  365. collatz_test
  366. collatz_parfor, a MATLAB code using the parfor() statement for parallel execution, to find the longest Collatz sequence in the range 1 through N.
  367. collatz_parfor_test
  368. collatz_polynomial, a MATLAB code which implements the Collatz polynomial iteration, a polynomial analog of the numerical iteration that is also known as the 3n+1 conjecture or the hailstone sequence.
  369. collatz_polynomial_test
  370. collatz_recursive, a MATLAB code which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
  371. collatz_recursive_test
  372. collocation, a MATLAB code which demonstrates the use of collocation to produce a function g(x) that satisfies the same constraints as a function f(x), but only at a discrete set of points.
  373. collocation_test
  374. colored_noise, a MATLAB code which generates samples of noise obeying a 1/f^alpha power law.
  375. colored_noise_test
  376. combo, a MATLAB code which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
  377. combo_test
  378. compass_search, a MATLAB code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
  379. compass_search_test
  380. complex_numbers_test, a MATLAB code which demonstrates some of the features of using complex numbers.
  381. components, a MATLAB code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
  382. components_test
  383. condition, a MATLAB code which implements methods of computing or estimating the condition number of a matrix.
  384. condition_test
  385. conservation_ode, a MATLAB code which monitors the conservation of a quantity that should be constant, during the solution of an ordinary differential equation (ODE).
  386. conservation_ode_test
  387. conte_deboor, a MATLAB code which contains examples from the text 'Elementary Numerical Analysis' by Conte and deBoor.
  388. conte_deboor_test
  389. continuation, a MATLAB code which implements the continuation method for a simple 2D problem, involving finding a point on the unit circle, and then finding a sequence of nearby points that trace out the full curve, using only the information available in the implicit definition of the curve from the function f(x,y)=x^2+y^2-1.
  390. continuation_test
  391. continued_fraction a MATLAB code which implements some simple algorithms for dealing with simple and generalized continued fractions.
  392. continued_fraction_test
  393. contour_gradient, a MATLAB code which displays contours and gradient vectors for a function f(x,y).
  394. contour_gradient_test
  395. contour_gradient_3d, a MATLAB code which displays contours and gradient vectors for a function f(x,y) in a 3D display.
  396. contour_gradient_3d_test
  397. contour_sequence4, a MATLAB code which creates images suitable for animation from one XY file and a sequence of u(x,y) data files;
  398. contour_sequence4_test
  399. control_bio, a MATLAB code which optimizes a given cost functional of a biological model using optimal control, based on work by Suzanne Lenhart and John Workman.
  400. control_bio_test
  401. convective_rolls_test, a MATLAB code which plots data describing the convective rolling behavior of a fluid being heated from below, as computed by FreeFem++() and transferred using the ffmatlib() library.
  402. convective_rolls_movie_test, a MATLAB code which animates data describing the convective rolling behavior of a fluid being heated from below, as computed by FreeFem++() and transferred using the ffmatlib() library.
  403. convhull_test, a MATLAB code which demonstrates the use of the built-in function convhull() for the computation of the convex hull of a set of 2D points.
  404. coordinate_search, a MATLAB code which seeks the minimizer of a scalar function of several variables, by Jeff Borggaard.
  405. coordinate_search_test
  406. cordic, a MATLAB code which computes a few special functions using the CORDIC algorithm.
  407. cordic_test
  408. correlation, a MATLAB code which contains statistical correlation functions.
  409. correlation_test
  410. cosine_transform, a MATLAB code which demonstrates some simple properties of the discrete cosine transform (DCT).
  411. cosine_transform_test
  412. counterfeit_detection, a MATLAB code which considers problems in which one or more counterfeit coins are to be identified by the fact that they do not have the standard weight.
  413. counterfeit_detection_test
  414. cplex_solution_read, a MATLAB code which extracts solution data from a cplex() result file.
  415. cplex_solution_read_test
  416. craps_simulation, a MATLAB code which simulates the gambling game of craps, in which a player rolls two dice. On the first roll, the player wins immediately if a 7 or 11 is rolled, and loses immediately if a 2, 3 or 12 is rolled. Otherwise, the sum of the dice on this first roll is called the point. The player now continues to roll the dice, winning if the point is rolled again, and losing if a 7 is rolled.
  417. craps_simulation_test
  418. crs_io, a MATLAB code which reads and writes sparse linear systems stored in the Compressed Row Storage (CRS) format.
  419. crs_io_test
  420. cube_arbq_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
  421. cube_arbq_rule_test
  422. cube_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the interior of the unit cube in 3D.
  423. cube_distance_test
  424. cube_exactness, a MATLAB code which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.
  425. cube_exactness_test
  426. cube_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a cube in 3D.
  427. cube_felippa_rule_test
  428. cube_grid, a MATLAB code which computes a grid of points over the interior of a cube in 3D.
  429. cube_grid_test
  430. cube_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
  431. cube_integrals_test
  432. cube_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
  433. cube_monte_carlo_test
  434. cube_surface_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit cube.
  435. cube_surface_distance_test
  436. cuda_loop, a MATLAB code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
  437. cuda_loop_test
  438. cvt, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) in M dimensions;
  439. cvt_test
  440. cvt_1_movie, a MATLAB code which creates a movie of the evolution of a Centroidal Voronoi Tessellation (CVT) in the unit square;
  441. cvt_1_movie_test
  442. cvt_2_movie, a MATLAB code which animates the generation of a Centroidal Voronoi Tessellation (CVT) in the unit square, which includes a random "rebirth" at every iteration.
  443. cvt_2_movie_test
  444. cvt_3_movie, a MATLAB code which animates the generation of a Centroidal Voronoi Tessellation (CVT) for the "holey pie" region.
  445. cvt_3_movie_test
  446. cvt_4_movie, a MATLAB code which creates a Centroidal Voronoi Tessellation (CVT) movie in the unit square, with a density function that drives points to the corners;
  447. cvt_4_movie_test
  448. cvt_1d_lloyd, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using the Lloyd method to compute the Voronoi regions exactly.
  449. cvt_1d_lloyd_test
  450. cvt_1d_lumping, a MATLAB code which allows the user to carry out a lumped version of the Lloyd iterative algorithm for a centroidal Voronoi Tessellation (CVT() in the interval [-1,+1], and is applied to investigate a relationship between a CVT and the Chebyshev Zero nodes.
  451. cvt_1d_lumping_test
  452. cvt_1d_nonuniform, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) in 1 dimension, under a nonuniform density, and plots the evolution of the locations of the generators during the iteration;
  453. cvt_1d_nonuniform_test
  454. cvt_1d_sampling, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using sampling to estimate the Voronoi regions.
  455. cvt_1d_sampling_test
  456. cvt_2d_lumping, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [-1,1]^2, under a Chebyshev density, using weighted sampling (lumping) to estimate the Voronoi regions.
  457. cvt_2d_lumping_test
  458. cvt_2d_sampling, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [0,1]x[0,1], under a uniform density, using sampling to estimate the Voronoi regions.
  459. cvt_2d_sampling_test
  460. cvt_3d_lumping, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [-1,1]^3, under a Chebyshev density, using weighted sampling (lumping) to estimate the Voronoi regions.
  461. cvt_3d_lumping_test
  462. cvt_3d_sampling, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [0,1]^3, under a uniform density, using sampling to estimate the Voronoi regions.
  463. cvt_3d_sampling_test
  464. cvt_basic, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) in a square with uniform density. It is intended as an introduction to the cvt_square_uniform() code.
  465. cvt_basic_test
  466. cvt_circle_nonuniform, a MATLAB code which demonstrates the computation of a centroidal Voronoi Tessellation (CVT) over a circular region, using a nonuniform density.
  467. cvt_circle_nonuniform_test
  468. cvt_circle_uniform, a MATLAB code which computes a centroidal Voronoi Tessellation (CVT) over a circular region, using a uniform density.
  469. cvt_circle_uniform_test
  470. cvt_corn, a MATLAB code which studies a 2D model of the growth of a corn kernel, by treating the surface and interior biological cells as points to be organized by a Centroidal Voronoi Tessellation (CVT) with a nonuniform density; during a sequence of growth steps, new biological cells are randomly added to the surface and interior.
  471. cvt_corn_test
  472. cvt_corn_movie, a MATLAB code which makes a movie in which the growth of a corn kernel is simulated using a Centroidal Voronoi Tessellation (CVT).
  473. cvt_corn_movie_test
  474. cvt_ellipse_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over an ellipse, with a uniform density.
  475. cvt_ellipse_uniform_test
  476. cvt_square_nonuniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a nonuniform density.
  477. cvt_square_nonuniform_test
  478. cvt_square_pdf_discrete, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a density determined from a discrete PDF.
  479. cvt_square_pdf_discrete_test
  480. cvt_square_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a uniform density.
  481. cvt_square_uniform_test
  482. cvt_triangle_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a triangle, with a uniform density.
  483. cvt_triangle_uniform_test
  484. cvtm_1d, a MATLAB code which estimates a mirror-periodic centroidal Voronoi Tessellation (CVTM) in the periodic interval [0,1], using a version of the Lloyd iteration.
  485. cvtm_1d_test
  486. cvtp, a MATLAB code which creates a periodic Centroidal Voronoi Tessellation (CVTP).
  487. cvtp_test
  488. cvtp_1d, a MATLAB code which estimates a periodic centroidal Voronoi Tessellation (CVTP) in the periodic interval [0,1], using a version of the Lloyd iteration.
  489. cvtp_1d_test
  490. cycle_brent, a MATLAB code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
  491. cycle_brent_test
  492. cycle_floyd, a MATLAB code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
  493. cycle_floyd_test
  494. cyclic_reduction, a MATLAB code which solves a tridiagonal linear system using cyclic reduction;
  495. cyclic_reduction_test
  496. delaunay_test, a MATLAB code which calls the built-in delaunay() function, which computes the Delaunay triangulation of a set of points.
  497. delsq, a MATLAB code which is given a grid G, and returns a corresponding sparse matrix D that defines the Laplacian operator on G. MATLAB includes a built-in version of this function.
  498. delsq_test
  499. dfield9, a MATLAB code which allows a user to interactively specify the right hand side of an ordinary differential equation (ODE). The program then displays the corresponding direction field. If the user clicks on any point in the image as an initial condition, the program displays the corresponding solution curve. The original version of this code was by John Polking.
  500. dg1d_advection, a MATLAB code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the advection equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  501. dg1d_advection_test
  502. dg1d_burgers, a MATLAB code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D Burgers equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  503. dg1d_burgers_test
  504. dg1d_heat, a MATLAB code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D heat equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  505. dg1d_heat_test
  506. dg1d_maxwell, a MATLAB code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the Maxwell equations. The original version of the code was written by Jan Hesthaven and Tim Warburton.
  507. dg1d_maxwell_test
  508. dg1d_poisson, a MATLAB code which applies the discontinuous Galerkin method (DG) to a 1D version of the Poisson equation; the original version of the code was written by Beatrice Riviere.
  509. dg1d_poisson_test
  510. diaphony, a MATLAB code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
  511. diaphony_test
  512. dice_simulation, a MATLAB code which simulates N tosses of M dice, making a histogram of the resulting sums.
  513. dice_simulation_test
  514. dictionary_code, a MATLAB code which demonstates how a text file can be compressed and decompressed using a dictionary code.
  515. dictionary_code_test
  516. diff_test, a MATLAB code which calls diff(), which computes differences in a vector of data, which can be scaled to estimate derivatives of equally spaced data.
  517. diff_center, a MATLAB code which interactively uses centered differences to estimate the derivative of a function f(x), using a stepsize h.
  518. diff_center_test
  519. diff_forward, a MATLAB code which interactively uses forward differences to estimate the derivative of a function f(x), using a stepsize h.
  520. diff_forward_test
  521. diff2_center, a MATLAB code which interactively uses centered differences to estimate the second derivative of a function f(x), using a stepsize h.
  522. diff2_center_test
  523. differ, a MATLAB code which determines the finite difference method (FDM) coefficients to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.
  524. differ_test
  525. diffusion_pde, a MATLAB code which solves the diffusion partial differential equation (PDE) dudt - mu * d2udx2 = 0 in one spatial dimension, with a constant diffusion coefficient mu, and periodic boundary conditions, using the forward time, centered space (FTCS) difference method.
  526. diffusion_pde_test
  527. digital_dice, a MATLAB code which carries out the probability simulations described in "Digital Dice", by Paul Nahin;
  528. digital_dice_test
  529. dijkstra, a MATLAB code which implements a simple version of the Dijkstra minimum distance algorithm for graphs.
  530. dijkstra_test
  531. diophantine, a MATLAB code which finds one solution of a Diophantine equation in any number of variables.
  532. diophantine_test
  533. diophantine_nd, a MATLAB code which is given a Diophantine equation in N variables, and returns all nonnegative solutions, or all strictly positive solutions.
  534. diophantine_nd_doc
  535. diophantine_nd_test
  536. discrete_pdf_sample_2d, a MATLAB code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
  537. discrete_pdf_sample_2d_test
  538. disk_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit disk in 2D.
  539. disk_distance_test
  540. disk_grid, a MATLAB code which computes grid points within the interior of a disk of user specified radius and center in 2D, using gnuplot() to create an image of the grid.
  541. disk_grid_test
  542. disk_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of a disk of radius R centered at the origin.
  543. disk_integrals_test
  544. disk_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate integrals of a function over the interior of a disk of radius R centered at the origin.
  545. disk_monte_carlo_test
  546. disk_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit positive disk in 2D.
  547. disk_positive_distance_test
  548. disk_rule, a MATLAB code which computes quadrature rules for the general disk in 2D.
  549. disk_rule_test
  550. disk01_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
  551. disk01_integrals_test
  552. disk01_integrands, a MATLAB code which defines several test integrals over the unit disk, making it possible to check the accuracy of quadrature rules.
  553. disk01_integrands_test
  554. disk01_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
  555. disk01_monte_carlo_test
  556. disk01_rule, a MATLAB code which computes quadrature rules for the unit disk in 2D.
  557. disk01_rule_test
  558. disk01_positive_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
  559. disk01_positive_monte_carlo_test
  560. disk01_positive_rule, a MATLAB code which computes quadrature rules for the unit positive disk in 2D.
  561. disk01_positive_rule_test
  562. dist_plot, a MATLAB code which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh() code;
  563. dist_plot_test
  564. distance_to_position, a MATLAB code which estimates the positions of cities which minimizes the discrepancy with a city-to-city distance table.
  565. distance_to_position_test
  566. distance_to_position_sphere, a MATLAB code which estimates the positions of cities on a sphere (such as the earth) based on a city-to-city distance table.
  567. distance_to_position_sphere_test
  568. distmesh, a MATLAB code which carries out a method of mesh generation; by Per-Olof Persson and Gilbert Strang.
  569. distmesh_test
  570. distmesh_3d, a MATLAB code which carries out a method of mesh generation in 3D, by Per-Olof Persson and Gilbert Strang.
  571. distmesh_3d_test
  572. divdif, a MATLAB code which uses divided differences to compute the polynomial interpolant to a given set of data.
  573. divdif_test
  574. doomsday, a MATLAB code which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.
  575. doomsday_test
  576. dosage_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) to simulate the blood levels of a medicinal drug that should stay between medicinal and toxic limits.
  577. dosage_ode_test
  578. double_c_data, a MATLAB code which generates, plots and writes out 2D data that forms two interlocking "C" shapes.
  579. double_c_data_test
  580. double_well_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which models the motion of a particle in a double well potential.
  581. double_well_ode_test
  582. dream, a MATLAB code which implements the DREAM algorithm for accelerating Markov Chain Monte Carlo (MCMC) convergence using differential evolution, using five user functions to define the problem, by Guannan Zhang.
  583. dream_test
  584. duel_simulation, a MATLAB code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  585. duel_simulation_test
  586. dueling_idiots, a MATLAB code which carries out the probability simulations described in "Dueling Idiots", by Paul Nahin;
  587. dueling_idiots_test
  588. duffing_ode, a MATLAB code which sets up and solves a second-order ordinary differential equation (ODE) whose solution can exhibit chaotic behavior.
  589. duffing_ode_test
  590. e_spigot, a MATLAB code which produces any number of digits of the decimal expansion of e.
  591. e_spigot_test
  592. earth_sphere, a MATLAB code which displays a 3D image of the earth, including oceans, continents, and topography, by Clay Thompson and Will Campbell.
  593. earth_sphere_test
  594. edge, a MATLAB code which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities.
  595. edge_test
  596. eigenfaces, a MATLAB code which applies principal component analysis (PCA) to a set of images.
  597. eigenfaces_test
  598. elfun, a MATLAB code which evaluates elliptic integrals, include Bulirsch's integrals cel(), cel1(), cel2(), cel3(), Carlson integrals rc(), rd(), rf(), rg(), rj(), and Jacobi functions cn(), dn(), sn(), by Milan Batista.
  599. elfun_test
  600. ellipse, a MATLAB code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
  601. ellipse_test
  602. ellipse_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the ellipse (x/a)^2+(y/b)^2=1 in 2D.
  603. ellipse_distance_test
  604. ellipse_grid, a MATLAB code which computes a grid of points over the interior of an ellipse in 2D.
  605. ellipse_grid_test
  606. ellipse_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.
  607. ellipse_monte_carlo_test
  608. ellipsoid, a MATLAB code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
  609. ellipsoid_test
  610. ellipsoid_grid, a MATLAB code which computes a grid of points over the interior of an ellipsoid in 3D.
  611. ellipsoid_grid_test
  612. ellipsoid_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
  613. ellipsoid_monte_carlo_test
  614. elliptic_integral, a MATLAB code which evaluates complete elliptic integrals of first, second and third kind, using the Carlson elliptic integral functions.
  615. elliptic_integral_test
  616. epicycloid, a MATLAB code which computes, plots and tabulates an epicycloid curve.
  617. epicycloid_test
  618. equidistribution, investigates equidistribution properties relating to density functions and point sets.
  619. equidistribution_test
  620. eros, a MATLAB code which implements elementary row operations (EROs) for the interactive solution of a system of linear equations.
  621. eros_test
  622. errors, a MATLAB code which illustrates the failure of numerical algorithms;
  623. errors_test
  624. eternity, a MATLAB code which considers the eternity puzzle, an irregular dodecagon that is to be tiled by 209 pieces, each formed by 12 contiguous 30-60-90 triangles, known as polydrafters.
  625. eternity_test
  626. eternity_hexity, a MATLAB code which evaluates and manipulates a six-fold parity quantity associated with grids and tiles used in the Eternity puzzle.
  627. eternity_hexity_test
  628. eternity_tile, a MATLAB code which considers the individual tiles of the eternity puzzle, 209 distinct pieces, each formed by 36 contiguous 30-60-90 triangles, known as polydrafters.
  629. eternity_tile_test
  630. euclid, a MATLAB code which investigates various versions of Euclid's algorithm for computing the greatest common divisor (GCD) of two integers.
  631. euclid_test
  632. euler, a MATLAB code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
  633. euler_test
  634. exactness, a MATLAB code which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).
  635. exactness_test
  636. exm, a MATLAB code which contains scripts and data discussed in the electronic textbook "Experiments with Matlab", by Cleve Moler, including easter, Fast Fourier Transforms, Fibonacci numbers, the fractal fern, the game of Life, magic matrices, the Mandelbrot set, Morse code, Music, Ordinary Differential Equations, the page rank algorithm, planetary orbits, predator prey equations, the shallow water equations, Sudoku puzzles.
  637. exm_test
  638. exp_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) whose solution is an exponential function.
  639. exp_ode_test
  640. faces_average, a MATLAB code which averages several images of the same face;
  641. faces_average_test
  642. fair_dice_simulation, a MATLAB code which simulates N tosses of 2 dice, making a histogram of the resulting sums.
  643. fair_dice_simulation_test
  644. faure, a MATLAB code which computes the Faure M dimensional Quasi Mont Carlo (QMC) sequence;
  645. faure_test
  646. fd_predator_prey, a MATLAB code which solves a time-dependent predator prey system using the finite difference method (FDM).
  647. fd_predator_prey_test
  648. fd1d_advection_diffusion_steady, a MATLAB code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k.
  649. fd1d_advection_diffusion_steady_test
  650. fd1d_advection_ftcs, a MATLAB code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time centered space (FTCS) difference scheme.
  651. fd1d_advection_ftcs_test
  652. fd1d_advection_lax, a MATLAB code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to approximate the time derivative.
  653. fd1d_advection_lax_test
  654. fd1d_advection_lax_wendroff, a MATLAB code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to approximate the time derivative.
  655. fd1d_advection_lax_wendroff_test
  656. fd1d_burgers_lax, a MATLAB code which applies the finite difference method (FDM) and the Lax Wendroff method to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  657. fd1d_burgers_lax_test
  658. fd1d_burgers_leap, a MATLAB code which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  659. fd1d_burgers_leap_test
  660. fd1d_bvp, a MATLAB code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
  661. fd1d_bvp_test
  662. fd1d_display, a MATLAB code which reads a pair of files defining a 1D finite difference method (FDM) of a function, and plots the data.
  663. fd1d_display_test
  664. fd1d_heat_explicit, a MATLAB code which implements a finite difference method (FDM), explicit in time, to solve the time dependent 1D heat equation;
  665. fd1d_heat_explicit_test
  666. fd1d_heat_implicit, a MATLAB code which implements a finite difference method (FDM), implicit in time, to solve the time dependent 1D heat equation;
  667. fd1d_heat_implicit_test
  668. fd1d_heat_steady, a MATLAB code which implements a finite difference method (FDM) for the steady (time independent) 1D heat equation;
  669. fd1d_heat_steady_test
  670. fd1d_poisson, a MATLAB code which solves a Poisson equation over a user-specified discretized interval, with given functions f(x) (right hand side) and g(x) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
  671. fd1d_poisson_test
  672. fd1d_predator_prey, a MATLAB code which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence, by Marcus Garvie.
  673. fd1d_predator_prey_test
  674. fd1d_predator_prey_plot, a MATLAB code which plots solutions of the predator prey differential equations, by Marcus Garvie.
  675. fd1d_predator_prey_plot_test
  676. fd1d_wave, a MATLAB code which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.
  677. fd1d_wave_test
  678. fd2d_convergence_test, a MATLAB code which calls fd2d_poisson(), which repeatedly solves a Poisson equation on a sequence of finer meshes, so that the relationship between mesh size H and error norm E can be explored.
  679. fd2d_heat_steady, a MATLAB code which implements a finite difference method (FDM) for the steady (time independent) 2D heat equation;
  680. fd2d_heat_steady_test
  681. fd2d_poisson, a MATLAB code which solves a Poisson equation over a user-specified discretized rectangle, with given functions f(x,y) (right hand side) and g(x,y) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
  682. fd2d_poisson_test
  683. fd2d_predator_prey, a MATLAB code which implements a finite difference method (FDM) for a time and 2D space dependent predator-prey system, by Marcus Garvie.
  684. fd2d_predator_prey_test
  685. fd3d_poisson, a MATLAB code which solves a Poisson equation over a user-specified discretized 3d block, with given functions f(x,y,z) (right hand side) and g(x,y,z) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
  686. fd3d_poisson_test
  687. fem_basis, a MATLAB code which defines and evaluates finite element method (FEM) basis functions for any degree in an M dimensional simplex (1D interval, 2D triangle, 3D tetrahedron, and higher dimensional generalizations.)
  688. fem_basis_test
  689. fem_basis_q4_display, a MATLAB code which displays any single finite element method (FEM) basis function associated with an arbitrary linear quadrilateral Q4 mesh;
  690. fem_basis_q4_display_test
  691. fem_basis_t3_display, a MATLAB code which displays a basis function for the finite element method (FEM) associated with an arbitrary 3-node triangle T3 mesh;
  692. fem_basis_t3_display_test
  693. fem_basis_t4_display, a MATLAB code which displays a basis function for the finite element method (FEM) associated with an arbitrary 4-node triangle T4 mesh;
  694. fem_basis_t4_display_test
  695. fem_basis_t6_display, a MATLAB code which displays a basis function for the finite element method (FEM) associated with an arbitrary 6-node triangle T6 mesh;
  696. fem_basis_t6_display_test
  697. fem_io, a MATLAB code which reads or writes FEM files, which describe the nodes, elements, and function values associated with a finite element method (FEM) model;
  698. fem_io_test
  699. fem_neumann, a MATLAB code which sets up a time-dependent reaction-diffusion equation in 1D, with Neumann boundary conditions, discretized using the finite element method (FEM).
  700. fem_neumann_test
  701. fem_to_gmsh, a MATLAB code which reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a gmsh() MESH file.
  702. fem_to_gmsh_test
  703. fem_to_medit, a MATLAB code which reads a set of FEM files defining the node coordinates, boundary nodes, and elements of a finite element mesh, and rewrites the data as a medit() MESH file.
  704. fem_to_medit_test
  705. fem_to_tec, a MATLAB code which converts FEM models into tecplot() ASCII files.
  706. fem_to_tec_test
  707. fem_to_triangle, a MATLAB code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
  708. fem_to_triangle_test
  709. fem_to_xml, a MATLAB code which reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding XML file for input to dolfin() or fenics().
  710. fem_to_xml_test
  711. fem1d, a MATLAB code which applies the finite element method (FEM), using piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  712. fem1d_test
  713. fem1d_adaptive, a MATLAB code which uses an adaptive mesh when applying the finite element method (FEM), with piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  714. fem1d_adaptive_test
  715. fem1d_approximate, a MATLAB code which uses a given finite element method (FEM) mesh and piecewise linear (PWL) basis functions to approximate a set of data points, while controlling the variation in the derivative.
  716. fem1d_approximate_test
  717. fem1d_bvp_linear, a MATLAB code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  718. fem1d_bvp_linear_test
  719. fem1d_bvp_quadratic, a MATLAB code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  720. fem1d_bvp_quadratic_test
  721. fem1d_display, a MATLAB code which reads three files defining a 1D arbitrary degree basis function associated with the finite element method (FEM), and displays a plot.
  722. fem1d_display_test
  723. fem1d_function_10_display, a MATLAB code which reads three files defining a 1D piecewise linear finite element method (FEM) function and displays a plot.
  724. fem1d_display_function_10_test
  725. fem1d_heat_explicit, a MATLAB code which uses the finite element method (FEM) and explicit time stepping to solve the time dependent heat equation in 1D.
  726. fem1d_heat_explicit_test
  727. fem1d_heat_implicit, a MATLAB code which uses the finite element method (FEM) and implicit time stepping to solve the time dependent heat equation in 1D.
  728. fem1d_heat_implicit_test
  729. fem1d_heat_steady, a MATLAB code which uses the finite element method (FEM) to solve the steady (time independent) 1D heat equation;
  730. fem1d_heat_steady_test
  731. fem1d_lagrange, a MATLAB code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
  732. fem1d_lagrange_test
  733. fem1d_nonlinear, a MATLAB code which applies the finite element method (FEM), with piecewise linear (PWL) basis functions, to a nonlinear two point boundary value problem (BVP) in 1D;
  734. fem1d_nonlinear_test
  735. fem1d_pack, a MATLAB code which contains utilities for 1D finite element method (FEM) calculations.
  736. fem1d_pack_test
  737. fem1d_pmethod, a MATLAB code which applies the p-method version of the finite element method (FEM) to a linear two point boundary value problem (BVP) in 1D;
  738. fem1d_pmethod_test
  739. fem1d_project, a MATLAB code which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.
  740. fem1d_project_test
  741. fem1d_sample, a MATLAB code which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.
  742. fem1d_sample_test
  743. fem1d_spectral_numeric, a MATLAB code which applies the spectral finite element method (FEM) to solve the problem u'' = - pi^2 sin(x) over [-1,+1] with zero boundary conditions, using as basis elements the functions x^n*(x-1)*(x+1), and carrying out the integration numerically, using the quad() function, by Miro Stoyanov.
  744. fem1d_spectral_numeric_test
  745. fem2d_bvp_linear, a MATLAB code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  746. fem2d_bvp_linear_test
  747. fem2d_bvp_quadratic, a MATLAB code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  748. fem2d_bvp_quadratic_test
  749. fem2d_bvp_serene, a MATLAB code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  750. fem2d_bvp_serene_test
  751. fem2d_heat, a MATLAB code which applies the finite element method (FEM) to the time dependent heat equation on an arbitrary triangulated region in 2D;
  752. fem2d_heat_test
  753. fem2d_heat_rectangle, a MATLAB code which applies the finite element method (FEM) for the time-dependent heat equation on a triangulated rectangle in 2D;
  754. fem2d_heat_rectangle_test
  755. fem2d_heat_sparse, a MATLAB code which applies the finite element method (FEM) to the heat equation on an arbitrary triangulated region in 2D, using a sparse storage matrix format;
  756. fem2d_heat_sparse_test
  757. fem2d_mesh_display, a MATLAB code which reads a FEM model of a 2D mesh of elements of any uniform order and displays a plot of the elements and nodes, with optional numbering.
  758. fem2d_mesh_display_test
  759. fem2d_pack, a MATLAB code which performs simple 2D finite element method (FEM) computations;
  760. fem2d_pack_test
  761. fem2d_poisson_rectangle, a MATLAB code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.
  762. fem2d_poisson_rectangle_test
  763. fem2d_poisson_rectangle_linear, a MATLAB code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.
  764. fem2d_poisson_rectangle_linear_test
  765. fem2d_predator_prey_fast, a MATLAB code which implements a finite element method (FEM) for a time and 2D space dependent predator-prey system, on an arbitrary triangulated region, with a variety of possible boundary conditions, incorporating some optimizations, by Marcus Garvie.
  766. fem2d_predator_prey_fast_test
  767. fem2d_project, a MATLAB code which projects a function f(x,y), given as data, into a given finite element method (FEM) space of piecewise linear triangular elements.
  768. fem2d_project_test
  769. fem2d_project_function, a MATLAB code which projects a function f(x,y), given as a formula, into a given finite element method (FEM) space of piecewise linear triangular elements.
  770. fem2d_project_function_test
  771. fem2d_sample, a MATLAB code which samples a finite element method (FEM) function, defined by three text files describing the nodes, triangles, and coefficients, at arbitrary points.
  772. fem2d_sample_test
  773. fem2d_scalar_display, a MATLAB code which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a surface plot of U(X,Y).
  774. fem2d_scalar_display_test
  775. fem2d_scalar_display_brief, a MATLAB code which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a surface plot of U(X,Y), in 5 lines of code.
  776. fem2d_scalar_display_brief_test
  777. fem2d_scalar_display_gpl, a MATLAB code which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a GPL file describing a surface plot of U(X,Y), which can be displayed by gnuplot().
  778. fem2d_scalar_display_gpl_test,
  779. fem3d_pack, a MATLAB code which contains utilities for 3D finite element method (FEM) calculations.
  780. fem3d_pack_test
  781. fem3d_project, a MATLAB code which projects a function f(x,y,z), given as a data, into a given space of piecewise linear tetrahedral elements for use in the finite element method (FEM).
  782. fem3d_project_test
  783. fem3d_sample, a MATLAB code library which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
  784. fem3d_sample_test
  785. fern, a MATLAB code which computes and displays the Barnsley fractal fern.
  786. fern_test
  787. feynman_kac_1d, a MATLAB code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 1D interval by averaging stochastic paths to the boundary.
  788. feynman_kac_1d_test
  789. feynman_kac_2d, a MATLAB code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 2D ellipse by averaging stochastic paths to the boundary.
  790. feynman_kac_2d_test
  791. feynman_kac_3d, a MATLAB code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
  792. feynman_kac_3d_test
  793. ffmatlib, a MATLAB code which allows the user to plot finite element method (FEM) results that have been computed by FreeFem++().
  794. fft_serial, a MATLAB code which computes a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.
  795. fft_serial_test
  796. fibonacci_spiral, a MATLAB code which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.
  797. fibonacci_spiral_test
  798. file_name_sequence, a MATLAB code which demonstrates ways to generate a sequence of filenames, which can be useful when generating a sequence of still snapshots to be animated later.
  799. file_name_sequence_test
  800. files_multiple_test
  801. filon_rule, a MATLAB code which approximates integrals which include an oscillatory factor of sin(k*x) or cos(k*x).
  802. filon_rule_test
  803. filum, a MATLAB code which handles files and filenames;
  804. filum_test
  805. fire_simulation, a MATLAB code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
  806. fire_simulation_test
  807. fitzhugh_nagumo_ode, a MATLAB code which sets up and solves the Fitzhugh-Nagumo system of ordinary differential equations (ODE).
  808. fitzhugh_nagumo_ode_test
  809. flame_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
  810. flame_ode_test
  811. flies_simulation, a MATLAB code which simulates an experiment in which two flies land on a plate of radius 1. By repeating the experiment many times, the average distance between the flies is to be estimated.
  812. flies_simulation_test
  813. florida_cvt_geo, a MATLAB code which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based solely on geometric considerations.
  814. florida_cvt_geo_test
  815. florida_cvt_pop, a MATLAB code which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based on population considerations.
  816. florida_cvt_pop_test
  817. floyd, a MATLAB code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  818. floyd_test
  819. fly_simulation, a MATLAB code which simulates an experiment in which a fly lands on a plate of radius 1. By repeating the experiment many times, the average distance of the fly from the center is to be estimated.
  820. fly_simulation_test
  821. fmincon_test, a MATLAB code which calls fmincon(), which seeks the minimizer of a scalar function of multiple variables, within a region specified by linear constraints and bounds. fmincon() is part of the MATLAB Optimization Toolbox.
  822. fn, a MATLAB code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.
  823. fn_test
  824. football_dynamic, a MATLAB code which uses dynamic programming to count the ways of achieving a given score in football.
  825. football_dynamic_test
  826. four_fifths, a MATLAB code which searches for a solution to the problem of finding four fifth powers that sum to a fifth power, that is, integers a, b, c, d and e such that a^5+b^5+c^5+d^5=e^5. Euler conjectured that no solution was possible.
  827. four_fifths_test
  828. fractal_coastline, a MATLAB code which uses perturbed Bezier interpolation to create a fractal coastline from a crude outline of a state, country, island, or even any general closed polygonal curve.
  829. fractal_coastline_test
  830. freefem_msh_io, a MATLAB code which reads and writes files used by the FreeFem finite element program to store mesh information.
  831. freefem_msh_io_test
  832. fsolve_test, a MATLAB code which calls fsolve() which seeks the solution x of one or more nonlinear equations f(x)=0.
  833. full_deck_simulation, a MATLAB code which simulates a process in which a random card is drawn from a deck of 52, and then replaced, continuing until every card has been seen at least once.
  834. full_deck_simulation_test
  835. gamblers_ruin_simulation, a MATLAB code which simulates a game in which a gambler never stops playing until all money is lost.
  836. gamblers_ruin_simulation_test
  837. gauss_seidel, a MATLAB code which implements the Gauss-Seidel iteration for linear systems.
  838. gauss_seidel_test
  839. gauss_seidel_poisson_1d, a MATLAB code which demonstrates how the linear system for a discretized version of the steady 1D Poisson equation can be solved by the Gauss-Seidel iteration.
  840. gauss_seidel_poisson_1d_test
  841. gauss_seidel_stochastic, a MATLAB code which uses a stochastic version of the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
  842. gauss_seidel_stochastic_test
  843. gaussian, a MATLAB code which evaluates the Gaussian function and its derivatives.
  844. gaussian_test,
  845. gaussian_2d, a MATLAB code which evaluates a general Gaussian function of a 2D argument.
  846. gaussian_2d_test,
  847. gaussian_prime_spiral, a MATLAB code which computes a twisting spiral path along the Gaussian primes, and displays a plot of the total trajectory.
  848. gaussian_prime_spiral_test
  849. ge_to_crs, a MATLAB code which converts a matrix from General (GE) to Compressed Row Storage (CRS) format.
  850. ge_to_crs_test
  851. gegenbauer_cc, a MATLAB code which computes the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
  852. gegenbauer_cc_test
  853. gegenbauer_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
  854. gegenbauer_exactness_test
  855. gegenbauer_polynomial, a MATLAB code which evaluates the Gegenbauer polynomial and associated functions.
  856. gegenbauer_polynomial_test
  857. gegenbauer_rule, a MATLAB code which computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
  858. gegenbauer_rule_test
  859. gen_hermite_exactness, a MATLAB code which tests the polynomial exactness of generalized Gauss-Hermite quadrature rules.
  860. gen_hermite_exactness_test
  861. gen_hermite_rule, a MATLAB code which computes and writes out a generalized Gauss-Hermite quadrature rule of given order and parameter value.
  862. gen_hermite_rule_test
  863. gen_laguerre_exactness, a MATLAB code which tests the polynomial exactness of generalized Gauss-Laguerre quadrature rules.
  864. gen_laguerre_exactness_test
  865. gen_laguerre_rule, a MATLAB code which prints a generalized Gauss-Laguerre quadrature rule of given order and parameter value.
  866. gen_laguerre_rule_test
  867. geometry, a MATLAB code which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.
  868. geometry_test
  869. geompack, a MATLAB code which computes Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.
  870. geompack_test
  871. gl_fast_rule, a MATLAB code which carries out the rapid computation of the Kth value and weight of an N point Gauss-Legendre quadrature rule, by Ignace Bogaert.
  872. gl_fast_rule_test
  873. glomin, a MATLAB code which finds a global minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  874. glomin_test
  875. glycolysis_ode, a MATLAB code which sets up a pair of ordinary differential equations (ODE) that model the biochemical process of glycolysis, for which a limit cycle exists.
  876. glycolysis_ode_test
  877. gmres, a MATLAB code which implements the generalized minimum residual (GMRES) method for solving a nonsymmetric sparse linear system A*x=b.
  878. gmres_test
  879. gmsh_io, a MATLAB code which reads or writes files created by the gmsh() program for 1D, 2D or 3D meshes used by the finite element method (FEM).
  880. gmsh_io_test
  881. gmsh_to_fem, a MATLAB code which reads a mesh data file created by the gmsh() program and writes a pair of node and element files that correspond to the FEM format.
  882. gmsh_to_fem_test
  883. gnuplot_test, a MATLAB code which uses gnuplot() to create various kinds of plots.
  884. gpl_display, a MATLAB code which tries to read the data in a typical gnuplot() GPL file, describing a 1D, 2D or 3D curve, or a surface Z(X,Y) defined on a regular grid, a triangular grid, or an irregular quadrilateral grid, displays it in a more attractive way than gnuplot() does.
  885. gpl_display_test
  886. gradient_descent, a MATLAB code which uses gradient descent to solve a linear least squares (LLS) problem.
  887. gradient_descent_test
  888. gram_polynomial, a MATLAB code which evaluates the Gram polynomials, also known as the discrete Chebyshev polyomials and associated functions.
  889. gram_polynomial_test
  890. gram_schmidt, a MATLAB code which implements the Gram-Schmidt process to orthogonalize and normalize a set of vectors.
  891. gram_schmidt_test
  892. graph_adj, a MATLAB code which carries out operations on abstract graphs, with undirected edges, represented by an adjacency matrix. Operations include breadth-first search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure.
  893. graph_adj_test
  894. graph_representation, a MATLAB code which expresses the representation of an abstract mathematical graph in several ways.
  895. graph_representation_test
  896. graphics_test, a MATLAB code which demonstrates a variety of graphics displays, including bar plots, contour plots, filled polygons, histograms, line plots, scatter plots, surface plots, tree diagrams, vector plots.
  897. gray_code_display, a MATLAB code which computes the Hamming distance tables for both the binary and Gray codes, and displays 3D plots that illustrate how the Gray code does a better job of providing nearby representations for nearby numbers.
  898. gray_code_display_test
  899. gray_scott_movie, a MATLAB code which solves versions of the partial differential equation (PDE) known as the Gray-Scott reaction diffusion equation, converting the solutions to a sequence of graphics frames, which are then assembled into a movie.
  900. gray_scott_movie_test
  901. gray_scott_pde, a MATLAB code which solves the partial differential equation (PDE) known as the Gray-Scott reaction diffusion equation, displaying a sequence of solutions as time progresses.
  902. gray_scott_pde_test
  903. grazing_ode, a MATLAB code which sets up and solves ordinary differential equations (ODE) that model the populations of an edible plant, and the herbivore that grazes on it.
  904. grazing_ode_test
  905. grf_display, a MATLAB code which reads a grf file defining a mathematical graph and displays it.
  906. grf_display_test
  907. grf_io, a MATLAB code which reads or writes a grf file which represents a mathematical graph;
  908. grf_io_test
  909. grid_display, a MATLAB code which reads a file of points on a grid or sparse grid, displays the grid and saves the image in a png file;
  910. grid_display_test
  911. gridlines, a MATLAB code which gives the user more control over drawing gridlines on a graph than the builtin grid command.
  912. gridlines_test
  913. grids_display, a MATLAB code which reads two files of grids or sparse grids, displaying the first with hollow blue dots, the second with solid red dots.
  914. grids_display_test
  915. gurobi_solution_read, a MATLAB code which reads a file created by the optimization package GUROBI, representing the solution of a polyomino tiling problem, and writes out a simple ASCII file that can be read by load().
  916. gurobi_solution_read_test
  917. haar_transform, a MATLAB code which computes the Haar transform of 1d or 2d data.
  918. haar_transform_test
  919. halton, a MATLAB code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
  920. halton_test
  921. hammersley, a MATLAB code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
  922. hammersley_test
  923. hamming, a MATLAB code which implements some simple versions of Hamming codes which can detect and correct errors in data.
  924. hamming_test
  925. hand_area, a MATLAB code which estimates the area of a curve which outlines a hand.
  926. hand_area_test
  927. hand_data, a MATLAB code which carries out some numerical exercises based on data that came from tracing several points on a hand.
  928. hand_data_test
  929. hand_mesh2d, a MATLAB code which reads in a set of points which outline a human hand, and calls mesh2d(), which is able to create a fine triangular mesh of the region outlined by the points.
  930. hand_mesh2d_test
  931. hankel_cholesky, a MATLAB code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix so that H = R' * R.
  932. hankel_cholesky_test
  933. hankel_inverse, a MATLAB code which computes the inverse of a Hankel matrix.
  934. hankel_inverse_test
  935. hankel_spd, a MATLAB code which computes a lower triangular matrix L which is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
  936. hankel_spd_test
  937. hb_io, a MATLAB code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
  938. hb_io_test
  939. hb_to_mm, a MATLAB code which converts a sparse matrix from Harwell Boeing (HB) to Matrix Market (MM) format.
  940. hb_to_mm_test
  941. hb_to_msm, a MATLAB code which converts a sparse matrix stored in a Harwell Boeing (HB) format to MATLAB sparse matrix (MSM) format;
  942. hb_to_msm_test
  943. hb_to_st, a MATLAB code which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.
  944. hb_to_st_test
  945. heartbeat_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) describing the beating of the heart, as suggested by Zeeman.
  946. heartbeat_ode_test
  947. heat_transfer_test, a MATLAB code which plots data from the computation of heat distribution on a metal disk, as computed by FreeFem++() and transferred using the ffmatlib() library.
  948. heated_plate, a MATLAB code which solves the steady state heat equation in a 2D rectangular region, and is intended as a starting point for a parallel version.
  949. heated_plate_test
  950. hello, a MATLAB code which prints out "Hello, world!".
  951. hello_test
  952. hello_parfor, a MATLAB code which uses the parfor() statement for parallel execution and simply prints "Hello, world!" multiple times.
  953. hello_parfor_test
  954. henon_heiles_ode, a MATLAB code which sets up and solves the Henon-Heiles system of ordinary differential equations (ODE) which model the motion of a star around the galactic center.
  955. henon_heiles_ode_test
  956. henon_orbit, a MATLAB code which computes the orbit of the Henon map for various sets of initial data.
  957. henon_orbit_test
  958. hermite_cubic, a MATLAB code which computes the value, derivatives or integral of a Hermite cubic polynomial, or manipulates an interpolating function made up of piecewise Hermite cubic polynomials.
  959. hermite_cubic_test
  960. hermite_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Hermite quadrature rules to estimate the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
  961. hermite_exactness_test
  962. hermite_integrands, a MATLAB code which defines test integrands for Hermite integrals with density exp(-x^2) over the interval (-oo,+oo).
  963. hermite_integrands_test
  964. hermite_interpolant, a MATLAB code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
  965. hermite_interpolant_test
  966. hermite_polynomial, a MATLAB code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
  967. hermite_polynomial_test
  968. hermite_product_display, a MATLAB code which displays an image of a function created by the Cartesian product of two Hermite polynomials, such as f(x,y) = h(3,x) * h(1,y).
  969. hermite_product_display_test
  970. hermite_product_polynomial, a MATLAB code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
  971. hermite_product_polynomial_test
  972. hermite_rule, a MATLAB code which returns a Gauss-Hermite quadrature rule to estimate the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
  973. hermite_rule_test
  974. hexagon_integrals, a MATLAB code which returns the exact value of the integral of a monomial over the interior of a hexagon in 2D.
  975. hexagon_integrals_test
  976. hexagon_lyness_rule, a MATLAB code which computes one of 13 Lyness quadrature rules over the interior of the unit hexagon.
  977. hexagon_lyness_rule_test
  978. hexagon_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of a hexagon in 2D;
  979. hexagon_monte_carlo_test
  980. hexagon_stroud_rule, a MATLAB code which computes one of four Stroud quadrature rules over the interior of the unit hexagon.
  981. hexagon_stroud_rule_test
  982. hexahedron_jaskowiec_rule, a MATLAB code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
  983. hexahedron_jaskowiec_rule_test
  984. hexahedron_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
  985. hexahedron_witherden_rule_test
  986. high_card_parfor, a MATLAB code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop, using parfor() to carry out the computation in parallel.
  987. high_card_parfor_test
  988. high_card_simulation, a MATLAB code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop.
  989. high_card_simulation_test
  990. hilbert_curve, a MATLAB code which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.
  991. hilbert_curve_test
  992. hilbert_curve_display, a MATLAB code which plots a Hilbert curve of given order.
  993. hilbert_curve_display_test
  994. histogram_data_2d_sample, a MATLAB code which demonstrates how to construct a Probability Density Function (PDF) from sample data over a 2D domain, and then to use that PDF to create new samples.
  995. histogram_data_2d_sample_test
  996. histogram_discrete, a MATLAB code which tries to make a histogram of data without using bins.
  997. histogram_discrete_test
  998. histogram_display, a MATLAB code which makes a bar plot of a set of data stored as columns in a file; the first column is the X values, and all the other columns are Y values to be shown as a stack of bars;
  999. histogram_display_test
  1000. histogram_pdf_sample, a MATLAB code which demonstrates how sampling can be done by starting with the formula for a PDF, creating a histogram, constructing a histogram for the CDF, and then sampling.
  1001. histogram_pdf_sample_test
  1002. histogram_pdf_2d_sample, a MATLAB code which demonstrates how uniform sampling of a 2D region with respect to some known Probability Density Function (PDF) can be approximated by decomposing the region into rectangles, approximating the PDF by a piecewise constant (PWC) function, constructing a histogram for the CDF, and then sampling.
  1003. histogram_pdf_2d_sample_test
  1004. histogramize, a MATLAB code which takes a vector of data and organizes it into a histogram of a given number of bins with given width and range, which can be displayed as a bar chart.
  1005. histogramize_test
  1006. hits, a MATLAB code which uses the HITS algorithm to assign authority and hub indices to a set of nodes in a directed network.
  1007. hits_test
  1008. house, a MATLAB code which includes a line segment outline of a house, and some programs to show how linear transformations affect the shape, by Cleve Moler.
  1009. house_test
  1010. human_data, a MATLAB code which starts with an image of simple outline of a human body, tabulates a sequence of points on the outline, creating numerical data defining the boundary. It is then able to fill the region with mesh points and triangulate the region. This allows the region to be analyzed by the finite element method (FEM).
  1011. human_data_test
  1012. humps, a MATLAB code which evaluates the humps() function, its first and second derivatives and its antiderivative.
  1013. humps_test
  1014. humps_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) whose solution is a double hump curve.
  1015. humps_ode_test
  1016. hyper_2f1, a MATLAB code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real parameters a, b, c, and real or complex argument x. For convenience, this function is simply a wrapper for the corresponding function in the scipy.special() library.
  1017. hyper_2f1_test
  1018. hyperball_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit hyperball in M dimensions.
  1019. hyperball_distance_test
  1020. hyperball_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.
  1021. hyperball_integrals_test
  1022. hyperball_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
  1023. hyperball_monte_carlo_test
  1024. hyperball_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit positive hyperball in M dimensions.
  1025. hyperball_positive_distance_test
  1026. hypercube_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected in the M-dimensional unit hypercube.
  1027. hypercube_distance_test
  1028. hypercube_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule over the interior of the unit hypercube in M dimensions.
  1029. hypercube_exactness_test
  1030. hypercube_grid, a MATLAB code which computes a grid of points over the interior of a hypercube in M dimensions.
  1031. hypercube_grid_test
  1032. hypercube_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.
  1033. hypercube_integrals_test
  1034. hypercube_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.
  1035. hypercube_monte_carlo_test
  1036. hypercube_surface_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit hypercube in D dimensions.
  1037. hypercube_surface_distance_test
  1038. hypergeom_test, a MATLAB code which calls hypergeom(), which is a built-in MATLAB function which evaluates the generalized hypergeometric functions pFq(z), for integer p and q.
  1039. hypersphere, a MATLAB code which carries out various operations for an M dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
  1040. hypersphere_test
  1041. hypersphere_angle, a MATLAB code which considers the problem of describing the typical value of the angle between a pair of points randomly selected on the unit hypersphere in M dimensions. Since by symmetry, this will be zero, we instead look at the average of the absolute value of the dot product, and the corresponding angle. In dimension 1, we have average dot product of 1, and angle 0. As the dimension increases, the average dot product rapidly decreases to 0, while the average angle goes to 90 degrees.
  1042. hypersphere_angle_test
  1043. hypersphere_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit hypersphere in M dimensions.
  1044. hypersphere_distance_test
  1045. hypersphere_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.
  1046. hypersphere_integrals_test
  1047. hypersphere_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
  1048. hypersphere_monte_carlo_test
  1049. hypersphere_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit positive hypersphere in M dimensions.
  1050. hypersphere_positive_distance_test
  1051. i4lib, a MATLAB code which contains utilities using single precision integer (I4) arithmetic.
  1052. i4lib_test
  1053. i4mat_rref2, a MATLAB code which computes a version of the reduced row echelon form of an integer matrix.
  1054. i4mat_rref2_test
  1055. ice_io, a MATLAB code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
  1056. ice_io_test
  1057. ice_to_medit, a MATLAB code which reads a netcdf() file containing an ICE dataset and rewrites the information as a medit() MESH file.
  1058. ice_to_medit_test
  1059. ill_bvp, a MATLAB code which defines an ill conditioned boundary value problem (BVP), and calls on bvp4c() to solve it with various values of the conditioning parameter.
  1060. ill_bvp_test
  1061. image_boundary, a MATLAB code which reports the pixels which form the boundary between the black and white regions of a simple image.
  1062. image_boundary_test
  1063. image_contrast, a MATLAB code which applies image processing techniques to increase the contrast in an image.
  1064. image_contrast_test
  1065. image_decimate, a MATLAB code which drops the even rows and columns from an image.
  1066. image_decimate_test
  1067. image_denoise, a MATLAB code which applies simple filtering operations to a noisy image.
  1068. image_denoise_test
  1069. image_diffuse, a MATLAB code which uses diffusion to smooth out an image.
  1070. image_diffuse_test
  1071. image_double, a MATLAB code which doubles the height and width of an image by repeating each row and column.
  1072. image_double_test
  1073. image_edge, a MATLAB code which detects edges in an image.
  1074. image_edge_test
  1075. image_mesh, a MATLAB code which starts with a list of points that bound some region, and calls mesh2d() to create a mesh of the interior.
  1076. image_mesh_test
  1077. image_noise, a MATLAB code which adds noise to an image.
  1078. image_noise_test
  1079. image_normalize, a MATLAB code which reads image data from a file, converts it (if necessary) to grayscale, resizes it to H pixels by W pixels.
  1080. image_normalize_test
  1081. image_quantization, a MATLAB code which uses kmeans() to reduce the number of colors or shades of gray in an image.
  1082. image_quantization_test
  1083. image_rgb_to_gray, a MATLAB code which makes a grayscale version of an RGB image.
  1084. image_rgb_to_gray_test
  1085. image_sample, a MATLAB code which allows the user to specify an image file to be displayed. The user may then use the mouse to select points on the image. The coordinates of each point are saved to a file. Selection ends with a double click. An example is supplied, which outlines the boundary of an aneurysm.
  1086. image_sample_test
  1087. image_threshold, a MATLAB code which makes a black and white version of a grayscale image by setting all pixels below or above a threshold value to black or white.
  1088. image_threshold_test
  1089. imshow_numeric, a MATLAB code which accepts a numeric 2D array and displays it as a grayscale image.
  1090. imshow_numeric_test
  1091. index, a MATLAB code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one based indexing schemes, as well as column major and row major conventions.
  1092. index_test
  1093. insurance_simulation, a MATLAB code which simulates a highly simplified model of term life insurance, in which a customer agrees to pay an annual fee for a given number of years, so that if the customer dies within that term, the family receives a large payout.
  1094. insurance_simulation_test
  1095. interp, a MATLAB code which parameterizes and interpolates data;
  1096. interp_test
  1097. interp_chebyshev, a MATLAB code which interactively uses n Chebyshev spaced nodes in the interval [a,b] to interpolate a function f(x) with a polynomial.
  1098. interp_chebyshev_test
  1099. interp_equal, a MATLAB code which interactively uses n equally spaced nodes in the interval [a,b] to interpolate a function f(x) with a polynomial.
  1100. interp_equal_test
  1101. interp_ncs, a MATLAB code which interactively constructs a natural cubic spline (NCS) interpolant to a function f(x), using the 'zero second derivative' end condition.
  1102. interp_ncs_test
  1103. interp_spline, a MATLAB code which interactively constructs a cubic spline interpolant to a function f(x), using the 'not-a-knot' end condition.
  1104. interp_spline_test
  1105. interp_spline_data, a MATLAB code which interactively constructs a cubic spline interpolant to (x,y) data, using the 'not-a-knot' end condition.
  1106. interp_spline_data_test
  1107. interp_trig, a MATLAB code which interactively uses n equally spaced nodes in the interval [a,b] to interpolate a function f(x) with a trigonometric polynomial.
  1108. interp_trig_test
  1109. iplot, a MATLAB code which interactively plots a function f(x) over a domain a ≤ x ≤ b;
  1110. iplot_test
  1111. is_gaussian_prime, a MATLAB code which is true if a given complex number c is a Gaussian prime.
  1112. is_gaussian_prime_test
  1113. is_prime, a MATLAB code which is true if a given integer n is prime.
  1114. is_prime_test
  1115. isbn, a MATLAB code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
  1116. isbn_test
  1117. ising_2d_simulation, a MATLAB code which simulates the evolution of a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors.
  1118. ising_2d_simulation_test
  1119. jaccard_distance, a MATLAB code which computes the Jaccard distance between two sets.
  1120. jaccard_distance_test
  1121. jacobi, a MATLAB code which implements the Jacobi iteration for the iterative solution of linear systems.
  1122. jacobi_test
  1123. jacobi_eigenvalue, a MATLAB code which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.
  1124. jacobi_eigenvalue_test
  1125. jacobi_exactness, a MATLAB code which tests the polynomial exactness of rules for integrals with a Jacobi weight function.
  1126. jacobi_exactness_test
  1127. jacobi_poisson_1d, a MATLAB code which uses Jacobi iteration to solve the linear system for a discretized steady 1D Poisson equation.
  1128. jacobi_poisson_1d_test
  1129. jacobi_polynomial, a MATLAB code which evaluates the Jacobi polynomial and associated functions.
  1130. jacobi_polynomial_test
  1131. jacobi_rule, a MATLAB code which computes a Gauss-Jacobi quadrature rule.
  1132. jacobi_rule_test
  1133. jai_alai_simulation, a MATLAB code which simulates a sequence matches of the game of jai alai.
  1134. jai_alai_simulation_test
  1135. jordan_matrix, a MATLAB code which returns a random matrix in Jordan canonical form.
  1136. jordan_matrix_test
  1137. joukowsky_transform, a MATLAB code which applies the Joukowsky transform to data, mapping between a circle in the complex plane and various airfoil shapes.
  1138. joukowsky_transform_test
  1139. julia_set, a MATLAB code which computes and plots a Julia set, the set of points in the complex plane that remain bounded under a mapping of the form f(z) = z^2+c.
  1140. julia_set_test
  1141. jumping_bean_simulation, a MATLAB code which simulates the motion of several jumping beans which prefer cooler locations.
  1142. jumping_bean_simulation_test
  1143. kdv_etdrk4, a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
  1144. kdv_etdrk4_test
  1145. kdv_exact, a MATLAB code which evaluates an exact solution of the Korteweg-deVries (KdV) partial differential equation (PDE).
  1146. kdv_exact_test
  1147. kdv_ift, a MATLAB code which uses the Inverse Fourier Transform (IFT) method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
  1148. kdv_ift_test
  1149. kelley, a MATLAB code which implements iterative methods for linear and nonlinear problems, by Tim Kelley.
  1150. kelley_test
  1151. kepler_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) for a Kepler two-body gravitational system.
  1152. kepler_ode_test
  1153. kepler_perturbed_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) for a perturbed Kepler two-body gravitational system.
  1154. kepler_perturbed_ode_test
  1155. keyword_test, a MATLAB code which accepts named keywords, using the Name/Value paired argument convention.
  1156. kmeans, a MATLAB code which handles the K-Means problem, which organizes a set of N points in M dimensions into K clusters;
  1157. kmeans_test
  1158. kmeans_fast, a MATLAB code which contains several different algorithms for the K-Means problem, which organizes a set of N points in M dimensions into K clusters, by Charles Elkan.
  1159. kmeans_fast_test
  1160. knapsack_01_brute, a MATLAB code which uses brute force to solve small versions of the 0/1 knapsack problem;
  1161. knapsack_01_brute_test
  1162. knapsack_dynamic, a MATLAB code which uses dynamic programming to solve a knapsack problem.
  1163. knapsack_dynamic_test
  1164. knapsack_greedy, a MATLAB code which uses a greedy algorithm to estimate a solution of the knapsack problem;
  1165. knapsack_greedy_test
  1166. kronrod_rule, a MATLAB code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  1167. kronrod_rule_test
  1168. kursiv_pde_etdrk4, a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Kuratomo-Sivashinsky PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
  1169. kursiv_pde_etdrk4_test
  1170. lagrange_approx_1d, a MATLAB code which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).
  1171. lagrange_approx_1d_test
  1172. lagrange_basis_display, a MATLAB code which displays the basis functions associated with a given set of nodes used with the Lagrange interpolation scheme.
  1173. lagrange_basis_display_test
  1174. lagrange_interp_1d, a MATLAB code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on a 1D argument, so that p(x(i)) = y(i).
  1175. lagrange_interp_1d_test
  1176. lagrange_interp_2d, a MATLAB code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).
  1177. lagrange_interp_2d_test
  1178. lagrange_interp_nd, a MATLAB code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on an M dimensional argument that was evaluated on a product grid, so that p(x(i)) = z(i).
  1179. lagrange_interp_nd_test
  1180. lagrange_nd, a MATLAB code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
  1181. lagrange_nd_test
  1182. laguerre_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Laguerre quadrature rules for integrating functions with density exp(-x) over [0,+oo).
  1183. laguerre_exactness_test
  1184. laguerre_integrands, a MATLAB code which implements test problems for approximate integration over a semi-infinite interval, often carried out using Gauss-Laguerre quadrature.
  1185. laguerre_integrands_test
  1186. laguerre_polynomial, a MATLAB code which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
  1187. laguerre_polynomial_test
  1188. laguerre_product, a MATLAB code which computes weighted integrals of products of Laguerre polynomials.
  1189. laguerre_product_test
  1190. laguerre_rule, a MATLAB code which returns a Gauss-Laguerre quadrature rule of given order.
  1191. laguerre_rule_test
  1192. lambert_w, a MATLAB code which evaluates Lambert's W function.
  1193. lambert_w_test
  1194. langford_ode, a MATLAB code which sets up and solves the Langford system of ordinary differential equations (ODE).
  1195. langford_ode_test
  1196. laplace_periodic_test, a MATLAB code which plots data from the solution of the Laplace equation in a square with periodic boundary conditions, computed by FreeFem++() and transferred using the ffmatlib() library.
  1197. laplacian, a MATLAB code which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
  1198. laplacian_test
  1199. latin_center, a MATLAB code which computes N points in an M dimensional Latin Center square;
  1200. latin_center_test
  1201. latin_cover, a MATLAB code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
  1202. latin_cover_test
  1203. latin_edge, a MATLAB code which returns N points in an M dimensional Latin Edge square;
  1204. latin_edge_test
  1205. latin_random, a MATLAB code which returns N points in an M dimensional Latin Random square;
  1206. latin_random_test
  1207. latinize, a MATLAB code which adjusts N points in M dimensions to form a Latin hypercube;
  1208. latinize_test
  1209. lattice_rule, a MATLAB code which returns lattice rules for M dimensional integration;
  1210. lattice_rule_test
  1211. leapfrog, a MATLAB code which uses the leapfrog method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
  1212. leapfrog_test
  1213. least_squares_approximant, a MATLAB code which finds a polynomial approximant to data using linear least squares (LLS).
  1214. least_squares_approximant_test
  1215. lebesgue, a MATLAB code which is given nodes in 1D, plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation.
  1216. lebesgue_test
  1217. legendre_exactness, a MATLAB code which tests the monomial exactness of quadrature rules for the Legendre problem of integrating a function with density 1 over the interval [-1,+1].
  1218. legendre_exactness_test
  1219. legendre_fast_rule, a MATLAB code which uses a fast (order N) algorithm to compute a Gauss-Legendre quadrature rule of given order.
  1220. legendre_fast_rule_test
  1221. legendre_polynomial, a MATLAB code which evaluates the Legendre polynomial and associated functions.
  1222. legendre_polynomial_test
  1223. legendre_product, a MATLAB code which computes weighted integrals of products of Legendre polynomials.
  1224. legendre_product_test
  1225. legendre_product_display, a MATLAB code which displays the points in a 2D Gauss-Legendre product quadrature rule;
  1226. legendre_product_display_test
  1227. legendre_product_polynomial, a MATLAB code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
  1228. legendre_product_polynomial_test
  1229. legendre_rule, a MATLAB code which returns a Gauss-Legendre quadrature rule of given order.
  1230. legendre_rule_test
  1231. legendre_shifted_polynomial, a MATLAB code which evaluates the shifted Legendre polynomial, with the domain [0,1].
  1232. legendre_shifted_polynomial_test
  1233. levels, a MATLAB code which makes a contour plot, choosing the contour levels using random sampling.
  1234. levels_test
  1235. levenshtein_distance, a MATLAB code which returns the Levenshtein distance between two strings.
  1236. levenshtein_distance_test
  1237. levenshtein_matrix, a MATLAB code which returns the Levenshtein distance matrix defined by two strings.
  1238. levenshtein_matrix_test
  1239. life, a MATLAB code which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.
  1240. life_test
  1241. lights_out, a MATLAB code which sets up the "Lights Out" game, lighting up a few squares on a grid. An interactive user must then try to press squares in such a way that all the lights are turned off.
  1242. lindberg_ode, a MATLAB code which sets up and solves a system of 4 ordinary differential equations (ODE) which are very stiff.
  1243. lindberg_ode_test
  1244. line_cvt_lloyd, a MATLAB code which applies the Lloyd iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
  1245. line_cvt_lloyd_test
  1246. line_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit line segment.
  1247. line_distance_test
  1248. line_fekete_rule, a MATLAB code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
  1249. line_fekete_rule_test
  1250. line_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a line segment in 1D.
  1251. line_felippa_rule_test
  1252. line_grid, a MATLAB code which computes a grid of points over the interior of a line segment in 1D.
  1253. line_grid_test
  1254. line_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the length of the unit line in 1D.
  1255. line_integrals_test
  1256. line_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line in 1D.
  1257. line_monte_carlo_test
  1258. line_ncc_rule, a MATLAB code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  1259. line_ncc_rule_test
  1260. line_nco_rule, a MATLAB code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  1261. line_nco_rule_test
  1262. linear_algebra, a MATLAB code which carries out various linear algebra operations for matrices stored in a variety of formats.
  1263. lissajous, a MATLAB code which displays a Lissajous figure, of the form x = sin ( a1 t + b1 ), y = sin ( a2 t + b2 ).
  1264. lissajous_test
  1265. llsq, a MATLAB code which solves the linear least squares (LLS) problem. It finds the "best" straight line to match a set of data points. More precisely, it finds the quantities "a" and "b" defining the straight line y=a*x+b, which minimizes the root-mean-square (RMS) error to the data.
  1266. llsq_test
  1267. load_test, a MATLAB code which calls the load() function, which reads data from a file into a variable.
  1268. lobatto_polynomial, a MATLAB code which evaluates Lobatto polynomials, which are similar to Legendre polynomials except that they are 0 at both endpoints.
  1269. lobatto_polynomial_test
  1270. local_min, a MATLAB code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  1271. local_min_test
  1272. local_min_rc, a MATLAB code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
  1273. local_min_rc_test
  1274. locker_simulation, a MATLAB code which simulates the locker problem, in which gym users have left their wallets in lockers; someone has scrambled all the lockers, and the gym users need a strategy that maximizes the chance that everyone will find their wallet by searching a limited number of lockers.
  1275. locker_simulation_test
  1276. log_norm, a MATLAB code which computes the logarithmic norm of a matrix, for norms 1, 2 and oo.
  1277. log_norm_test
  1278. log_normal, a MATLAB code which returns quantities related to the log normal Probability Distribution Function (PDF).
  1279. log_normal_test
  1280. log_normal_truncated_ab, a MATLAB code which returns quantities related to the log normal Probability Distribution Function (PDF) truncated to the interval [a,b].
  1281. log_normal_truncated_ab_test
  1282. logistic_bifurcation, a MATLAB code which plots the bifurcation diagram for the logistic equation, by John D Cook.
  1283. logistic_bifurcation_test
  1284. logistic_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
  1285. logistic_ode_test
  1286. lorenz_ode, sets up and solves the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
  1287. lorenz_ode_test
  1288. lorenz_ode_cluster_test, takes N points on a trajectory of solutions to the Lorenz system of ordinary differential equations (ODE), and applies the K-Means algorithm to organize the data into K clusters.
  1289. lorenz_ode_sensitivity_test, a MATLAB code which demonstrates sensitivity to initial conditions in the Lorenz system, of ordinary differential equations (ODE), using an approach suggested by John D Cook.
  1290. luhn, a MATLAB code which computes the Luhn check digit for a string, and validates a string.
  1291. luhn_test
  1292. machar, a MATLAB code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
  1293. machar_test
  1294. machine, a MATLAB code which returns values of arithmetic constants for a given machine.
  1295. machine_test
  1296. mackey_glass_dde, a MATLAB code which sets up and solves the Mackey-Glass Delay Differential Equation (DDE), which models dynamical diseases such as irregular breathing apnea and chronic myelogenous leukemia, and produces a strange chaotic attractor.
  1297. mackey_glass_dde_test
  1298. magic_matrix, a MATLAB code which computes a magic matrix, for any odd order n, such that all rows and columns have the same sum.
  1299. magic_matrix_test
  1300. mandelbrot, a MATLAB code which generates an image of the Mandelbrot set;
  1301. mandelbrot_test
  1302. mandelbrot_orbit, a MATLAB code which generates the Mandelbrot iterates arising from a single starting point;
  1303. mandelbrot_orbit_test
  1304. maple_area, a MATLAB code which takes the list of pixels that form the boundary of the image of a maple leaf within a picture, and uses grid, Monte Carlo, and Quasi Monte Carlo (QMC) sampling to estimate the area of the leaf.
  1305. maple_area_test
  1306. maple_boundary, a MATLAB code which reads an image of a maple leaf and extracts the list of pixels that form the boundary.
  1307. maple_boundary_test
  1308. mario, a MATLAB code which creates a sort of "needlepoint" image of Mario, as an array of colored squares.
  1309. mario_test
  1310. markov_letters, a MATLAB code which counts the occurences of letter pairs in a text.
  1311. markov_letters_test
  1312. matlab_test, a MATLAB code which illustrates the use of scripts and M-files;
  1313. matlab_combinatorics, a MATLAB code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
  1314. matlab_commandline, a MATLAB code which illustrates how MATLAB can be run from the UNIX command line, that is, not with the usual command window.
  1315. matlab_compiler, a MATLAB code which illustrates the use of the Matlab compiler, which allows you to run an application outside of the Matlab environment.
  1316. matlab_distance, a MATLAB code which estimates the typical distance between a pair of points randomly selected from the surface or interior of a geometric object such as a circle, disk, sphere, cube, and between other nongeometric pairs of items.
  1317. matlab_graphics, a MATLAB code which demonstrates a few issues that arise when producing graphic images with MATLAB.
  1318. matlab_grid, a MATLAB code which generates a regular grid of points inside a variety of regions in one, two, three or many dimensions.
  1319. matlab_kmeans_test, a MATLAB code which calls the MATLAB kmeans() function, which clusters N sets of M-dimensional data into K clusters.
  1320. matlab_map, a MATLAB code which uses the MATLAB mapping toolbox to draw maps of the world, countries, the US, or individual states.
  1321. matlab_mistake, a MATLAB code which illustrates some simple but devious programming mistakes in MATLAB.
  1322. matlab_monte_carlo, a MATLAB code which uses Monte Carlo sampling to estimate areas and integrals.
  1323. matlab_ode, a MATLAB code which sets up various systems of ordinary differential equations (ODE).
  1324. matlab_os, a MATLAB code which illustrates how the system command can be used to allow MATLAB to issue commands to the computer operating system (UNIX or DOS);
  1325. matlab_plots, a MATLAB code which uses plotting to illustrate a mathematical structure, such as an iterative map, a fractal, a curve or surface.
  1326. matlab_polynomial, a MATLAB code which analyzes a variety of polynomial families, returning the polynomial values, coefficients, derivatives, integrals, roots, or other information.
  1327. matlab_random_test, a MATLAB code which demonstrates random number generation.
  1328. matlab_simulation, a MATLAB code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
  1329. matrix_analyze, a MATLAB code which reports whether a matrix has various properties.
  1330. matrix_analyze_test
  1331. matrix_assemble_parfor, a MATLAB code which demonstrates the parfor() parallel programming feature by assembling the Hilbert matrix in a parallel loop.
  1332. matrix_assemble_parfor_test
  1333. matrix_chain, a MATLAB code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming..
  1334. matrix_chain_test
  1335. matrix_exponential, a MATLAB code which computes the exponential of a matrix.
  1336. matrix_exponential_test
  1337. mcnuggets, a MATLAB code which counts M(N), the number of ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
  1338. mcnuggets_test
  1339. mcnuggets_diophantine, a MATLAB code which uses Diophantine methods to find the ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
  1340. mcnuggets_diophantine_test
  1341. md, a MATLAB code which carries out a molecular dynamics simulation, and is intended as a starting point for implementing a parallel version.
  1342. md_test
  1343. md_fast, a MATLAB code which carries out a molecular dynamics simulation; it is a version of md() that has been revised to take advantage of vectorization.
  1344. md_fast_test
  1345. md_parfor, a MATLAB code which runs the md() molecular dynamics program, running in parallel using parfor().
  1346. md_parfor_test
  1347. medit_mesh_io, a MATLAB code which reads or writes medit() MESH files defining a finite element mesh.
  1348. medit_mesh_io_test
  1349. medit_to_fem, a MATLAB code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
  1350. medit_to_fem_test
  1351. medit_to_ice, a MATLAB code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
  1352. medit_to_ice_test
  1353. memory, a MATLAB code which declares and uses a sequence of larger and larger arrays, to see what the memory limits are on a given computer.
  1354. memory_test
  1355. mesh_bandwidth, a MATLAB code which returns the geometric bandwidth associated with a mesh of elements of any order and in a space of M dimensions.
  1356. mesh_bandwidth_test
  1357. mesh_boundary, a MATLAB code which is given a mesh of a 2D region, formed by polygonal elements, and determines a sequence of pairs of polygonal vertices that define the boundary of the region.
  1358. mesh_boundary_test
  1359. mesh_display, a MATLAB code which plots the nodes and elements of a polygonal mesh, with optional numbering.
  1360. mesh_display_test
  1361. mesh_etoe, a MATLAB code which uses ETOV, the mesh element-to-vertex connectivity, to construct ETOE, the element-to-element connectivity.
  1362. mesh_etoe_test
  1363. mesh_vtoe, a MATLAB code which uses ETOV, the mesh element-to-vertex connectivity, to construct VTOE, the vertex-to-element connectivity.
  1364. mesh_vtoe_test
  1365. mesh2d, a MATLAB code which automatically creates a triangular mesh for a given polygonal region, by Darren Engwirda.
  1366. mesh2d_test
  1367. mesh2d_to_medit, a MATLAB code which accepts the nodes and triangles of a mesh created by mesh2d() and creates a corresponding medit() MESH file.
  1368. mesh2d_to_medit_test
  1369. mesh2d_write, a MATLAB code which writes mesh2d() node and element data to files.
  1370. mesh2d_write_test
  1371. mgmres, a MATLAB code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
  1372. mgmres_test
  1373. mgs, a MATLAB code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
  1374. mgs_test
  1375. middle_square, a MATLAB code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
  1376. middle_square_test
  1377. midpoint, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with fsolve() solving the implicit equation, and a fixed time step.
  1378. midpoint_test
  1379. midpoint_adaptive, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with fsolve() solving the implicit equation, and an adaptive time step.
  1380. midpoint_adaptive_test
  1381. midpoint_explicit, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method, and using a fixed time step.
  1382. midpoint_explicit_test
  1383. midpoint_fixed, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a simple fixed-point iteration to solve the implicit equation, and using a fixed time step.
  1384. midpoint_fixed_test
  1385. mm_io, a MATLAB code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
  1386. mm_io_test
  1387. mm_to_hb, a MATLAB code which reads the sparse matrix information from an Matrix Market (MM) file and writes a corresponding Harwell Boeing (HB) file.
  1388. mm_to_hb_test
  1389. mm_to_msm, a MATLAB code which reads a Matrix Market (MM) file defining a sparse matrix, and creates a corresponding matrix in MATLAB sparse matrix (MSM) format.
  1390. mm_to_msm_test
  1391. mm_to_st, a MATLAB code which reads the sparse matrix information from a Matrix Market (MM) file and writes a corresponding Sparse Triplet (ST) file.
  1392. mm_to_st_test
  1393. mnist_neural, a MATLAB code which constructs a neural network in order to classify images of digits.
  1394. mnist_neural_test
  1395. monoalphabetic, a MATLAB code which applies a monoalphabetic substitution cipher to a string of text.
  1396. monoalphabetic_test
  1397. monomial, a MATLAB code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
  1398. monomial_test
  1399. monomial_symmetrize, a MATLAB code which symmetrizes the coefficients of equivalent monomials in a polynomial.
  1400. monomial_symmetrize_test
  1401. monomial_value, a MATLAB code which evaluates a monomial in M dimensions.
  1402. monomial_value_test
  1403. monopoly_matrix, a MATLAB code which computes the adjacency and transition matrices for the game of Monopoly.
  1404. monopoly_matrix_test
  1405. monty_hall_simulation, a MATLAB code which simulates the "Let's Make a Deal" game in which Monty Hall has hidden a prize behind one of several doors, and the user wins the prize if the correct door is selected.
  1406. monty_hall_simulation_test
  1407. mortality, a MATLAB code which processes some sample mortality data.
  1408. mortality_test
  1409. msm_to_hb, a MATLAB code which writes a MATLAB sparse matrix (MSM) to a Harwell Boeing (HB) file;
  1410. msm_to_hb_test
  1411. msm_to_mm, a MATLAB code which writes a MATLAB sparse matrix (MSM) to a Matrix Market (MM) file;
  1412. msm_to_mm_test
  1413. msm_to_st, a MATLAB code which writes a MATLAB sparse matrix (MSM) to a Sparse Triplet (ST) file;
  1414. msm_to_st_test
  1415. mxm, a MATLAB code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
  1416. mxm_test
  1417. naca, a MATLAB code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The shape can be displayed with MATLAB graphics.
  1418. naca_test
  1419. nas, a MATLAB code which runs the NASA kernel benchmark.
  1420. nas_test
  1421. navier_stokes_2d_exact, a MATLAB code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
  1422. navier_stokes_2d_exact_test
  1423. navier_stokes_3d_exact, a MATLAB code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
  1424. navier_stokes_3d_exact_test
  1425. navier_stokes_mesh2d, a MATLAB code which handles meshes for several 2D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
  1426. navier_stokes_mesh2d_test
  1427. navier_stokes_mesh3d, a MATLAB code which handles meshes for several 3D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
  1428. navier_stokes_mesh3d_test
  1429. ncm, a MATLAB code which accompanies the textbook "Numerical Computing with MATLAB", by Cleve Moler, and illustrates algorithms for the 3n+1 problem, blackjack, eigenvalue computations, fast Fourier transforms, Fibonacci numbers, file encryption, the flame differential equation, the fractal fern, the Lorenz differential equation, a membrane partial differential equation, minimization of a scalar function, ordinary differential equations, the pendulum differential equation, piecewise cubic Hermite interpolation, polynomial interpolation, quadrature for approximate integration, random number generation, tridiagonal linear system solution, the singular value decomposition, solution of a nonlinear equation.
  1430. ncm_test
  1431. nearest_interp_1d, a MATLAB code which interpolates a set of data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion.
  1432. nearest_interp_1d_test
  1433. neighbor_risk, a MATLAB code which records information about neighboring pairs of territories in the game of RISK.
  1434. neighbor_risk_test
  1435. neighbor_states, a MATLAB code which records information about pairs of US states which are neighbors.
  1436. neighbor_states_test
  1437. nelder_mead, a MATLAB code which implements the Nelder-Mead algorithm for the minimization of a scalar function of several variables, by Jeff Borggaard.
  1438. nelder_mead_test
  1439. netcdf_test, a MATLAB code which reads and writes netcdf files.
  1440. neural_network, a MATLAB code which illustrates the use of neural networks for deep learning, using back propagation and stochastic gradient descent, by Catherine Higham and Desmond Higham.
  1441. neural_network_test
  1442. newton_interp_1d, a MATLAB code which finds a polynomial interpolant to data using Newton divided differences.
  1443. newton_interp_1d_test
  1444. newton_rc, a MATLAB code which solves a system of nonlinear equations by Newton's method, using reverse communication (RC).
  1445. newton_rc_test
  1446. niederreiter2, a MATLAB code which computes the Niederreiter M dimensional Quasi Mont Carlo (QMC) sequence, base 2;
  1447. niederreiter2_test
  1448. nintlib, a MATLAB code which implements approximate integration (quadrature) in M dimensions;
  1449. nintlib_test
  1450. nonlin_bisect, a MATLAB code which interactively uses bisection to seek a zero of a function f(x) within a domain a ≤ x ≤ b;
  1451. nonlin_bisect_test
  1452. nonlin_fixed_point, a MATLAB code which interactively uses fixed point iteration x=g(x) to seek a zero of a function f(x) given a starting point x0 and iterations it;
  1453. nonlin_fixed_point_test
  1454. nonlin_newton, a MATLAB code which interactively uses the Newton method to find the zero of a function, given formulas for f(x), f'(x), and a starting point.
  1455. nonlin_newton_test
  1456. nonlin_regula, a MATLAB code which interactively uses the regula falsi method to seek a zero of a function f(x) within a change of sign interval [a,b];
  1457. nonlin_regula_test
  1458. nonlin_secant, a MATLAB code which interactively uses the secant method to seek a zero of a function f(x) given two starting estimates a and b.
  1459. nonlin_secant_test
  1460. nonlin_snyder, a MATLAB code which interactively uses the Snyder method to seek a zero of a function f(x) within a change of sign interval [a,b];
  1461. nonlin_snyder_test
  1462. norm_l1, a MATLAB code which interactively estimates the L1 norm of a function over an interval [A,B], with the function entered as a string.
  1463. norm_l1_test
  1464. norm_l2, a MATLAB code which interactively estimates the L2 norm of a function over an interval [A,B], with the function entered as a string.
  1465. norm_l2_test
  1466. norm_loo, a MATLAB code which interactively estimates the L-infinity norm of a function over an interval [A,B], with the function entered as a string.
  1467. norm_loo_test
  1468. norm_rms, a MATLAB code which interactively estimates the root mean square (RMS) norm of a function over an interval [A,B], with the function entered as a string.
  1469. norm_rms_test
  1470. normal, a MATLAB code which implements normal random number generators (RNG) for real and complex arithmetic, for scalars, vectors, and matrices.
  1471. normal_test
  1472. normal_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) defining the normal probability density function (PDF).
  1473. normal_ode_test
  1474. normal01_multivariate_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from an isotropic standard normal distribution in M dimensions.
  1475. normal01_multivariate_distance_test
  1476. numgrid, a MATLAB code which defines and numbers a subset of the nodes in a regular nxn grid of the [-1,+1]x[-1,+1] unit square. MATLAB includes a built-in version of this function.
  1477. numgrid_test
  1478. obj_display, a MATLAB code which displays an OBJ 3D graphics file;
  1479. obj_display_test
  1480. obj_io, a MATLAB code which reads and writes the data in an OBJ 3D graphics file;
  1481. obj_io_test
  1482. obj_to_tri_surface, a MATLAB code which reads an OBJ 3D graphics file and extracts the surface mesh data as a TRI_SURFACE dataset.
  1483. obj_to_tri_surface_test
  1484. octopus, a MATLAB code which contains some Octave utilities.
  1485. octopus_test
  1486. ode_euler, a MATLAB code which interactively applies the Euler method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
  1487. ode_euler_test
  1488. ode_euler_backward, a MATLAB code which interactively applies the backward Euler method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
  1489. ode_euler_backward_test
  1490. ode_euler_system, a MATLAB code which interactively applies the Euler method to estimate the solution of a system of ordinary differential equations (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
  1491. ode_euler_system_test
  1492. ode_midpoint, a MATLAB code which interactively applies the midpoint method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
  1493. ode_midpoint_test
  1494. ode_midpoint_system, a MATLAB code which interactively applies the midpoint method to estimate the solution of a system of ordinary differential equations (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
  1495. ode_midpoint_system_test
  1496. ode_rk4, a MATLAB code which interactively applies a fourth order Runge-Kutta method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
  1497. ode_rk4_test
  1498. ode_sweep_parfor, a MATLAB code which demonstrates how the parfor() command parallelizes the computation of a grid of solutions to a parameterized system of ordinary differential equations (ODE).
  1499. ode_sweep_parfor_test
  1500. ode_trapezoidal, a MATLAB code which interactively applies the trapezoidal method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
  1501. ode_trapezoidal_test
  1502. ode23_test, a MATLAB code which calls ode23(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 2 and 3.
  1503. ode45_test, a MATLAB code which calls ode45(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 4 and 5.
  1504. opt_golden, a MATLAB code which interactively estimates a minimizer of a function f(x) over the interval [a,b], assuming f(x) is unimodular (U-shaped) over the interval [a,b].
  1505. opt_golden_test
  1506. opt_gradient_descent, a MATLAB code which interactively seeks a local minimum of a function f(x), given a formula for the derivative f'(x), a starting point x0, and a stepsize factor gamma.
  1507. opt_gradient_descent_test
  1508. opt_quadratic, a MATLAB code which interactively uses quadratic interpolation to estimate a critical point of a function f(x) given three starting points, an iteration limit n, and tolerances for x and y.
  1509. opt_quadratic_test
  1510. opt_sample, a MATLAB code which interactively estimates the minimum and maximum of a function f(x) over an interval [a,b], using n random sample values, with the function entered as a string.
  1511. opt_sample_test
  1512. oregonator_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) for the Oregonator, a model of the Belousov-Zhabotinsky chemical reaction.
  1513. oregonator_ode_test
  1514. ornstein_uhlenbeck, a MATLAB code which approximates solutions of the Ornstein-Uhlenbeck stochastic differential equation (SDE) using the Euler method, the Euler-Maruyama method, and the Milstein method.
  1515. ornstein_uhlenbeck_test
  1516. oscillator_ode, a MATLAB code which sets up and solves the highly oscillatory ordinary differential equation (ODE).
  1517. oscillator_ode_test
  1518. outliers_test, a MATLAB code which uses the isoutlier() function, and other techniques, to identify outliers in data.
  1519. ozone_ode, a MATLAB code which sets up and solves a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration.
  1520. ozone_ode_test
  1521. ozone2_ode, a MATLAB code which sets up and solves a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration. This version of the ozone ODE includes a nitrogen oxide source term.
  1522. ozone2_ode_test
  1523. padua, a MATLAB code which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points.
  1524. padua_test
  1525. pagerank, a MATLAB code which uses the eigenvalue (power method) and surfer (Markov Chain Monte Carlo MCMC) approaches to ranking web pages.
  1526. pagerank_test
  1527. pagerank2, a MATLAB code which considers a specific application of the page rank algorithm.
  1528. pagerank2_test
  1529. pariomino, a MATLAB code which considers pariominoes, which are polyominoes with a checkerboard parity, and the determination of tilings of a region using a specific set of pariominoes.
  1530. pariomino_test
  1531. partial_digest, a MATLAB code which seeks solutions of the partial digest problem.
  1532. partial_digest_test
  1533. partition_brute, a MATLAB code which uses a brute force algorithm to seek solutions of the partition problem, splitting a set of integers into two subsets with equal sum.
  1534. partition_brute_test
  1535. partition_greedy, a MATLAB code which uses a greedy algorithm to seek a solution of the partition problem, in which a given set of integers is to be split into two groups whose sums are as close as possible.
  1536. partition_greedy_test
  1537. patterson_rule, a MATLAB code which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
  1538. patterson_rule_test
  1539. pbma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
  1540. pbma_io_test
  1541. pce_burgers, a MATLAB code which solves a version of the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
  1542. pce_burgers_test
  1543. pce_legendre, a MATLAB code which sets up the system matrix for a polynomial chaos expansion (PCE), using Legendre polynomials with a linear factor, applied to a 2D partial differential equation (PDE) with a stochastic diffusion coefficient.
  1544. pce_legendre_test
  1545. pce_ode_hermite, a MATLAB code which sets up a simple scalar ordinary differential equation (ODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
  1546. pce_ode_hermite_test
  1547. pdepe_test, a MATLAB code which uses pdepe(), which solves an initial boundary value problem (IBVP) in one spatial dimension.
  1548. pdflib, a MATLAB code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
  1549. pdflib_test
  1550. peak_movie, a MATLAB code which creates a sequence of frames, and then an animation or movie from the data displayed by the peaks() function.
  1551. peak_movie_test
  1552. pendulum_comparison_ode, a MATLAB code which compares the linear and nonlinear ordinary differential equations (ODE) that represent the behavior of a pendulum of length L under a gravitational force of strength G.
  1553. pendulum_comparison_ode_test
  1554. pendulum_double_ode, a MATLAB code which sets up and solves the double pendulum ordinary differential equation (ODE).
  1555. pendulum_double_ode_test
  1556. pendulum_double_ode_movie, a MATLAB code which solves the double pendulum ordinary differential equation (ODE) for a given set of initial conditions and parameters, and makes a movie of the results.
  1557. pendulum_double_ode_movie_test
  1558. pendulum_elastic_ode a MATLAB code which sets up and solves the ordinary differential equations (ODE) that represent the behavior of a nonlinear elastic pendulum, with gravitational force G, spring constant K, unstretched length L, and mass M.
  1559. pendulum_elastic_ode_test
  1560. pendulum_nonlinear_exact, a MATLAB code which evaluates an exact formula for the solution of the the ordinary differential equations (ODE) that represent the behavior of a nonlinear pendulum of length L under a gravitational force of strength G.
  1561. pendulum_nonlinear_exact_test
  1562. pendulum_nonlinear_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) that represent a nonlinear model of the behavior of a pendulum of length L under a gravitational force of strength G.
  1563. pendulum_nonlinear_ode_test
  1564. pendulum_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) that represent a linear model of the behavior of a pendulum of length L under a gravitational force of strength G.
  1565. pendulum_ode_test
  1566. pendulum_ode_period, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) that represent the behavior of a linear pendulum of length L under a gravitational force of strength G, in order to estimate the period of oscillation.
  1567. pendulum_ode_period_test
  1568. pentominoes, a MATLAB code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
  1569. pentominoes_test
  1570. perceptron_test, a MATLAB code which calculates a classifier of linearly separable data using the perceptron algorithm.
  1571. percolation_simulation, a MATLAB code which simulates a percolation system. A rectangular region is decomposed into a grid of MxN squares. Each square may be porous or solid. We are interested in a path of porous squares connecting the top and bottom, or the left and right boundaries. The original MATLAB code was written by Ian Cooper.
  1572. percolation_simulation_test
  1573. permutation_distance, a MATLAB code which estimates the expected value of the Ulam distance between a pair of randomly selected permutations of the same order.
  1574. permutation_distance_test
  1575. persistence, a MATLAB code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
  1576. persistence_test
  1577. pgma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
  1578. pgma_io_test
  1579. pi_spigot, a MATLAB code which produces any number of digits of the decimal expansion of pi.
  1580. pi_spigot_test
  1581. pic, a MATLAB code which uses the Particle In Cell (PIC) method to simulate the motion of electrically charged particles past a plate, and is intended as a starting point for implementing a parallel version.
  1582. pic_test
  1583. pink_noise, a MATLAB code which computes a pink noise signal obeying a 1/f power law.
  1584. pink_noise_test
  1585. plasma_matrix, a MATLAB code which sets up a matrix associated with a problem in plasma physics.
  1586. plasma_matrix_test
  1587. ply_io, a MATLAB code which reads or writes a 3D graphics file in PLY format, by Greg Turk;
  1588. ply_io_test
  1589. poisson_1d_multigrid, a MATLAB code which applies the multigrid method to a discretized version of the 1D Poisson equation.
  1590. poisson_1d_multigrid_test
  1591. poisson_2d, a MATLAB code which solves the Poisson equation in a rectangle, using finite differences and Jacobi iteration.
  1592. poisson_2d_test
  1593. poisson_ell_test, a MATLAB code which plots data from a solution of the Poisson equation in the L-shaped region, as computed by FreeFem++() and transferred using the ffmatlib() library.
  1594. poisson_simulation, a MATLAB code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda.
  1595. poisson_simulation_test
  1596. polar_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) whose variable is complex, and whose solution should be viewed in a polar coordinate plot.
  1597. polar_ode_test
  1598. polpak, a MATLAB code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Jacobi, Krawtchouk, Laguerre, Lambert, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling, Tau, Tribonacci, Zernike.
  1599. polpak_test
  1600. polygon, a MATLAB code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
  1601. polygon_test
  1602. polygon_average, a MATLAB code which demonstrates a process of repeatedly averaging and normalizing the vertices of a polygon, illustrating a property of the power method.
  1603. polygon_average_test
  1604. polygon_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of a polygon in 2D.
  1605. polygon_distance_test
  1606. polygon_grid, a MATLAB code which generates a grid of points over the interior of a polygon in 2D.
  1607. polygon_grid_test
  1608. polygon_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
  1609. polygon_integrals_test
  1610. polygon_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
  1611. polygon_monte_carlo_test
  1612. polygon_triangulate, a MATLAB code which triangulates a (possibly nonconvex) polygon in 2D, based on a C program by Joseph ORourke;
  1613. polygon_triangulate_test
  1614. polygonal_surface_display, a MATLAB code which displays a surface in 3D described as a set of polygons;
  1615. polygonal_surface_display_test
  1616. polyiamonds, a MATLAB code which works with polyiamonds, simple shapes constructed by edgewise connections of congruent equilateral triangles.
  1617. polyiamonds_test
  1618. polynomial, a MATLAB code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  1619. polynomial_test
  1620. polynomial_conversion, a MATLAB code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Hermite, Laguerre and Legendre forms.
  1621. polynomial_conversion_test
  1622. polynomial_multiply, a MATLAB code which multiplies two polynomials p(x) and q(x).
  1623. polynomial_multiply_test
  1624. polynomial_resultant, a MATLAB code which computes the resultant R of univariate polynomials P and Q.
  1625. polynomial_resultant_test
  1626. polynomial_resultant_symbolic_test, a MATLAB code which calls the symbolic function resultant(), which computes the resultant R of univariate polynomials P and Q.
  1627. polynomial_root_bound, a MATLAB code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
  1628. polynomial_root_bound_test
  1629. polynomials, a MATLAB code which defines multivariate polynomials over rectangular domains, for which certain information is to be determined, such as the maximum and minimum values.
  1630. polynomials_test
  1631. polyomino_parity, a MATLAB code which uses parity considerations to determine whether a given set of polyominoes can tile a specified region.
  1632. polyomino_parity_test
  1633. polyominoes, a MATLAB code which defines, solves, and plots a variety of polyomino tiling problems, which are solved by a direct algebraic approach, instead of the more typical brute-force or backtracking methods.
  1634. polyominoes_test
  1635. power_method, a MATLAB code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  1636. power_method_test
  1637. power_rule, a MATLAB code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
  1638. power_rule_test
  1639. pplane9, a MATLAB code which allows a user to interactively explore the phase plane of a system of autonomous ordinary differential equations. On starting the program, the user is given an interface in which to enter the equations and the screen limits, as well as a graphics screen on which the direction field is shown. Clicking any point in the graphics screen results in a trace of the phase plane curve through that point. The program is by Hugh Harvey and George Williams. With every new release of MATLAB, this program breaks again!
  1640. ppma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
  1641. ppma_io_test
  1642. pram, a MATLAB code which considers the pram puzzle, a smaller version of the eternity puzzle. The pram puzzle specifies a region R composed of 2304 30-60-90 triangles, and a set of 64 "tiles", consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  1643. pram_test
  1644. pram_cplex_test a BASH code which calls cplex(), to read the LP file defining the pram tiling problem, solve the linear programming problem, and write the solution to a file.
  1645. pram_view, a MATLAB code which considers the pram puzzle, and applies a given set of rotations, reflections and translations to the 64 tiles in order to reconstruct the pram region, thus verifying a known solution to the problem, as well as the correctness of the tile definitions.
  1646. praxis, a MATLAB code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
  1647. praxis_test
  1648. predator_prey_ode, a MATLAB code which sets up and solves a time-dependent predator-prey system of ordinary differential equations (ODE), for which a limit cycle exists.
  1649. predator_prey_ode_test
  1650. predator_prey_ode_period, a MATLAB code which sets up and solves a time-dependent predator-prey system of ordinary differential equations (ODE) in order to estimate the period of the limit cycle.
  1651. predator_prey_ode_period_test
  1652. prime, a MATLAB code which counts the number of primes between 1 and N, and is intended as a starting point for a parallel version.
  1653. prime_test
  1654. prime_parfor, a MATLAB code which counts primes between 1 and N, running in parallel using the parfor() feature of MATLAB.
  1655. prime_parfor_test
  1656. prime_pi, a MATLAB code which evaluates Pi(n), the number of primes less than or equal to an integer n.
  1657. prime_pi_test
  1658. prime_plot, a MATLAB code which displays a box plot of the prime and composite numbers.
  1659. prime_plot_test
  1660. prism_jaskowiec_rule, a MATLAB code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
  1661. prism_jaskowiec_rule_test
  1662. prism_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
  1663. prism_witherden_rule_test
  1664. prob, a MATLAB code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
  1665. prob_test
  1666. product_rule, a MATLAB code which creates an M dimensional quadrature rule from a product of distinct 1d quadrature rules;
  1667. product_rule_test
  1668. profile_data, a MATLAB code which carries out some numerical exercises based on data that came from tracing the profile of a face.
  1669. profile_data_test
  1670. puzzles, a MATLAB code which solves simple puzzles;
  1671. pwc_plot_1d, a MATLAB code which converts the definition of a piecewise constant (PWC) function of a 1D argument into plottable data.
  1672. pwc_plot_1d_test
  1673. pwc_plot_2d, a MATLAB code which converts the definition of a piecewise constant (PWC) function of a 2D argument into plottable data.
  1674. pwc_plot_2d_test
  1675. pwl_approx_1d, a MATLAB code which approximates a set of data using a piecewise linear (PWL) function.
  1676. pwl_approx_1d_test
  1677. pwl_interp_1d, a MATLAB code which interpolates a set of data using a piecewise linear (PWL) function.
  1678. pwl_interp_1d_test
  1679. pwl_interp_2d, a MATLAB code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
  1680. pwl_interp_2d_test
  1681. pwl_interp_2d_scattered, a MATLAB code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
  1682. pwl_interp_2d_scattered_test
  1683. pwl_product_integral, a MATLAB code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions f(x) and g(x).
  1684. pwl_product_integral_test
  1685. pyramid_exactness, a MATLAB code which investigates the polynomial exactness of a quadrature rule over the interior of the unit pyramid in 3D.
  1686. pyramid_exactness_test
  1687. pyramid_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
  1688. pyramid_felippa_rule_test
  1689. pyramid_grid, a MATLAB code which computes a grid of points over the interior of the unit pyramid in 3D;
  1690. pyramid_grid_test
  1691. pyramid_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
  1692. pyramid_integrals_test
  1693. pyramid_jaskowiec_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
  1694. pyramid_jaskowiec_rule_test
  1695. pyramid_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
  1696. pyramid_monte_carlo_test
  1697. pyramid_rule, a MATLAB code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D.
  1698. pyramid_rule_test
  1699. pyramid_witherden_rule, a MATLAB code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
  1700. pyramid_witherden_rule_test
  1701. qr_solve, a MATLAB code which computes the linear least squares (LLS) solution of a system A*x=b using the QR factorization.
  1702. qr_solve_test
  1703. quad_fast_rule, a MATLAB code which rapidly defines certain quadrature rules for approximating an integral;
  1704. quad_fast_rule_test
  1705. quad_gauss, a MATLAB code which interactively uses an n-point Gauss quadrature rule to estimate the integral of a function f(x) in the interval [a,b].
  1706. quad_gauss_test
  1707. quad_monte_carlo, a MATLAB code which interactively uses n random samples to estimate the integral of a function f(x) in the interval [a,b].
  1708. quad_monte_carlo_test
  1709. quad_parfor, a MATLAB code which estimates an integral using quadrature, using parfor() to enable parallel execution.
  1710. quad_parfor_test
  1711. quad_rule, a MATLAB code which defines quadrature rules for approximating an integral;
  1712. quad_rule_test
  1713. quad_trapezoid, a MATLAB code which interactively applies a trapezoid rule using n intervals to estimate the integral of a function f(x) over an interval [a,b].
  1714. quad_trapezoid_test
  1715. quad2d, a MATLAB code which estimates an integral over a 2D rectangle using quadrature, intended as the starting point for program optimization or parallelization.
  1716. quad2d_test
  1717. quadex_ode a MATLAB code which sets up and solves a stiff ordinary differential equation (ODE), whose exact solution is a parabola, but for which errors grow exponentially.
  1718. quadex_ode_test
  1719. quadmom, a MATLAB code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
  1720. quadmom_test
  1721. quadprog_test, calls quadprog() to solve problems in quadratic programming.
  1722. quadrature_golub_welsch, a MATLAB code which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure.
  1723. quadrature_golub_welsch_test
  1724. quadrature_least_squares, a MATLAB code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
  1725. quadrature_least_squares_test
  1726. quadrature_weights_vandermonde, a MATLAB code which computes the weights of a quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  1727. quadrature_weights_vandermonde_test
  1728. quadrature_weights_vandermonde_2d, a MATLAB code which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  1729. quadrature_weights_vandermonde_2d_test
  1730. quadrilateral, a MATLAB code which carries out geometric calculations on quadrilaterals, including angles, area, distances, nearest point, point containment, perimeter, and random generation.
  1731. quadrilateral_test
  1732. quadrilateral_mesh, a MATLAB code which handles meshes of quadrilaterals over a 2D region;
  1733. quadrilateral_mesh_test
  1734. quadrilateral_mesh_order1_display, a MATLAB code which plots piecewise constant (PWC) data associated with a mesh of quadrilaterals;
  1735. quadrilateral_mesh_order1_display_test
  1736. quadrilateral_surface_display, a MATLAB code which plots piecewise bilinear data associated with a quadrilateral_surface, that is, a 3D surface defined by a quadrilateral mesh;
  1737. quadrilateral_surface_display_test
  1738. quadrilateral_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
  1739. quadrilateral_witherden_rule_test
  1740. quality, a MATLAB code which measures the dispersion of pointsets in M dimensions;
  1741. quality_test
  1742. quasiperiodic_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) for a problem with a quasiperiodic solution.
  1743. quasiperiodic_ode_test
  1744. quaternions, a MATLAB code which carries out some simple arithmetic operations for quaternions.
  1745. quaternions_test
  1746. r8_scale, a MATLAB code which computes the "next" and "previous" real numbers.
  1747. r8_scale_test
  1748. r83, a MATLAB code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
  1749. r83_test
  1750. r83_np, a MATLAB code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
  1751. r83_np_test
  1752. r83p, a MATLAB code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
  1753. r83p_test
  1754. r83s, a MATLAB code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
  1755. r83s_test
  1756. r83t, a MATLAB code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
  1757. r83t_test
  1758. r83v, a MATLAB code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
  1759. r83v_test
  1760. r85, a MATLAB code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
  1761. r85_test
  1762. r8bb, a MATLAB code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
  1763. r8bb_test
  1764. r8blt, a MATLAB code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
  1765. r8blt_test
  1766. r8bto, a MATLAB code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
  1767. r8bto_test
  1768. r8but, a MATLAB code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
  1769. r8but_test
  1770. r8cb, a MATLAB code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
  1771. r8cb_test
  1772. r8cbb, a MATlAB code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
  1773. r8cbb_test
  1774. r8ccs, a MATLAB code which contains linear algebra routines for r8ccs matrices: real, 64 bit, Compressed Column Storage (CCS) format.
  1775. r8ccs_test
  1776. r8ci, a MATLAB code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
  1777. r8ci_test
  1778. r8col, a MATLAB code which contains utility routines for an R8COL, that is, a real 64 bit MxN array, considered as N column vectors, each of length M. The data may be thought of as a matrix of multiple columns, and many operations will be carried out columnwise.
  1779. r8col_test
  1780. r8crs, a MATLAB code which contains linear algebra routines for R8CRS matrices: real, 64 bit, Compressed Row Storage (CRS) format.
  1781. r8crs_test
  1782. r8gb, a MATLAB code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
  1783. r8gb_test
  1784. r8gd, a MATLAB code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
  1785. r8gd_test
  1786. r8ge, a MATLAB code which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).
  1787. r8ge_test
  1788. r8ge_np, a MATLAB code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
  1789. r8ge_np_test
  1790. r8lib, a MATLAB code which contains utilities for real 64 bit (R8) arithmetic.
  1791. r8lib_test
  1792. r8lt, a MATLAB code which contains linear algebra routines for R8LT matrices: real, 64 bit, Lower Triangular.
  1793. r8lt_test
  1794. r8ltt, a MATLAB code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
  1795. r8ltt_test
  1796. r8ncf, a MATLAB code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
  1797. r8ncf_test
  1798. r8pbl, a MATLAB code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
  1799. r8pbl_test
  1800. r8pbu, a MATLAB code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
  1801. r8pbu_test
  1802. r8po, a MATLAB code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
  1803. r8po_test
  1804. r8poly, a MATLAB code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
  1805. r8poly_test
  1806. r8pp, a MATLAB code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
  1807. r8pp_test
  1808. r8ri, a MATLAB code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
  1809. r8ri_test
  1810. r8row, a MATLAB code which contains utility routines for an R8ROW, that is, a real 64 bit MxN array, considered as M row vectors, each of length N. The data may be thought of as a matrix of multiple rows, and many operations will be carried out rowwise.
  1811. r8row_test
  1812. r8sd, a MATLAB code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
  1813. r8sd_test
  1814. r8sm, a MATLAB code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
  1815. r8sm_test
  1816. r8sr, a MATLAB code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
  1817. r8sr_test
  1818. r8ss, a MATLAB code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
  1819. r8ss_test
  1820. r8st, a MATLAB code which contains linear algebra routines for R8ST matrices: real, 64 bit, Sparse Triplet.
  1821. r8st_test
  1822. r8sto, a MATLAB code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
  1823. r8sto_test
  1824. r8to, a MATLAB code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
  1825. r8to_test
  1826. r8ut, a MATLAB code which contains linear algebra routines for r8ut matrices: real, 64 bit, Upper Triangular.
  1827. r8ut_test
  1828. r8utp, a MATLAB code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
  1829. r8utp_test
  1830. r8utt, a MATLAB code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
  1831. r8utt_test
  1832. r8vm, a MATLAB code which contains linear algebra routines for r8vm matrices (real, 64 bit, vandermonde format).
  1833. r8vm_test
  1834. randlc, a MATLAB code which implements a random number generator (RNG) used by the nas() benchmarks.
  1835. randlc_test
  1836. random_data, a MATLAB code which uses a random number generator (RNG) to sample points distributed according to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, cube, ellipse, ellipsoid, polygon, simplex and sphere.
  1837. random_data_test
  1838. random_sorted, a MATLAB code which generates vectors of random values which are already sorted.
  1839. random_sorted_test
  1840. random_walk_1d_simulation, a MATLAB code which simulates a random walk in a 1-dimensional region.
  1841. random_walk_1d_simulation_test
  1842. random_walk_2d_avoid_simulation, a MATLAB code which simulates a self-avoiding random walk in a 2-dimensional region.
  1843. random_walk_2d_avoid_simulation_test
  1844. random_walk_2d_simulation, a MATLAB code which simulates a random walk in a 2-dimensional region.
  1845. random_walk_2d_simulation_test
  1846. random_walk_3d_simulation, a MATLAB code which simulates a random walk in a 3-dimensional region.
  1847. random_walk_3d_simulation_test
  1848. ranlib, a MATLAB code which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
  1849. ranlib_test
  1850. rbf_interp_1d, a MATLAB code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
  1851. rbf_interp_1d_test
  1852. rbf_interp_2d, a MATLAB code which defines radial basis function (RBF) interpolants to 2D data.
  1853. rbf_interp_2d_test
  1854. rbf_interp_nd, a MATLAB code which defines and evaluates radial basis function (RBF) interpolants to M dimensional data.
  1855. rbf_interp_nd_test
  1856. reaction_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) which model a simple chemical reaction A+B --k--> C.
  1857. reaction_ode_test
  1858. reaction_twoway_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) which model a two-way chemical reaction between species W1 and W2.
  1859. reaction_twoway_ode_test
  1860. reactor simulation, a MATLAB code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."
  1861. reactor simulation_test
  1862. readmatrix_test, a MATLAB code which calls readmatrix(), a built-in function which reads a data file containing numeric data in columns; it can also skip one or more initial rows, read only a specified set of columns, to avoid dealing with text input.
  1863. readtable_test, a MATLAB code which calls readtable(), a built-in function which reads a data file containing data in columns, with some data being numeric and some text.
  1864. rectangle_distance, a MATLAB code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a rectangle.
  1865. rectangle_distance_test
  1866. region_test, a MATLAB code which plots data from an interesting region that was meshed by FreeFem++() and transferred using the ffmatlib() library.
  1867. rejection_sample, a MATLAB code which demonstrates acceptance/rejection sampling.
  1868. rejection_sample_test
  1869. rigid_body_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) representing the Euler equations for a rigid body with three unequal moments of inertia, originally proposed by Fred Krogh.
  1870. rigid_body_ode_test
  1871. ring_data, a MATLAB code which creates, plots, or saves data generated by sampling a number of concentric, possibly overlapping rings.
  1872. ring_data_test
  1873. ripple_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) whose solutions start as ripples and end as hyperbolas.
  1874. ripple_ode_test
  1875. risk_matrix, a MATLAB code which returns the transition and adjacency matrix for the game of RISK.
  1876. risk_matrix_test
  1877. rk12, a MATLAB code which solves an ordinary differential equation (ODE) using a Runge-Kutta (RK) method of order 2, estimating the local error with a Runge-Kutta method of order 1.
  1878. rk12_test
  1879. rk12_adapt, a MATLAB code which defines an adaptive ordinary differential equation (ODE) solver, using Runge-Kutta (RK) solvers of order 1 and 2.
  1880. rk12_adapt_test
  1881. rk23, a MATLAB code which applies Runge-Kutta (RK) solvers of order 2 and 3 to a system of ordinary differential equations (ODE);
  1882. rk23_test
  1883. rk34, a MATLAB code which applies Runge-Kutta (RK) solvers of order 3 and 4 to a system of ordinary differential equations (ODE);
  1884. rk34_test
  1885. rk4, a MATLAB code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.
  1886. rk4_test
  1887. rk45, a MATLAB code which applies Runge-Kutta (RK) solvers of order 4 and 5 to a system of ordinary differential equations (ODE);
  1888. rk45_test
  1889. rkf45, a MATLAB code which applies a Runge-Kutta-Fehlberg (RKF) solver to a system of ordinary differential equations (ODE);
  1890. rkf45_test
  1891. rng_cliff, a MATLAB code which computes a sequence of values from the Cliff random number generator (RNG).
  1892. rng_cliff_test
  1893. rnglib, a MATLAB code which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
  1894. rnglib_test
  1895. robertson_ode, a MATLAB code which sets up and solves a system of three nonlinear stiff ordinary differential equations (ODE) characterizing an autocatalytic chemical reaction.
  1896. robertson_ode_test
  1897. roessler_ode, a MATLAB code which sets up and solves the right hand side of the 3D Roessler system of ordinary differential equations (ODE).
  1898. roessler_ode_test
  1899. root_rc, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Gaston Gonnet.
  1900. root_rc_test
  1901. roots_rc, a MATLAB code which seeks solutions of a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.
  1902. roots_rc_test
  1903. rot13, a MATLAB code which enciphers a string using the ROT13 cipher for letters, and the ROT5 cipher for digits.
  1904. rot13_test
  1905. roulette_simulation, a MATLAB code which simulates the spinning of a roulette wheel and the evaluation of certain common roulette bets.
  1906. roulette_simulation_test
  1907. row_echelon_integer, a MATLAB code which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.
  1908. row_echelon_integer_test
  1909. rref_test, a MATLAB code which calls rref() for the reduced row echelon form (RREF) of a matrix, which can be singular or rectangular.
  1910. rubber_band_ode, a MATLAB code which sets up and solves a set of ordinary differential equat ions (ODE) describing a mass suspended by a spring and rubber band, which exhibits chaotic behavior.
  1911. rubber_band_ode_test
  1912. rucklidge_ode, a MATLAB code which sets up and solves the Rucklidge ordinary differential equation (ODE), a model of double convection which embodies a transition to chaos.
  1913. rucklidge_ode_test
  1914. sammon_data, a MATLAB code which generates six M dimensional datasets for cluster analysis.
  1915. sammon_data_test
  1916. sandia_cubature, a MATLAB code which computes M-dimensional quadrature rules for certain regions and weight functions.
  1917. sandia_cubature_test
  1918. sandia_rules, a MATLAB code which produces 1D quadrature rules of Chebyshev, Clenshaw Curtis, Fejer 2, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, Legendre and Patterson types.
  1919. sandia_rules_test
  1920. sandia_sgmgg, a MATLAB code which explores a generalized construction method for sparse grids.
  1921. sandia_sgmgg_test
  1922. sandia_sparse, a MATLAB code which produces a M-dimensional sparse grid, based on a variety of 1D quadrature rules; only isotropic grids are generated, that is, the same rule is used in each dimension, and the same maximum order is used in each dimension.
  1923. sandia_sparse_test
  1924. satisfy_brute, a MATLAB code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
  1925. satisfy_brute_test
  1926. satisfy_parfor, a MATLAB code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, running in parallel using the parfor() feature.
  1927. satisfy_parfor_test
  1928. sawtooth_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) driven by a right hand side which is a sawtooth function (periodic, discontinuous, piecewise linear).
  1929. sawtooth_ode_test
  1930. schroedinger_linear_pde, a MATLAB code which sets up and solves the complex partial differential equation (PDE) known as Schroedinger's linear equation: dudt = i uxx, in one spatial dimension, with Neumann boundary conditions.
  1931. schroedinger_linear_pde_test
  1932. schroedinger_nonlinear_pde, a MATLAB code which sets up and solves the complex partial differential equation (PDE) known as Schroedinger's nonlinear equation: dudt = i uxx + i gamma * |u|^2 u, in one spatial dimension, with Neumann boundary conditions.
  1933. schroedinger_nonlinear_pde_test
  1934. scip_solution_read, a MATLAB code which reads a file created by the integer programming package scip(), representing the solution of a polyomino tiling problem, and writes out a simple ASCII file.
  1935. scip_solution_read_test
  1936. sde, a MATLAB code which illustrates properties of stochastic differential equations (SDE), and common algorithms for their analysis, by Desmond Higham;
  1937. sde_test
  1938. search_test, a MATLAB code which searches integers between A and B for a value J such that F(J) = C.
  1939. sensitive_ode, a MATLAB code which sets up a second order ordinary differential equation (ODE) which exhibits sensitive dependence on the initial condition.
  1940. sensitive_ode_test
  1941. serenity, a MATLAB code which considers the serenity puzzle, a smaller version of the eternity puzzle. The serenity puzzle specifies a dodecagonal region R composed of 288 30-60-90 triangles, and a set of 8 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  1942. serenity_test
  1943. serenity_cplex_test a BASH code which calls cplex(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
  1944. serenity_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
  1945. set_theory, a MATLAB code which implements set theory operations such as union, intersection, complement, symmetric difference.
  1946. set_theory_test
  1947. sftpack, a MATLAB code which implements the slow Fourier transform (SFT), intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
  1948. sftpack_test
  1949. shallow_water_1d, a MATLAB code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations (SWE).
  1950. shallow_water_1d_test
  1951. shallow_water_1d_display, a MATLAB code which displays a solution of the shallow water equations (SWE) in 1D, generally as computed by the program shallow_water_1d().
  1952. shallow_water_1d_display_test
  1953. shallow_water_1d_movie, a MATLAB code which solves the partial differential equation (PDE) known as the shallow water equations (SWE), converting the solutions to a sequence of graphics frames, which are then assembled into a movie.
  1954. shallow_water_1d_movie_test
  1955. shepard_interp_1d, a MATLAB code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
  1956. shepard_interp_1d_test
  1957. shepard_interp_2d, a MATLAB code which defines and evaluates Shepard interpolants to 2D data, based on inverse distance weighting.
  1958. shepard_interp_2d_test
  1959. shepard_interp_nd, a MATLAB code which defines and evaluates Shepard interpolants to M dimensional data, based on inverse distance weighting.
  1960. shepard_interp_nd_test
  1961. simplex_coordinates, a MATLAB code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  1962. simplex_coordinates_test
  1963. simplex_gm_rule, a MATLAB code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or over the interior of the simplex in M dimensions.
  1964. simplex_gm_rule_test
  1965. simplex_grid, a MATLAB code which generates a regular grid of points over the interior of an arbitrary simplex in M dimensions.
  1966. simplex_grid_test
  1967. simplex_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.
  1968. simplex_integrals_test
  1969. simplex_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate an integral over the interior of the unit simplex in M dimensions.
  1970. simplex_monte_carlo_test
  1971. sine_transform, a MATLAB code which demonstrates properties of the discrete sine transform (DST).
  1972. sine_transform_test
  1973. single_linkage_test, a MATLAB code which uses the MATLAB single linkage clustering functions.
  1974. sir_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) which simulate the spread of a disease using the Susceptible/Infected/Recovered (SIR) model.
  1975. sir_ode_test
  1976. sir_simulation, a MATLAB code which simulates the spread of a disease through a hospital room of M by N beds, using the Susceptible/Infected/Recovered (SIR) model.
  1977. sir_simulation_test
  1978. sling_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) for which the exact circular solution can only be approximated for a short interval before it decays to zero.
  1979. sling_ode_test
  1980. snakes_and_ladders, a MATLAB code which provides tools for studying the game of Snakes and Ladders.
  1981. snakes_and_ladders_simulation, a MATLAB code which simulates a one-player game of Snakes and Ladders, to produce histograms of the count, PDF and CDF estimates for the length of a one-player game.
  1982. snakes_and_ladders_simulation_test
  1983. snakes_game, a MATLAB code which simulates a one-player version of the game of Snakes and Ladders, by Mina Aymin.
  1984. snakes_matrix, a MATLAB code which returns the transition matrix for the game of Snakes and Ladders.
  1985. snakes_matrix_test
  1986. snakes_probability, a MATLAB code which computes the game length probabilities for the game of Snakes and Ladders, by Desmond Higham and Nicholas Higham.
  1987. snakes_probability_test
  1988. sobol, a MATLAB code which generates elements of the Sobol M dimensional Quasi Mont Carlo (QMC) sequence, by Bennett Fox.
  1989. sobol_test
  1990. solve, a MATLAB code which uses Gauss elimination to solve a linear system A*x=b.
  1991. solve_test
  1992. sor, a MATLAB code which uses the successive over-relaxation (SOR) iteration to solve a linear system of equations.
  1993. sor_test
  1994. sort_rc, a MATLAB code which sorts a list of any kind of objects, using reverse communication (RC).
  1995. sort_rc_test
  1996. sort_test, a MATLAB code which calls the sort() function to sort objects of several types.
  1997. sparse_test, a MATLAB code which tests the sparse() function for creating sparse matrices and carrying out linear algebraic functions on them;
  1998. sparse_display, a MATLAB code which reads information defining a matrix of numbers and displays the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is already available in the built-in MATLAB spy() function.
  1999. sparse_display_test
  2000. sparse_grid_cc, a MATLAB code which creates sparse grids based on Clenshaw-Curtis (CC) quadrature rules.
  2001. sparse_grid_cc_test
  2002. sparse_grid_gl, a MATLAB code which creates sparse grids based on Gauss-Legendre (GL) rules.
  2003. sparse_grid_gl_test
  2004. sparse_grid_hermite, a MATLAB code which creates sparse grids based on Gauss-Hermite rules.
  2005. sparse_grid_hermite_test
  2006. sparse_grid_hw, a MATLAB code which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
  2007. sparse_grid_hw_test
  2008. sparse_grid_laguerre, a MATLAB code which creates sparse grids based on Gauss-Laguerre rules.
  2009. sparse_grid_laguerre_test
  2010. sparse_grid_mixed, a MATLAB code which creates a sparse grid dataset based on a mixed set of 1D factor rules.
  2011. sparse_grid_mixed_test
  2012. sparse_grid_total_poly, a MATLAB code which investigates the total polynomial approximation using sparse grids.
  2013. sparse_grid_total_poly_test
  2014. sparse_interp_nd, a MATLAB code which defines a sparse interpolant to a function f(x) of a M dimensional argument.
  2015. sparse_interp_nd_test
  2016. sparse_parfor, a MATLAB code which constructs a sparse matrix by evaluating individual blocks in parallel with the parfor() command, and then assembled on a single processor using the sparse() command, by Gene Cliff.
  2017. sparse_parfor_test
  2018. spd_test, a MATLAB code which performs a few tests on a real matrix to determine whether it is symmetric positive definite (SPD).
  2019. sphere_cubed_grid, a MATLAB code which uses the projection of a cube to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.
  2020. sphere_cubed_grid_test
  2021. sphere_cvt, a MATLAB code which carries out the Centroidal Voronoi Tessellation (CVT) iteration on the surface of the unit sphere in 3D.
  2022. sphere_cvt_test
  2023. sphere_delaunay, a MATLAB code which computes the Delaunay triangulation of points on the surface of the unit sphere in 3D.
  2024. sphere_delaunay_test
  2025. sphere_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit sphere in 3D.
  2026. sphere_distance_test
  2027. sphere_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule on the surface of the unit sphere in 3D.
  2028. sphere_exactness_test
  2029. sphere_fibonacci_grid, a MATLAB code which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.
  2030. sphere_fibonacci_grid_test
  2031. sphere_grid, a MATLAB code which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.
  2032. sphere_grid_test
  2033. sphere_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
  2034. sphere_integrals_test
  2035. sphere_lebedev_rule, a MATLAB code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
  2036. sphere_lebedev_rule_test
  2037. sphere_lebedev_rule_display, a MATLAB code which reads a file defining a Lebedev quadrature rule on the surface of the unit sphere in 3D and displays the point locations.
  2038. sphere_lebedev_rule_display_test
  2039. sphere_llq_grid, a MATLAB code which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.
  2040. sphere_llq_grid_test
  2041. sphere_llt_grid, a MATLAB code which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.
  2042. sphere_llt_grid_test
  2043. sphere_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.
  2044. sphere_monte_carlo_test
  2045. sphere_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit positive sphere in 3D.
  2046. sphere_positive_distance_test
  2047. sphere_quad, a MATLAB code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
  2048. sphere_quad_test
  2049. sphere_stereograph, a MATLAB code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
  2050. sphere_stereograph_test
  2051. sphere_stereograph_display, a MATLAB code which computes and displays the results of several stereographic projections between points on the surface of the unit sphere in 3D and a plane.
  2052. sphere_stereograph_display_test
  2053. sphere_triangle_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;
  2054. sphere_triangle_monte_carlo_test
  2055. sphere_triangle_quad, a MATLAB code which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.
  2056. sphere_triangle_quad_test
  2057. sphere_voronoi, a MATLAB code which computes the Voronoi diagram of points on the surface of the unit sphere in 3D.
  2058. sphere_voronoi_test
  2059. spinterp, a MATLAB code which carries out piecewise multilinear hierarchical sparse grid interpolation, quadrature and optimization, by Andreas Klimke; an earlier version of this software is ACM TOMS Algorithm 847.
  2060. spinterp_test
  2061. spiral_data, a MATLAB code which computes a velocity vector field that satisfies the continuity equation in 2D, writing the data to a file that can be plotted or analyzed.
  2062. spiral_data_test
  2063. spiral_pde, a MATLAB code which solves a pair of reaction-diffusion partial differential equations (PDE) over a rectangular domain with periodic boundary condition, whose solution is known to evolve into a pair of spirals.
  2064. spiral_pde_test
  2065. spiral_pde_movie, a MATLAB code which solves a pair of reaction-diffusion partial differential equations (PDE) over a rectangular domain with periodic boundary condition, whose solution is known to evolve into a pair of spirals. The sequence of solutions is bundled into a movie.
  2066. spiral_pde_movie_test
  2067. spline, a MATLAB code which interpolates and approximates via splines;
  2068. spline_test
  2069. spquad, a MATLAB code which computes the points and weights of a sparse grid quadrature rule for an M-dimensional integral, based on the Clenshaw-Curtis quadrature rule, by Greg von Winckel.
  2070. spquad_test
  2071. spring_double_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) for a system in which a mass is connected by a spring to a mass connected by a spring to a fixed support.
  2072. spring_double_ode_test
  2073. spring_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) for the motion of a spring with mass m, damping b, and stiffness k.
  2074. spring_ode_test
  2075. spring_sweep_ode, a MATLAB code which computes a grid of solutions to a parameterized system of ordinary differential equations (ODE) that represent the motion of a spring with mass m, damping b, and stiffness k.
  2076. spring_sweep_ode_test
  2077. square_arbq_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  2078. square_arbq_rule_test
  2079. square_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of the unit square in 2D.
  2080. square_distance_test
  2081. square_exactness, a MATLAB code which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a rectangle in 2D.
  2082. square_exactness_test
  2083. square_felippa_rule, a MATLAB code which returns Felippa quadrature rules for approximating integrals over the interior of a square in 2D.
  2084. square_felippa_rule_test
  2085. square_grid, a MATLAB code which computes a grid of points over the interior of a square in 2D.
  2086. square_grid_test
  2087. square_hex_grid, a MATLAB code which computes a hexagonal grid of points over the interior of a square in 2D.
  2088. square_hex_grid_test
  2089. square_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.
  2090. square_integrals_test
  2091. square_minimal_rule, a MATLAB code which returns "almost minimal" quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.
  2092. square_minimal_rule_test
  2093. square_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.
  2094. square_monte_carlo_test
  2095. square_surface_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit square.
  2096. square_surface_distance_test
  2097. square_symq_rule, a MATLAB code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  2098. square_symq_rule_test
  2099. squircle_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) for a pair of functions that generalize the sine and cosine, and whose phase portrait is a squircle (a sort of squared circle).
  2100. squircle_ode_test
  2101. st_io, a MATLAB code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
  2102. st_io_test
  2103. st_to_ccs, a MATLAB code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format;
  2104. st_to_ccs_test
  2105. st_to_hb, a MATLAB code which converts sparse matrix data from Sparse Triplet (ST) format to Harwell Boeing (HB) format;
  2106. st_to_hb_test
  2107. st_to_mm, a MATLAB code which converts sparse matrix data from Sparse Triplet (ST) format to Matrix Market (MM) format;
  2108. st_to_mm_test
  2109. st_to_msm, a MATLAB code which reads a Sparse Triplet (ST) file and creates a corresponding MATLAB Sparse Matrix (MSM).
  2110. st_to_msm_test
  2111. steinerberger, a MATLAB code which evaluates the Steinerberger function, a continuous function with discontinuous derivative, which is very hard to accurately plot, integrate, minimize, or interpolate.
  2112. steinerberger_test
  2113. stetter_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) for which a specific time step sequence causes the implicit trapezoidal method to be unstable, while the implicit midpoint method will be stable. Note that the right hand side function f(t,y) is periodic, discontinuous, and piecewise linear.
  2114. stetter_ode_test
  2115. stiff_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which is an example of a stiff ODE.
  2116. stiff_ode_test
  2117. stla_display, a MATLAB code which displays an ASCII stereolithography (STL) 3D graphics file;
  2118. stla_display_test
  2119. stla_io, a MATLAB code which reads and writes an ASCII stereolithography (STL) 3D graphics file;
  2120. stla_io_test
  2121. stla_to_tri_surface, a MATLAB code which reads an ASCII stereolithography (STL) 3D graphics file and extracts the surface mesh data as a TRI_SURFACE dataset.
  2122. stla_to_tri_surface_test
  2123. stla_to_tri_surface_fast, a MATLAB code which is a faster version of stla_to_tri_surface().
  2124. stla_to_tri_surface_fast_test
  2125. stochastic_diffusion, a MATLAB code which implements several versions of a stochastic diffusivity coefficient.
  2126. stochastic_diffusion_test
  2127. stochastic_heat2d, a MATLAB code which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.
  2128. stochastic_heat2d_test
  2129. stochastic_rk, a MATLAB code which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SDE).
  2130. stochastic_rk_test
  2131. stokes_2d_exact, a MATLAB code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
  2132. stokes_2d_exact_test
  2133. string_pde, a MATLAB code which sets up and solves the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
  2134. string_pde_test
  2135. stroud, a MATLAB code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
  2136. stroud_test
  2137. subset, a MATLAB code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems.
  2138. subset_test
  2139. subset_distance, a MATLAB code which estimates the expected value of the Hamming distance between a pair of randomly selected subsets of an M set.
  2140. subset_distance_test
  2141. subset_sum, a MATLAB code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  2142. subset_sum_test
  2143. subset_sum_backtrack, a MATLAB code which uses backtracking to find solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  2144. subset_sum_backtrack_test
  2145. subset_sum_brute, a MATLAB code which seeks solutions of the subset sum problem, using a brute force approach.
  2146. subset_sum_brute_test
  2147. sudoku, a MATLAB code which handles Sudoku puzzles;
  2148. sudoku_test
  2149. surf_test, calls surf(), which displays a 3D surface or contour plot for data of the form Z=F(X,Y).
  2150. svd_basis, a MATLAB code which applies the singular value decomposition (SVD) to a collection of data vectors, extracting dominant modes;
  2151. svd_basis_test
  2152. svd_circle, a MATLAB code which analyzes a linear map of the unit circle caused by an arbitrary 2x2 matrix A, using the singular value decomposition (SVD).
  2153. svd_circle_test
  2154. svd_faces, a MATLAB code which applies singular value decomposition (SVD) analysis to a set of images.
  2155. svd_faces_test
  2156. svd_fingerprint, a MATLAB code which reads a file containing a fingerprint image and uses the singular value decomposition (SVD) to compute and display a series of low rank approximations to the image.
  2157. svd_fingerprint_test
  2158. svd_gray, a MATLAB code which reads a gray scale image, computes the Singular Value Decomposition (SVD), and constructs a series of low rank approximations to the image.
  2159. svd_gray_test
  2160. svd_lls, a MATLAB code which uses the singular value decomposition (SVD) to construct and plot the best affine and linear relationships in the sense of least square, between two vectors of data.
  2161. svd_lls_test
  2162. svd_powers, a MATLAB code which applies singular value decomposition (SVD) analysis to a set of powers x(i)^(j-1).
  2163. svd_powers_test
  2164. svd_snowfall, a MATLAB code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).
  2165. svd_snowfall_test
  2166. svd_sphere, a MATLAB code which analyzes a linear map of the unit sphere caused by an arbitrary 3x3 matrix A, using the singular value decomposition (SVD).
  2167. svd_sphere_test
  2168. svd_test, a MATLAB code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
  2169. svd_truncated_test, a MATLAB code which calls the "economy" version of the Singular Value Decomposition (SVD) of an M by N rectangular matrix, in cases where M is less than N or N is less than M.
  2170. t_puzzle, a MATLAB code which considers the T puzzle, a set of 4 wooden pieces. The challenge is to arrange the pieces to form the shape of the letter T. Three other challenge shapes are an arrow, a rhombus, and a "fat" T.
  2171. t_puzzle_test
  2172. t_puzzle_cplex_test, a BASH code which calls cplex(), to read the LP file defining the T-puzzle tiling problem, solve the linear programming problem, and write the solution to a file.
  2173. t_puzzle_gui, a MATLAB code which sets up a graphical user interface for the T puzzle, by Cleve Moler.
  2174. t_puzzle_gurobi_test, a BASH code which calls gurobi(), to read the LP file defining the T-puzzle tiling problem, solve the linear programming problem, and write the solution to a file.
  2175. table_io, a MATLAB code which reads and writes a simple table file;
  2176. table_io_test
  2177. task_division, a MATLAB code which implements a simple procedure for smoothly dividing T tasks among P processors; such a method can be useful in MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors can be indexed starting from 0 or from 1.
  2178. task_division_test
  2179. tec_io, a MATLAB code which reads or writes a tecplot() ASCII TEC file containing a model associated with the finite element method (FEM).
  2180. tec_io_test
  2181. tec_to_fem, a MATLAB code which converts a tecplot() ASCII TEC file into an FEM model.
  2182. tec_to_fem_test
  2183. tec_to_vtk, a MATLAB code which converts a tecplot() TEC file into a set of VTK files.
  2184. tec_to_vtk_test
  2185. tennis_matrix, a MATLAB code which computes the transition matrix for a game of tennis, which has 17 distinct states.
  2186. tennis_matrix_test
  2187. tensor_grid_display, a MATLAB code which displays the grid points of a tensor product rule used for interpolation or quadrature, in 1D, 2D or 3D.
  2188. tensor_grid_display_test
  2189. test_approx, a MATLAB code which implements test problems for approximation, provided as a set of (x,y) data.
  2190. test_approx_test
  2191. test_con, a MATLAB code which implements test problems for numerical continuation.
  2192. test_con_test
  2193. test_eigen, a MATLAB code which implements test matrices for eigenvalue analysis.
  2194. test_eigen_test
  2195. test_int, a MATLAB code which implements test problems for approximate integration (quadrature) in one dimension.
  2196. test_int_test
  2197. test_int_2d, a MATLAB code which implements test problems for approximate integration (quadrature) in two dimensions.
  2198. test_int_2d_test
  2199. test_interp, a MATLAB code which defines test problems for interpolation, provided as a set of (x,y(x)) data.
  2200. test_interp_test
  2201. test_interp_1d, a MATLAB code which defines test problems for interpolation of data y(x), which depends on a 1D argument.
  2202. test_interp_1d_test
  2203. test_interp_2d, a MATLAB code which defines test problems for interpolation of data z(x,y), which depends on a 2D argument.
  2204. test_interp_2d_test
  2205. test_interp_fun, a MATLAB code which defines test problems for interpolation which are available in functional form.
  2206. test_interp_fun_test
  2207. test_interp_nd, a MATLAB code which defines test problems for interpolation of data z(x), depending on an M dimensional argument.
  2208. test_interp_nd_test
  2209. test_lls, a MATLAB code which implements linear least squares (LLS) test problems of the form A*x=b.
  2210. test_lls_test
  2211. test_matrix, a MATLAB code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
  2212. test_matrix_test
  2213. test_matrix_exponential, a MATLAB code which defines a set of test cases for computing the matrix exponential.
  2214. test_matrix_exponential_test
  2215. test_min, a MATLAB code which implements test problems for minimization of a scalar function of a scalar variable.
  2216. test_min_test
  2217. test_nearest, a MATLAB code which tests the time complexity of various procedures for solving the nearest neighbor problem.
  2218. test_nearest_test
  2219. test_nint, a MATLAB code which defines test functions for M-dimensional quadrature routines.
  2220. test_nint_test
  2221. test_nonlin, a MATLAB code which implements test problems for the solution of systems of nonlinear equations.
  2222. test_nonlin_test
  2223. test_opt, a MATLAB code which implements test problems for optimization of a scalar function of several variables.
  2224. test_opt_test
  2225. test_opt_con, a MATLAB code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
  2226. test_opt_con_test
  2227. test_optimization, a MATLAB code which implements test problems for optimization of a scalar function of several variables, as described by Molga and Smutnicki.
  2228. test_optimization_test
  2229. test_partial_digest, a MATLAB code which generates example cases of the partial digest problem.
  2230. test_partial_digest_test
  2231. test_triangulation, a MATLAB code which defines test problems for triangulation;
  2232. test_triangulation_test
  2233. test_values, a MATLAB code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi, Julian Ephemeris Date, Kelvin, Laguerre, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright omega, Zeta.
  2234. test_values_test
  2235. test_zero, a MATLAB code which defines some functions f(x) suitable for testing software that solves a nonlinear equation f(x)=0;
  2236. test_zero_test
  2237. tester, a BASH script which runs the MATLAB tests.
  2238. tet_mesh, a MATLAB code which works with tetrahedral meshes in 3D;
  2239. tet_mesh_test
  2240. tet_mesh_boundary, a MATLAB code which reads information defining a tetrahedral mesh of points in 3D, and determines the triangular faces that form the boundary of the mesh; it writes out files containing the nodes and elements defining this TRI_SURFACE data.
  2241. tet_mesh_boundary_test
  2242. tet_mesh_display, a MATLAB code which reads data defining a tetrahedral mesh, and displays a wireframe image of the nodes and edges;
  2243. tet_mesh_display_test
  2244. tet_mesh_l2q, a MATLAB code which reads information about a 4-node linear mesh of tetrahedrons and creates data defining a corresponding 10-node quadratic mesh of tetrahedrons;
  2245. tet_mesh_l2q_test
  2246. tet_mesh_q2l, a MATLAB code which reads information about a 10-node quadratic mesh of tetrahedrons and creates data defining a corresponding 4-node linear mesh of tetrahedrons;
  2247. tet_mesh_q2l_test
  2248. tet_mesh_quad, a MATLAB code which estimates the integral of a function over a region defined by a tetrahedral mesh.
  2249. tet_mesh_quad_test
  2250. tet_mesh_quality, a MATLAB code which computes various quality measures for a tetrahedral mesh of a set of nodes in 3D;
  2251. tet_mesh_quality_test
  2252. tet_mesh_rcm, a MATLAB code which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a mesh of tetrahedrons, using 4 or 10 node elements.
  2253. tet_mesh_rcm_test
  2254. tet_mesh_refine, a MATLAB code which refines a mesh of tetrahedrons;
  2255. tet_mesh_refine_test
  2256. tet_mesh_tet_neighbors, a MATLAB code which reads information about a tetrahedral mesh and lists the tetrahedrons adjacent to a given tetrahedron;
  2257. tet_mesh_tet_neighbors_test
  2258. tet_mesh_to_gmsh, a MATLAB code which write a gmsh() file describing a tetrahedral mesh;
  2259. tet_mesh_to_gmsh_test
  2260. tet_mesh_to_xml, a MATLAB code which write an XML file describing a tetrahedral mesh;
  2261. tet_mesh_to_xml_test
  2262. tet_mesh_volumes, a MATLAB code which computes the volume of each tetrahedron in a mesh of tetrahedrons;
  2263. tet_mesh_volumes_test
  2264. tetrahedron, a MATLAB code which carries out geometric calculations involving a general tetrahedron, including solid and facial angles, face areas, point containment, distances to a point, circumsphere and insphere, measures of shape quality, centroid, barycentric coordinates, edges and edge lengths, random sampling, and volumes.
  2265. tetrahedron_test
  2266. tetrahedron_arbq_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
  2267. tetrahedron_arbq_rule_test
  2268. tetrahedron_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.
  2269. tetrahedron_exactness_test
  2270. tetrahedron_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
  2271. tetrahedron_felippa_rule_test
  2272. tetrahedron_grid, a MATLAB code which computes a grid of points over the interior of a tetrahedron in 3D.
  2273. tetrahedron_grid_test
  2274. tetrahedron_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
  2275. tetrahedron_integrals_test
  2276. tetrahedron_jaskowiec_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
  2277. tetrahedron_jaskowiec_rule_test
  2278. tetrahedron_keast_rule, a MATLAB code which defines a Keast quadrature rule, of degree of exactness 0 through 8, over the interior of the tetrahedron in 3D.
  2279. tetrahedron_keast_rule_test
  2280. tetrahedron_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate an integral over the interior of a general tetrahedron in 3D.
  2281. tetrahedron_monte_carlo_test
  2282. tetrahedron_ncc_rule, a MATLAB code which defines Newton-Cotes closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
  2283. tetrahedron_ncc_rule_test
  2284. tetrahedron_nco_rule, a MATLAB code which defines Newton-Cotes open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
  2285. tetrahedron_nco_rule_test
  2286. tetrahedron_slice_display, a MATLAB code which determines the intersection between a tetrahedron and a plane and displays the result.
  2287. tetrahedron_slice_display_test
  2288. tetrahedron_slice_movie, a MATLAB code which is given a tetrahedron and a vector, displays an evenly spaced sequence of planes that intersect the tetrahedron and are normal to the vector, and creates a movie of the process.
  2289. tetrahedron_slice_movie_test
  2290. tetrahedron_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
  2291. tetrahedron_witherden_rule_test
  2292. tetrahedron01_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate an integral over the interior of the unit tetrahedron in 3D.
  2293. tetrahedron01_monte_carlo_test
  2294. theodolite, a MATLAB code which presents the problem of estimating the location of an event which occurs in the sky, atmosphere, or the heavens, using nothing but the reported angle of observation from several stations; a nonlinear least squares (NLS) solver is needed.
  2295. theodolite_test
  2296. theta_method, a MATLAB code which solves one or more ordinary differential equations (ODE) using the theta method.
  2297. theta_method_test
  2298. three_body_ode, a MATLAB code which sets up and solves ordinary differential equations (ODE) that simulate the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.
  2299. three_body_ode_test
  2300. tictoc_test, a MATLAB code which calls tic() and toc(), which compute elapsed time.
  2301. timer_test, a MATLAB code which demonstrates and compares several ways of timing code execution.
  2302. timestamp, a MATLAB code which prints the current YMDHMS date as a timestamp;
  2303. timestamp_test
  2304. toeplitz_cholesky, a MATLAB code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
  2305. toeplitz_cholesky_test
  2306. toeplitz_inverse, a MATLAB code which computes the inverse of a Toeplitz matrix.
  2307. toeplitz_inverse_test
  2308. toms097, a MATLAB code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm.
  2309. toms097_test
  2310. toms112, a MATLAB code which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.
  2311. toms112_test
  2312. toms178, a MATLAB code which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.
  2313. toms178_test
  2314. toms179, a MATLAB code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
  2315. toms179_test
  2316. toms243, a MATLAB code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
  2317. toms243_test
  2318. toms291, a MATLAB code which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.
  2319. toms291_test
  2320. toms443, a MATLAB code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
  2321. toms443_test
  2322. toms446, a MATLAB code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
  2323. toms446_test
  2324. toms462, a MATLAB code which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.
  2325. toms462_test
  2326. toms515, a MATLAB code which selects subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
  2327. toms515_test
  2328. toms577, a MATLAB code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
  2329. toms577_test
  2330. toms655, a MATLAB code which computes the weights for interpolatory quadrature rules; this is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
  2331. toms655_test
  2332. toms743, a MATLAB code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
  2333. toms743_test
  2334. toms847, a MATLAB code which carries out piecewise linear (PWL) multidimensional hierarchical sparse grid interpolation; this is commonly called spinterp() (version 2.1); this is a version of ACM TOMS Algorithm 847, by Andreas Klimke;
  2335. toms847_test
  2336. toms866, a MATLAB code which is version 2.2 of the Incompressible Flow Iterative Solution Software (IFISS), for fluid flow governed by the Navier Stokes equations (NSE), by Howard Elman, Alison Ramage, David Silvester; this is a version of ACM TOMS algorithm 866.
  2337. toms886, a MATLAB code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
  2338. toms886_test
  2339. toms923, a MATLAB code which evaluates the Pfaffian for a dense or banded skew symmetric matrix, by Michael Wimmer.
  2340. toms923_test
  2341. tortoise, a MATLAB code which considers the tortoise tiling puzzle, a smaller version of the eternity puzzle. The puzzle specifies a region R composed of 1620 30-60-90 triangles, and a set of 45 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  2342. tortoise_test
  2343. tortoise_cplex_test a BASH code which calls cplex(), to read the LP file defining the tortoise tiling problem, solve the linear programming problem, and write the solution to a file.
  2344. tortoise_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the tortoise tiling problem, solve the linear programming problem, and write the solution to a file.
  2345. tough_ode, a MATLAB code which sets up and solves a system of four ordinary differential equations (ODE) which is extremely difficult to solve accurately.
  2346. tough_ode_test
  2347. traffic_simulation, a MATLAB code which simulates the cars waiting to get through a traffic light.
  2348. traffic_simulation_test
  2349. trapezoidal, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and MATLAB's fsolve() to handle the implicit system.
  2350. trapezoidal_test
  2351. trapezoidal_explicit, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (explicit) trapezoidal method.
  2352. trapezoidal_explicit_test
  2353. trapezoidal_fixed, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, using the fixed point method.
  2354. trapezoidal_fixed_test
  2355. treepack, a MATLAB code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
  2356. treepack_test
  2357. tri_surface_display, a MATLAB code which displays a TRI_SURFACE describing a triangulated surface;
  2358. tri_surface_display_test
  2359. tri_surface_to_obj, a MATLAB code which reads a TRI_SURFACE dataset and extracts the surface mesh data as an OBJ file.
  2360. tri_surface_to_obj_test
  2361. tri_surface_to_stla, a MATLAB code which reads a TRI_SURFACE dataset and extracts the surface mesh data as an ASCII stereolithography (STL) file.
  2362. tri_surface_to_stla_test
  2363. triangle, a MATLAB code which computes properties of a triangle, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, quality, Cartesian to barycentric coordinates, barycentric coordinates to Cartesian. A point is treated as a (1,2) array, a list of points as an (n,2) array, and a triangle as a (3,2) array.
  2364. triangle_test
  2365. triangle_analyze, a MATLAB code which reads a triangle defined in a file and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
  2366. triangle_analyze_test
  2367. triangle_display, a MATLAB code which displays the nodes and elements of a triangulation for which the data has been stored in NODE and ELE files by Jonathan Shewchuk's triangle() program.
  2368. triangle_display_test
  2369. triangle_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from the interior of a triangle in 2D.
  2370. triangle_distance_test
  2371. triangle_dunavant_rule, a MATLAB code which returns a Dunavant quadrature rule over the interior of a triangle in 2D.
  2372. triangle_dunavant_rule_test
  2373. triangle_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule over the interior of a triangle in 2D.
  2374. triangle_exactness_test
  2375. triangle_fekete_rule, a MATLAB code which sets up one of seven Fekete rules for interpolation or quadrature over the interior of a triangle in 2D.
  2376. triangle_fekete_rule_test
  2377. triangle_felippa_rule, a MATLAB code which returns Felippa quadrature rules for approximating integrals over the interior of a triangle in 2D.
  2378. triangle_felippa_rule_test
  2379. triangle_grid, a MATLAB code which computes a grid of points over the interior of a triangle in 2D.
  2380. triangle_grid_test
  2381. triangle_histogram, a MATLAB code which computes histograms of data over the interior of a unit triangle in 2D.
  2382. triangle_histogram_test
  2383. triangle_integrals, a MATLAB code which returns the exact value of the integral of any polynomial over the interior of an arbitrary triangle in 2D.
  2384. triangle_integrals_test
  2385. triangle_integrands, a MATLAB code which defines integrands for testing quadrature rules over a triangle.
  2386. triangle_integrands_test
  2387. triangle_interpolate, a MATLAB code which shows how vertex data can be interpolated at any point in the interior of a triangle.
  2388. triangle_interpolate_test
  2389. triangle_io, a MATLAB code which reads or writes files created by Jonathan Shewchuk's triangle() program.
  2390. triangle_io_test
  2391. triangle_lyness_rule, a MATLAB code which returns a Lyness-Jespersen quadrature rule over the interior of a triangle in 2D;
  2392. triangle_lyness_rule_test
  2393. triangle_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate an integral over the interior of a general triangle in 2D.
  2394. triangle_monte_carlo_test
  2395. triangle_quadrature_symmetry, a MATLAB code which determines the symmetries of a quadrature rule for a triangle.
  2396. triangle_quadrature_symmetry_test
  2397. triangle_refine, a MATLAB code which divides a triangle into c^2 copies of itself, and implements a simple centroid-based quadrature scheme.
  2398. triangle_refine_test
  2399. triangle_svg, a MATLAB code which uses Scalable Vector graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
  2400. triangle_svg_test
  2401. triangle_symq_rule, a MATLAB code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle, by Hong Xiao and Zydrunas Gimbutas.
  2402. triangle_symq_rule_test
  2403. triangle_symq_rule_convert a MATLAB code which takes quadrature rules for the equilateral triangle and converts them to the reference triangle (0,0), (1,0), (0,1).
  2404. triangle_symq_rule_old, a MATLAB code which is based on the original Fortran77 code, which uses an equilateral triangle as the reference element, by Hong Xiao and Zydrunas Gimbutas.
  2405. triangle_symq_rule_old_test
  2406. triangle_symq_to_ref, a MATLAB code which creates quadrature rules defined on the half-unit square from symmetric quadrature rules defined on an equilateral triangle, defined by triangle_symq_rule(), by Hong Xiao and Zydrunas Gimbutas.
  2407. triangle_symq_to_ref_test
  2408. triangle_to_fem, a MATLAB code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
  2409. triangle_to_fem_test
  2410. triangle_to_medit, a MATLAB code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
  2411. triangle_to_medit_test
  2412. triangle_to_xml, a MATLAB code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh in 2D, and writes a corresponding XML mesh file for use by dolfin() or fenics().
  2413. triangle_to_xml_test
  2414. triangle_twb_rule, a MATLAB code which generates the points and weights of quadrature rules over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
  2415. triangle_twb_rule_test
  2416. triangle_wandzura_rule, a MATLAB code which returns quadrature rules of exactness 5, 10, 15, 20, 25 and 30 over the interior of the triangle in 2D.
  2417. triangle_wandzura_rule_test
  2418. triangle_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
  2419. triangle_witherden_rule_test
  2420. triangle01_integrals, a MATLAB code which returns the integral of any monomial over the interior of the unit triangle in 2D.
  2421. triangle01_integrals_test
  2422. triangle01_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate an integral over the interior of the unit triangle in 2D.
  2423. triangle01_monte_carlo_test-
  2424. triangulate, a MATLAB code which triangulates a polygonal region, based on a C program by Joseph ORourke;
  2425. triangulate_test
  2426. triangulate_rectangle, a MATLAB code which sets up a grid of triangles in a rectangular region.
  2427. triangulate_rectangle_test
  2428. triangulation, a MATLAB code which computes the triangulation of a set of points in the plane, and performs various operations using a triangulation, including searching a Delaunay triangulation to find which triangle contains a given point.
  2429. triangulation_test
  2430. triangulation_boundary, a MATLAB code which starts with a triangulation of a simple shape, and determines the triangle edges that form the boundary, and a sequence of nodes that trace the boundary.
  2431. triangulation_boundary_test
  2432. triangulation_boundary_edges, a MATLAB code which reads data defining a triangulation, determines which edges lie on the boundary, organizes them into connected components, and writes this information to a file.
  2433. triangulation_boundary_edges_test
  2434. triangulation_boundary_nodes, a MATLAB code which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file;
  2435. triangulation_boundary_nodes_test
  2436. triangulation_delaunay_discrepancy, a MATLAB code which measures the amount by which a triangulation fails the local Delaunay test;
  2437. triangulation_delaunay_discrepancy_test
  2438. triangulation_display, a MATLAB code which displays the nodes and elements of a triangulation;
  2439. triangulation_display_test
  2440. triangulation_node_to_element, a MATLAB code which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an order1 finite element model of the data.
  2441. triangulation_node_to_element_test
  2442. triangulation_order1_display, a MATLAB code which plots piecewise constant (PWC) data associated with a triangulation;
  2443. triangulation_order1_display_test
  2444. triangulation_order3_contour, a MATLAB code which plots color contours of a piecewise linear (PWL) scalar quantity evaluated at the nodes of a 3-node triangle triangulation.
  2445. triangulation_order3_contour_test
  2446. triangulation_order6_contour, a MATLAB code which plots color contours of a piecwise quadratic (PWQ) scalar quantity evaluated at the nodes of a 6-node triangle triangulation.
  2447. triangulation_order6_contour_test
  2448. triangulation_plot, a MATLAB code which plots the nodes and elements of a triangulation as a PostScript file;
  2449. triangulation_plot_test
  2450. triangulation_quad, a MATLAB code which reads information about a triangulation and the value of a function at the nodes and estimates the integral of the function over the triangulated region.
  2451. triangulation_quad_test
  2452. triangulation_quality, a MATLAB code which reads information about a triangulation and computes various quality measures;
  2453. triangulation_quality_test
  2454. triangulation_refine, a MATLAB code which refines a triangulation;
  2455. triangulation_refine_test
  2456. triangulation_refine_local, a MATLAB code which refines a triangulation locally; a single triangular element is replaced by four smaller triangles, and neighboring information is updated.
  2457. triangulation_refine_local_test
  2458. triangulation_svg, a MATLAB code which creates a Scalable Vector graphics (SVG) image of a triangulation, which can be displayed by a web browser.
  2459. triangulation_svg_test
  2460. triangulation_triangle_neighbors, a MATLAB code which reads data defining a triangulation, finds the three neighbor triangles for each triangle, and writes them to a file;
  2461. triangulation_triangle_neighbors_test
  2462. tridiagonal_solver, a MATLAB code which solves a tridiagonal linear system.
  2463. tridiagonal_solver_test
  2464. trig_interp, a MATLAB code which uses trigonometric functions for interpolation.
  2465. trig_interp_test
  2466. trig_interp_basis, a MATLAB code which evaluates the cardinal basis functions for trigonometric interpolation of equally spaced data.
  2467. trig_interp_basis_test
  2468. trinity, a MATLAB code which considers the trinity puzzle, a smaller version of the eternity puzzle. The trinity puzzle specifies a region R composed of 144 30-60-90 triangles, and a set of 4 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  2469. trinity_test
  2470. trinity_cplex_test a BASH code which calls cplex(), to read the LP file defining the trinity tiling problem, solve the linear programming problem, and write the solution to a file.
  2471. trinity_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the trinity tiling problem, solve the linear programming problem, and write the solution to a file.
  2472. trinity_scip_test a BASH code which calls scip(), to read the LP file defining the trinity tiling problem, solve the linear programming problem, and write the solution to a file.
  2473. truel_simulation, a MATLAB code which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
  2474. truel_simulation_test
  2475. truncated_normal, a MATLAB code which works with the truncated normal distribution over [a,b], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
  2476. truncated_normal_test
  2477. truncated_normal_rule, a MATLAB code which computes a quadrature rule for a normal probability density function (PDF), sometimes called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [a,b].
  2478. truncated_normal_rule_test
  2479. truncated_normal_sparse_grid, a MATLAB code which computes a sparse grid based on a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [a,+oo), (-oo,b] or [a,b].
  2480. truncated_normal_sparse_grid_test
  2481. tsp_brute, a MATLAB code which is given a table of city-to-city distances and solves a (small!) traveling salesperson problem (TSP), using brute force.
  2482. tsp_brute_test
  2483. tsp_descent, a MATLAB code which is given a table of city-to-city distances, chooses an initial tour at random, and then tries some simple variations to quickly find a tour of lower length, to solve the traveling salesperson problem (TSP).
  2484. tsp_descent_test
  2485. tsp_greedy, a MATLAB code which is given a table of city-to-city distances, and solves a small traveling salesperson problem (TSP) using the greedy algorithm. It picks a starting city at random, and then successively visits the nearest unvisited city.
  2486. tsp_greedy_test
  2487. tsp_moler, a MATLAB code which tries to optimize the traveling salesperson problem (TSP), written by Cleve Moler.
  2488. tsp_moler_test
  2489. tsp_random, a MATLAB code which seeks a solution of the Traveling Salesperson Problem (TSP), by accepting a table of city-to-city distances, and randomly generating round trips that visit every city, returning the tour of shortest length.
  2490. tsp_random_test
  2491. tumor_pde, a MATLAB code which solves the tumor angiogenesis partial differential equations (PDE) using MATLAB's pdepe() function.
  2492. tumor_pde_test
  2493. two_body_ode, a MATLAB code which sets up and solves ordinary differential equations (ODE) which simulate the behavior of two bodies, constrained to lie in a plane, moving under the influence of gravity, with one body much more massive than the other.
  2494. two_body_ode_test
  2495. ubvec, a MATLAB code which demonstrates how nonnegative integers can be stored as unsigned binary vectors, and arithmetic can be performed on them.
  2496. ubvec_test
  2497. ulam_spiral, a MATLAB code which displays the integers as a spiral of grid cells, with the primes highlighted, so show that they tend to fall along diagonals, as discovered by Stanislaw Ulam.
  2498. ulam_spiral_test
  2499. unicycle, a MATLAB code which considers permutations containing a single cycle, sometimes called cyclic permutations.
  2500. unicycle_test
  2501. uniform, a MATLAB code which implements a uniform random number generator (RNG) for a variety of arithmetic types.
  2502. uniform_test
  2503. unstable_ode, a MATLAB code which sets up and solves an unstable ordinary differential equation (ODE) which the backward Euler method incorrectly drives to zero.
  2504. unstable_ode_test
  2505. upc, a MATLAB code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
  2506. upc_test
  2507. urn_simulation, a MATLAB code which simulates the experiment of sampling K balls from an urn containing N balls of various colors.
  2508. urn_simulation_test
  2509. usa_box_plot, a MATLAB code which creates simplified maps of the USA in which each state appears as a box, and the placement of the boxes only roughly corresponds to the relative locations of states on an accurate map.
  2510. usa_box_plot_test
  2511. usa_cvt_geo, a MATLAB code which explores the creation of a centroidal Voronoi Tessellation (CVT) of the continental United States, based solely on geometric considerations.
  2512. usa_cvt_geo_test
  2513. usa_matrix, a MATLAB code which defines the adjacency matrix for US states, using a variety of matrix formats.
  2514. usa_matrix_test
  2515. van_der_corput, a MATLAB code which computes elements of the van der Corput 1-dimensional Quasi Mont Carlo (QMC) sequence, using a simple interface.
  2516. van_der_corput_test
  2517. vandermonde, a MATLAB code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.
  2518. vandermonde_test
  2519. vandermonde_approx_1d, a MATLAB code which finds a polynomial approximant to data y(x) of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  2520. vandermonde_approx_1d_test
  2521. vandermonde_approx_2d, a MATLAB code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  2522. vandermonde_approx_2d_test
  2523. vandermonde_interp_1d, a MATLAB code which finds a polynomial interpolant to data y(x) of a 1D argument by solving a linear system for the polynomial coefficients involving the Vandermonde matrix.
  2524. vandermonde_interp_1d_test
  2525. vandermonde_interp_2d, a MATLAB code which finds a polynomial interpolant to data z(x,y) of a 2D argument by solving a linear system for the polynomial coefficients involving the Vandermonde matrix.
  2526. vandermonde_interp_2d_test
  2527. vanderpol_ode, a MATLAB code which sets up and solves the van der Pol system of ordinary differential equations (ODE), for which a limit cycle exists.
  2528. vanderpol_ode_test
  2529. vanderpol_ode_period, a MATLAB code which sets up and solves the ordinary differential equations (ODE) defining the van der Pol oscillator in order to estimate the period of the limit cycle.
  2530. vanderpol_ode_period_test
  2531. variomino, a MATLAB code which considers variominoes, which are polyominoes in which each square has been assigned a positive label or "variety", and the determination of tilings of a region using a specific set of variominoes.
  2532. variomino_test
  2533. vector, a MATLAB code which considers a problem involving vectors, which can be considered to belong to equivalence classes, for which an arbitrary collection of coefficients must be gathered, averaged, and then scattered again.
  2534. vector_test
  2535. velocity_verlet, a MATLAB code which uses a version of the velocity Verlet method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
  2536. velocity_verlet_test
  2537. verlet_simulation, a MATLAB code which demonstates the use of Verlet integration to simulate simple problems in dynamics, involving changes in position and velocity.
  2538. verlet_simulation_test
  2539. vin, a MATLAB code which computes the check digit for a Vehicle Identification Number (VIN), or verifies that a given VIN is legitimate.
  2540. vin_test
  2541. voronoi_city, a MATLAB code which displays the steps involved in computing the Voronoi diagram of 3 points, which we think of as cities connected by roads.
  2542. voronoi_city_test
  2543. voronoi_display, a MATLAB code which computes and displays the Voronoi diagram of a set of points.
  2544. voronoi_display_test
  2545. voronoi_mountains, a MATLAB code which makes a mountain plot of a Voronoi diagram, that is, a surface plot of the distance from each point to its nearest Voronoi generator.
  2546. voronoi_mountains_test
  2547. voronoi_neighbors, a MATLAB code which is given a set of points in the plane and determines the Voronoi adjacency structure, that is, the points which share an edge of the Voronoi diagram.
  2548. voronoi_neighbors_test
  2549. voronoi_plot, a MATLAB code which estimates the Voronoi neighborhoods of points using sampling, and with a distance based on the L1, L2, LInfinity or arbitrary LP norms;
  2550. voronoi_plot_test
  2551. voronoi_test, a MATLAB code which calls the built-in voronoi() function, which computes the Voronoi diagram of a set of points.
  2552. vpa_test, a MATLAB code which uses the Variable Precision Arithmetic (VPA) feature of the Symbolic Math Toolbox to compute arbitrary precision quantities.
  2553. walker_sample, a MATLAB code which efficiently samples a discrete probability vector using Walker sampling.
  2554. walker_sample_test
  2555. walsh_transform, a MATLAB code which implements the Walsh data transform.
  2556. walsh_transform_test
  2557. wathen_matrix, a MATLAB code which compares storage schemes (full, banded, sparse triplet, sparse) and solution strategies (A\x, Linpack, conjugate gradient) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).
  2558. wathen_matrix_test
  2559. wave_pde, a MATLAB code which uses the finite difference method (FDM) in space, and the method of lines in time, to set up and solve the partial differential equations (PDE) known as the wave equations, utt = c uxx.
  2560. wave_pde_test
  2561. wavelet, a MATLAB code which does some simple calculations with wavelet transforms;
  2562. wavelet_test
  2563. web_matrix, a MATLAB code which stores sample matrices describing a web page network. These matrices are typically very sparse, and the examples here are stored using the sparse triplet (ST) format. They can be used to demonstrate pagerank and other graph algorithms.
  2564. web_matrix_test
  2565. wedge_exactness, a MATLAB code which investigates the polynomial exactness of a quadrature rule over the interior of the unit wedge in 3D.
  2566. wedge_exactness_test
  2567. wedge_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
  2568. wedge_felippa_rule_test
  2569. wedge_grid, a MATLAB code which computes a grid of points over the interior of the unit wedge in 3D.
  2570. wedge_grid_test
  2571. wedge_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
  2572. wedge_integrals_test
  2573. wedge_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate an integral over the interior of the unit wedge in 3D.
  2574. wedge_monte_carlo_test
  2575. weekday, a MATLAB code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.
  2576. weekday_test
  2577. weekday_zeller, a MATLAB code which uses the Zeller congruence to determine the day of the week corresponding to a given date, such as 13 July 1989, Gregorian calendar, ... which was a Thursday.
  2578. weekday_zeller_test
  2579. welzl, a MATLAB code which computes the minimal bounding circle or sphere for a set of points, using algorithms by Welzl or Ritter, by Anton Semechko.
  2580. welzl_test
  2581. whale, a MATLAB code which considers the whale tiling puzzle, a smaller version of the eternity puzzle. The whale puzzle specifies a region R composed of 288 30-60-90 triangles, and a set of 8 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
  2582. whale_test
  2583. whale_cplex_test a BASH code which calls cplex(), to read the LP file defining the whale tiling problem, solve the linear programming problem, and write the solution to a file.
  2584. whale_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the whale tiling problem, solve the linear programming problem, and write the solution to a file.
  2585. will_you_be_alive, a MATLAB code which carries out the probability simulations described in "Will You Be Alive 10 Years From Now?" by Paul Nahin;
  2586. will_you_be_alive_test
  2587. wishart_matrix, a MATLAB code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
  2588. wishart_matrix_test
  2589. wtime, a MATLAB code which returns a reading of the wall clock time in seconds.
  2590. wtime_test
  2591. xml2struct, a MATLAB code which reads a file containing XML data, and produces a corresponding MATLAB struct.
  2592. xml2struct_test
  2593. zero, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x)=0, by Richard Brent.
  2594. zero_test
  2595. zero_itp, a MATLAB code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
  2596. zero_itp_test
  2597. zero_rc, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Richard Brent.
  2598. zero_rc_test
  2599. ziggurat, a MATLAB code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
  2600. ziggurat_test
  2601. zombie_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) for a generalized Susceptible-Infected-Recovered (SIR) disease model to simulate a zombie attack, developed by Philip Munz.
  2602. zombie_ode_test

Last revised on 02 March 2024.