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) du/dt = nu * uxx - u * (u^2-1) / (2*xi) in 1 space dimension and time.
  4. allen_cahn_pde_test
  5. allen_cahn_pde_etdrk4 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. animation_test, a MATLAB code which demonstrates how to create an animation in the form of a GIF.
  14. anishchenko_ode, a MATLAB code which sets up and solves the Anishchenko ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  15. anishchenko_ode_test
  16. annulus_distance, a MATLAB code which estimates the typical distance between a pair of points randomly selected inside a circular annulus.
  17. annulus_distance_test
  18. annulus_grid, a MATLAB code which computes a grid of points over the interior of a circular annulus.
  19. annulus_grid_test
  20. 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.
  21. annulus_integrals_test
  22. 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.
  23. annulus_monte_carlo_test
  24. 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.
  25. annulus_rule_test
  26. aperiodic_tile, a MATLAB code which constructs several steps in the aperiodic tiling of the plane, using the monotile T(1,1), displaying the result graphically, by Henning Voss.
  27. aperiodic_tile_test
  28. approx_bernstein, a MATLAB code which interactively approximates a function f(x) in the interval [a,b] by constructing a Bernstein polynomial.
  29. approx_bernstein_test
  30. 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.
  31. approx_chebyshev_test
  32. 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.
  33. approx_leastsquares_test
  34. arclength, a MATLAB code which estimates the arclength of curves of the form (x,f(x)) or (x(t),y(t)).
  35. arclength_test
  36. area_under_curve, a MATLAB code which displays the area under a curve, that is, the points (x,y) between the X axis and the curve Y=F(X).
  37. area_under_curve_test
  38. 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.
  39. arenstorf_ode_test
  40. args, a function which shows how to count and report command line arguments;
  41. args_test
  42. arneodo_ode, a MATLAB code which sets up and solves the Arneodo ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  43. arneodo_ode_test
  44. arpack_test, a MATLAB code which calls arpack(), which computes eigenvalues and eigenvectors of large sparse matrices, accessible via the built-in eigs() command;
  45. artery_pde, a MATLAB code which solves a partial differential equation (PDE) that models the displacement of arterial walls under pressure.
  46. artery_pde_test
  47. asa_geometry_2011, 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.
  48. asa_2011_geometry_test
  49. asa_graphs_2011, 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.
  50. asa_images_2011, 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.
  51. 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;
  52. asa005_test
  53. 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;
  54. asa006_test
  55. 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.
  56. asa007_test
  57. asa032, a MATLAB code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
  58. asa032_test
  59. 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.
  60. asa047_test
  61. 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.
  62. asa053_test
  63. asa058, a MATLAB code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
  64. asa058_test
  65. 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.
  66. asa063_test
  67. 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.
  68. asa066_test
  69. 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.
  70. asa076_test
  71. 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.
  72. asa082_test
  73. 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.
  74. asa091_test
  75. asa103, a MATLAB code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
  76. asa103_test
  77. asa109, a MATLAB code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
  78. asa109_test
  79. 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.
  80. asa111_test
  81. 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.
  82. asa113_test
  83. asa121, a MATLAB code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
  84. asa121_test
  85. asa136, a MATLAB code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
  86. asa136_test
  87. asa144, a MATLAB code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
  88. asa144_test
  89. asa147, a MATLAB code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
  90. asa147_test
  91. 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.
  92. asa152_test
  93. asa159, a MATLAB code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
  94. asa159_test
  95. 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;
  96. asa172_test
  97. asa183, a MATLAB code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
  98. asa183_test
  99. 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.
  100. asa226_test
  101. asa239, a MATLAB code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
  102. asa239_test
  103. 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.
  104. asa241_test
  105. 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.
  106. asa243_test
  107. asa245, a MATLAB code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
  108. asa245_test
  109. asa266, a MATLAB code which evaluates various properties of the Dirichlet Probability Density Function (PDF); This is a version of Applied Statistics Algorithm 266.
  110. asa266_test
  111. 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;
  112. asa299_test
  113. 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.
  114. asa310_test
  115. 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;
  116. asa314_test
  117. atbash, a MATLAB code which applies the Atbash substitution cipher to a string of text.
  118. atbash_test
  119. atkinson, a MATLAB code which contains examples from the text 'Elementary Numerical Analysis', by Atkinson.
  120. atkinson_test
  121. autocatalytic_ode, a MATLAB code which sets up and solves the autocatalytic ordinary differential equation (ODE), which has chaotic behavior and an attractor.
  122. autocatalytic_ode_test
  123. axon_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) for the Hodgkin-Huxley model of an axon.
  124. axon_ode_test
  125. backtrack_binary_rc, a MATLAB code which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).
  126. backtrack_binary_rc_test
  127. 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.
  128. backward_euler_test
  129. 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.
  130. backward_euler_fixed_test
  131. ball_and_stick_display, a MATLAB code which demonstrates the creation of a 3D ball and stick image;
  132. ball_and_stick_display_test
  133. 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.
  134. ball_distance_test
  135. ball_grid, a MATLAB code which computes a grid of points over the interior of the unit ball in 3D.
  136. ball_grid_test
  137. 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.
  138. ball_integrals_test
  139. 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;
  140. ball_monte_carlo_test
  141. 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.
  142. ball_positive_distance_test
  143. 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.
  144. bank_test
  145. 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.
  146. barycentric_interp_1d_test
  147. basketball_dynamic, a MATLAB code which uses dynamic programming to count the ways of achieving a given score in basketball, respecting the order of events.
  148. basketball_dynamic_test
  149. bdf2, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF), using fsolve() to solve the implicit equation.
  150. bdf2_test
  151. bdf3, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 3 (BDF), using fsolve() to solve the implicit equation.
  152. bdf3_test
  153. 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.
  154. bellman_ford_test
  155. bernstein_approximation, a MATLAB code which looks at some simple cases of approximation of a function f(x) by a Bernstein polynomial.
  156. bernstein_approximation_test
  157. bernstein_polynomial, a MATLAB code which evaluates the Bernstein polynomials;
  158. bernstein_polynomial_test
  159. besselj, a MATLAB code which evaluates Bessel J functions of noninteger order;
  160. besselj_test
  161. besselj_zero, a MATLAB code which computes zeros of any Bessel j function of integer order n.
  162. besselj_zero_test
  163. besselzero, a MATLAB code which computes the zeros of Bessel j and y functions, by Greg van Winckel and Jason Nicholson.
  164. besselzero_test
  165. beta_nc, a MATLAB code which evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
  166. beta_nc_test
  167. bezier_surface, a MATLAB code which reads, writes, prints and manipulates the data that defines a Bezier surface;
  168. bezier_surface_test
  169. bezier_surface_display, a MATLAB code which displays a Bezier surface;
  170. bezier_surface_display_test
  171. bicg, a MATLAB code which implements the biconjugate gradient method (BICG), which estimates the solution of a large sparse nonsymmetric linear system.
  172. bicg_test
  173. b1g3, a MATLAB code which solves one or more ordinary differential equations (ODE) with the b1g3 method, using fsolve() to solve the implicit equation.
  174. b1g3_test
  175. 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.
  176. biharmonic_cheby1d_test
  177. biharmonic_exact, a MATLAB code which evaluates exact solutions w(x,y) to the biharmonic equation del^2 w = 0 or wxxxx + 2 wxxyy + wyyyy = 0
  178. biharmonic_exact_test
  179. 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.
  180. biharmonic_fd1d_test
  181. biharmonic_fd2d, a MATLAB code which deals with the biharmonic equation in two dimensions, whose simplest form is uxxxx + 2uxxyy + uyyyy = f.
  182. biharmonic_fd2d_test
  183. biochemical_linear_ode, a MATLAB code which sets up and solves a linear biochemical ordinary differential equation (ODE).
  184. biochemical_linear_ode_test
  185. biochemical_nonlinear_ode, a MATLAB code which sets up and solves a nonlinear biochemical ordinary differential equation (ODE).
  186. biochemical_nonlinear_ode_test
  187. 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.
  188. bioconvection_ode_test
  189. bird_egg, a MATLAB code which evaluates some formulas for the shapes of bird eggs.
  190. bird_egg_test
  191. 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.
  192. bisection_test
  193. 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].
  194. bisection_integer_test
  195. 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).
  196. bisection_rc_test
  197. black_scholes, a MATLAB code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
  198. black_scholes_test
  199. blend, a MATLAB code which carries out 1D/2D/3D blending interpolation;
  200. blend_test
  201. 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.
  202. blood_pressure_ode_test
  203. 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.
  204. blowup_ode_test
  205. 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.
  206. boat_test
  207. 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.
  208. 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.
  209. 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.
  210. boomerang_test
  211. 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.
  212. 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).
  213. boundary_locus_test
  214. 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.
  215. boundary_locus2_test
  216. boundary_word_drafter, a MATLAB code which describes the outline of an object using a string of symbols that represent the sequence of steps tracing out the boundary, on a grid of drafters, or 30-60-90 triangles. The objects include tiles for the eternity, serenity and trinity puzzles, and the hat and turtle aperiodic monotiles.
  217. boundary_word_drafter_test
  218. 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.
  219. boundary_word_equilateral_test
  220. 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.
  221. boundary_word_hexagon_test
  222. 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.
  223. boundary_word_right_test
  224. 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.
  225. boundary_word_square_test
  226. 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;
  227. box_behnken_test
  228. box_display, a MATLAB code which displays a box plot, over integer pairs of data, of a function defined by two formulas.
  229. box_display_test
  230. 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.
  231. box_distance_test
  232. box_flow, a MATLAB code which solves the Navier Stokes equations (NSE) in a 2D rectangular region, replacing the continuity equation with a pressure Poisson equation (PPE), by John Cornthwaite.
  233. box_flow_test
  234. box_games, a MATLAB code which assists in the display of game boards (checkers, cellular automatons, Conway's game of life);
  235. box_games_test
  236. box_plot, a MATLAB code which displays a box plot of data that consists of pairs of integers;
  237. box_plot_test
  238. brc_data, a MATLAB code which creates a file of randomly generated temperature readings to be associated with weather stations at 413 world cities. A file like this, with 1 billion records, is used for the billion record challenge (BRC).
  239. brc_data_test
  240. brc_naive, a MATLAB code which reads a file of randomly generated temperature readings, associated with weather stations at 413 world cities, and computes the minimum, mean, and maximum temperature for each weather station. It also reports the total execution time. Processing such a data file with one billion records is the substance of the billion record challenge (BRC).
  241. brc_naive_test
  242. brownian_motion_simulation, a MATLAB code which simulates Brownian motion in an M dimensional region.
  243. brownian_motion_simulation_test
  244. broyden, a MATLAB code which implements the Broyden iterative method for nonlinear equations, by Tim Kelley.
  245. broyden_test
  246. brusselator_ode, a MATLAB code which sets up and solves the Brusselator ordinary differential equation (ODE) system.
  247. brusselator_ode_test
  248. buckling_spring, a MATLAB code which plots solutions of the buckling spring equations.
  249. buckling_spring_test
  250. 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.
  251. burgers_pde_etdrk4_test
  252. burgers_exact, a MATLAB code which evaluates exact solutions of the time-dependent 1D viscous Burgers equation.
  253. burgers_exact_test
  254. 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.
  255. burgers_steady_viscous_test
  256. 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.
  257. burgers_time_inviscid_test
  258. 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.
  259. burgers_time_viscous_test
  260. bvec, a MATLAB code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
  261. bvec_test
  262. bvp_fd, a MATLAB code which demonstrates the use of the finite difference method (FDM) to solve a boundary value problem (BVP).
  263. bvp_fd_test
  264. bvp_shooting_test, a MATLAB code which demonstrates the use of the shooting method to solve a boundary value problem (BVP).
  265. bvp4c_test, a MATLAB code which calls bvp4c(), which solves boundary value problems (BVP) in one spatial dimension.
  266. bwlabel_test, a MATLAB code which calls bwlabel() or bwlabeln(), which are functions built in to the Image Processing Toolbox. Given a 2D matrix or 3D array of nonzero values, it organizes them into labeled components, using connectivity 4 or 8 (2D) or 6, 18 or 26 (3D).
  267. c8lib, a MATLAB code which implements certain elementary functions for complex 64 bit ("C8") variables;
  268. c8lib_test
  269. caesar, a MATLAB code which applies a Caesar Shift Cipher to a string of text.
  270. caesar_test
  271. calendar_nyt, a MATLAB code which shows the correspondence between dates and the New York Times volume and issue number;
  272. calendar_nyt_test
  273. california_migration, a MATLAB code which runs a simple linear model of migration between California and the rest of the US, based on data from 1960. The point of the code is to illustrate the use of a matrix model for population exchange.
  274. california_migration_test
  275. 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.
  276. calpak_test
  277. candy_count, a MATLAB code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
  278. candy_count_test
  279. 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.
  280. 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.
  281. 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?
  282. casino_simulation_test
  283. cauchy_method, a MATLAB code which solves one or more ordinary differential equations (ODE) using the Cauchy method.
  284. cauchy_method_test
  285. cauchy_principal_value, a MATLAB code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
  286. cauchy_principal_value_test
  287. 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.
  288. caustic_test
  289. cavity_flow_display, a MATLAB code which displays a single velocity field solution for the driven cavity;
  290. cavity_flow_display_test
  291. cavity_flow_movie, a MATLAB code which animates the velocity solutions for the driven cavity;
  292. cavity_flow_movie_test
  293. cc_display, a MATLAB code which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
  294. cc_display_test
  295. cc_project, a MATLAB code which computes generalized Clenshaw-Curtis quadrature rules for semi-infinite and infinite intervals, by John Boyd.
  296. cc_project_test
  297. 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.
  298. ccn_rule, a MATLAB code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
  299. ccn_rule_test
  300. ccs_io a MATLAB code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
  301. ccs_io_test
  302. ccs_to_st a MATLAB code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
  303. ccs_to_st_test
  304. 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;
  305. ccvt_reflect_test
  306. cell, a MATLAB code which defines a cell array, a generalization of an array which compactly stores and retrieves vector or matrix data of varying size, such as the rows of a triangular matrix.
  307. cell_test
  308. cellular_automaton, a MATLAB code which prints or plots the evolution of Cellular Automaton rule #30.
  309. cellular_automaton_test
  310. 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).
  311. cg_test
  312. cg_lab_triangles, a MATLAB code which was a computer lab assignment on computational geometry and triangles;
  313. cg_lab_triangles_test
  314. 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.
  315. cg_ne_test
  316. 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).
  317. cg_rc_test
  318. cg_squared, a MATLAB code which implements the conjugate gradient squared (CGS) method for solving a nonsymmetric sparse linear system A*x=b.
  319. cg_squared_test
  320. 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.
  321. 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.
  322. change_diophantine_test
  323. 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.
  324. change_dynamic_test
  325. 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.
  326. change_greedy_test
  327. 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.
  328. change_polynomial_test
  329. chebyshev, a MATLAB code which computes the Chebyshev interpolant/approximant to a given function over an interval.
  330. chebyshev_test
  331. 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).
  332. chebyshev_interp_1d_test
  333. chebyshev_matrix, a MATLAB code which defines the Chebyshev differentiation matrix, by Lloyd Trefethen.
  334. chebyshev_matrix_test
  335. chebyshev_polynomial, a MATLAB code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x).
  336. chebyshev_polynomial_test
  337. 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.
  338. chebyshev_series_test
  339. chebyshev1_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Chebyshev type 1 quadrature rules.
  340. chebyshev1_exactness_test
  341. chebyshev1_rule, a MATLAB code which computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
  342. chebyshev1_rule_test
  343. chebyshev2_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Chebyshev type 2 quadrature rules.
  344. chebyshev2_exactness_test
  345. chebyshev2_rule, a MATLAB code which computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
  346. chebyshev2_rule_test
  347. chen_ode, a MATLAB code which sets up and solves the Chen system of ordinary differential equations (ODE).
  348. chen_ode_test
  349. cheney_kincaid, a MATLAB code which contains examples from the text 'Numerical Mathematics and Computing', by Cheney and Kincaid.
  350. cheney_kincaid_test
  351. 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.
  352. chinese_remainder_theorem_test
  353. chirikov_iteration, a MATLAB code which applies the Chirikov map repeatedly to a given (x,y) initial condition.
  354. chirikov_iteration_test
  355. chladni_figures, a MATLAB code which creates Chladni figures of the eigenmodes of a thin vibrating plate, by Martin Gander and Felix Kwok.
  356. chladni_figures_test
  357. 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.
  358. chrominoes_test
  359. chrpak, a MATLAB code which manipulates characters and strings;
  360. chrpak_test
  361. chuckaluck_simulation, a MATLAB code which simulates the Chuck-a-Luck gambling game.
  362. chuckaluck_simulation_test
  363. circle_arc_grid, a MATLAB code which computes grid points along a circular arc.
  364. circle_arc_grid_test
  365. circle_circles_packing, a MATLAB code which tries to randomly pack as many non-overlapping circles of equal size into a larger circle, with a typical final coverage density of about 0.547. This is an example of random sequential adsorption (RSA).
  366. circle_circles_packing_test
  367. 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.
  368. circle_distance_test
  369. circle_grid_display a MATLAB code which reads a matrix of integers, and draws a corresponding grid of circles filled with color.
  370. circle_grid_display_test
  371. 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.
  372. circle_integrals_test
  373. circle_map, a MATLAB code which illustrates how a matrix maps points on the unit circle to an ellipse.
  374. circle_map_test
  375. 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;
  376. circle_monte_carlo_test
  377. 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.
  378. circle_positive_distance_test
  379. 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).
  380. circle_rule_test
  381. circle_segment, a MATLAB code which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.
  382. circle_segment_test
  383. circles, a MATLAB code which draws one or more circles, while controlling the center locations, radii, colors, edge colors, and transparency, by Chad Greene.
  384. circles_test
  385. cities, a MATLAB code which works with city-to-city distance matrices;
  386. cities_test
  387. clausen, a MATLAB code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
  388. clausen_test
  389. clenshaw_curtis_rule, a MATLAB code which implements a Clenshaw Curtis quadrature rule;
  390. clenshaw_curtis_rule_test
  391. 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.
  392. clock_solitaire_simulation_test
  393. closest_pair_brute, a MATLAB code which uses brute force to solve a 2D version of the closest pair problem.
  394. closest_pair_brute_test
  395. closest_pair_divcon, a MATLAB code which uses a divide and conquer approach to solve a 2D version of the closest pair problem.
  396. closest_pair_divcon_test
  397. closest_point_brute, a MATLAB code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
  398. closest_point_brute_test
  399. cnoise, a MATLAB code which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
  400. cnoise_test
  401. cobweb_plot, a MATLAB code which displays a cobweb plot illustrating the process of function iteration.
  402. cobweb_plot_test
  403. coin_simulation, a MATLAB code which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.
  404. coin_simulation_test
  405. collatz, a MATLAB code which computes and analyzes the Collatz sequence, also known as the hailstone sequence or 3n+1 sequence;
  406. collatz_test
  407. collatz_parfor, a MATLAB code using the parfor() statement for parallel execution, to find the longest Collatz sequence in the range 1 through N.
  408. collatz_parfor_test
  409. 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.
  410. collatz_polynomial_test
  411. collatz_recursive, a MATLAB code which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
  412. collatz_recursive_test
  413. 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.
  414. collocation_test
  415. colored_noise, a MATLAB code which generates samples of noise obeying a 1/f^alpha power law.
  416. colored_noise_test
  417. combo, a MATLAB code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
  418. combo_test
  419. companion_matrix, a MATLAB code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
  420. companion_matrix_test
  421. 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.
  422. compass_search_test
  423. complex_numbers_test, a MATLAB code which demonstrates some of the features of using complex numbers.
  424. 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.
  425. components_test
  426. condition, a MATLAB code which implements methods of computing or estimating the condition number of a matrix.
  427. condition_test
  428. 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).
  429. conservation_ode_test
  430. conte_deboor, a MATLAB code which contains examples from the text 'Elementary Numerical Analysis' by Conte and deBoor.
  431. conte_deboor_test
  432. 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.
  433. continuation_test
  434. continued_fraction a MATLAB code which implements some simple algorithms for dealing with simple and generalized continued fractions.
  435. continued_fraction_test
  436. continuity_exact, a MATLAB code which returns a 2D velocity vector field (u,v)(x,y) which is an exact solution of the partial differential equation (PDE) sometimes called the continuity equation of fluid mechanics, which has the form ux + vy = 0.
  437. continuity_exact_test
  438. contour_gradient, a MATLAB code which displays contours and gradient vectors for a function f(x,y).
  439. contour_gradient_test
  440. contour_gradient_3d, a MATLAB code which displays contours and gradient vectors for a function f(x,y) in a 3D display.
  441. contour_gradient_3d_test
  442. contour_sequence4, a MATLAB code which creates images suitable for animation from one XY file and a sequence of u(x,y) data files;
  443. contour_sequence4_test
  444. 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.
  445. control_bio_test
  446. control_bio_homework, a MATLAB code which handles several homework problems for a biological control class.
  447. 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.
  448. 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.
  449. convergence, a MATLAB code which is given a sequence of approximation errors and estimates the order of convergence, assuming the results correspond to a a sequence of decreasing mesh sizes h, or increasing mesh counts n.
  450. convergence_test
  451. 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.
  452. coordinate_search, a MATLAB code which seeks the minimizer of a scalar function of several variables, by Jeff Borggaard.
  453. coordinate_search_test
  454. cordic, a MATLAB code which computes a few special functions using the CORDIC algorithm.
  455. cordic_test
  456. correlation, a MATLAB code which contains statistical correlation functions.
  457. correlation_test
  458. cosine_integral, a MATLAB code which evaluates the Cosine Integral, by Shanjie Zhang, Jianming Jin;
  459. cosine_integral_test
  460. cosine_transform, a MATLAB code which demonstrates some simple properties of the discrete cosine transform (DCT).
  461. cosine_transform_test
  462. 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.
  463. counterfeit_detection_test
  464. cplex_solution_read, a MATLAB code which extracts solution data from a cplex() result file.
  465. cplex_solution_read_test
  466. cpr, a MATLAB code which implements the Chebyshev Proxy Rootfinder (CPR) to locate all the real zeros of a smooth real function f(x) within an interval [a,b], by John Boyd.
  467. cpr_test
  468. 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.
  469. craps_simulation_test
  470. cross_chaos, a MATLAB code which creates a dot-plot of an elaborate cross by repeatedly applying a randomized linear transformation to a starting point.
  471. cross_chaos_test
  472. crs_io, a MATLAB code which reads and writes sparse linear systems stored in the Compressed Row Storage (CRS) format.
  473. crs_io_test
  474. 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.
  475. cube_arbq_rule_test
  476. 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.
  477. cube_distance_test
  478. cube_exactness, a MATLAB code which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.
  479. cube_exactness_test
  480. cube_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a cube in 3D.
  481. cube_felippa_rule_test
  482. cube_grid, a MATLAB code which computes a grid of points over the interior of a cube in 3D.
  483. cube_grid_test
  484. 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.
  485. cube_integrals_test
  486. 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.
  487. cube_monte_carlo_test
  488. 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.
  489. cube_surface_distance_test
  490. 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.
  491. cuda_loop_test
  492. cvt, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) in M dimensions;
  493. cvt_test
  494. cvt_1_movie, a MATLAB code which creates a movie of the evolution of a Centroidal Voronoi Tessellation (CVT) in the unit square;
  495. cvt_1_movie_test
  496. 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.
  497. cvt_2_movie_test
  498. cvt_3_movie, a MATLAB code which animates the generation of a Centroidal Voronoi Tessellation (CVT) for the "holey pie" region.
  499. cvt_3_movie_test
  500. 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;
  501. cvt_4_movie_test
  502. 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.
  503. cvt_1d_lloyd_test
  504. 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.
  505. cvt_1d_lumping_test
  506. 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;
  507. cvt_1d_nonuniform_test
  508. 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.
  509. cvt_1d_sampling_test
  510. 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.
  511. cvt_2d_lumping_test
  512. 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.
  513. cvt_2d_sampling_test
  514. 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.
  515. cvt_3d_lumping_test
  516. 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.
  517. cvt_3d_sampling_test
  518. 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.
  519. cvt_basic_test
  520. cvt_box, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) constrained to a box region, with points projected to the boundary;
  521. cvt_box_test
  522. cvt_circle_nonuniform, a MATLAB code which demonstrates the computation of a centroidal Voronoi Tessellation (CVT) over a circular region, using a nonuniform density.
  523. cvt_circle_nonuniform_test
  524. cvt_circle_uniform, a MATLAB code which computes a centroidal Voronoi Tessellation (CVT) over a circular region, using a uniform density.
  525. cvt_circle_uniform_test
  526. 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.
  527. cvt_corn_test
  528. 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).
  529. cvt_corn_movie_test
  530. cvt_ellipse_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over an ellipse, with a uniform density.
  531. cvt_ellipse_uniform_test
  532. cvt_metric, a MATLAB code which computes a Centroidal Voronoi Tessellation (CVT) under a spatially varying metric;
  533. cvt_metric_test
  534. cvt_square_nonuniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a nonuniform density.
  535. cvt_square_nonuniform_test
  536. 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.
  537. cvt_square_pdf_discrete_test
  538. cvt_square_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a uniform density.
  539. cvt_square_uniform_test
  540. cvt_triangle_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a triangle, with a uniform density.
  541. cvt_triangle_uniform_test
  542. 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.
  543. cvtm_1d_test
  544. cvtp, a MATLAB code which creates a periodic Centroidal Voronoi Tessellation (CVTP).
  545. cvtp_test
  546. 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.
  547. cvtp_1d_test
  548. 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.
  549. cycle_brent_test
  550. 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.
  551. cycle_floyd_test
  552. cyclic_reduction, a MATLAB code which solves a tridiagonal linear system using cyclic reduction;
  553. cyclic_reduction_test
  554. delaunay_test, a MATLAB code which calls the built-in delaunay() function, which computes the Delaunay triangulation of a set of points.
  555. 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.
  556. delsq_test
  557. 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.
  558. 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.
  559. dg1d_advection_test
  560. 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.
  561. dg1d_burgers_test
  562. 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.
  563. dg1d_heat_test
  564. 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.
  565. dg1d_maxwell_test
  566. 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.
  567. dg1d_poisson_test
  568. diaphony, a MATLAB code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
  569. diaphony_test
  570. dice_simulation, a MATLAB code which simulates N tosses of M dice, making a histogram of the resulting sums.
  571. dice_simulation_test
  572. dictionary_code, a MATLAB code which demonstates how a text file can be compressed and decompressed using a dictionary code.
  573. dictionary_code_test
  574. 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.
  575. diff_center, a MATLAB code which interactively uses centered differences to estimate the derivative of a function f(x), using a stepsize h.
  576. diff_center_test
  577. diff_forward, a MATLAB code which interactively uses forward differences to estimate the derivative of a function f(x), using a stepsize h.
  578. diff_forward_test
  579. diff2_center, a MATLAB code which interactively uses centered differences to estimate the second derivative of a function f(x), using a stepsize h.
  580. diff2_center_test
  581. differ, a MATLAB code which is given function values at equally spaced locations, and the order of a derivative, and uses the finite difference method (FDM) to compute a linear combination of these function values which approximated that derivative.
  582. differ_test
  583. diffusion_pde, a MATLAB code which solves the diffusion partial differential equation (PDE) dudt = mu * d2udx2 in one spatial dimension and time, with a constant diffusion coefficient mu, and periodic or zero Neumann boundary conditions, using the forward time centered space (FTCS) solver or ode45().
  584. diffusion_pde_test
  585. digital_dice, a MATLAB code which carries out the probability simulations described in "Digital Dice", by Paul Nahin;
  586. digital_dice_test
  587. digraph_adj, a MATLAB code which carries out operations on abstract digraphs, a kind of graph with directed edges, described by an adjacency matrix.
  588. digraph_adj_test
  589. dijkstra, a MATLAB code which implements a simple version of the Dijkstra minimum distance algorithm for graphs.
  590. dijkstra_test
  591. diophantine, a MATLAB code which finds one solution of a Diophantine equation in any number of variables.
  592. diophantine_test
  593. diophantine_nd, a MATLAB code which is given a Diophantine equation in N variables, and returns all nonnegative solutions, or all strictly positive solutions.
  594. diophantine_nd_doc
  595. diophantine_nd_test
  596. dirichlet, a MATLAB code which evaluates the Dirichlet kernel function, sometimes called the periodic sinc function. The function includes a parameter n, normally taken to be an integer. The function is defined by diric(x,n)=sin(0.5*n*x)/n/sin(0.5*x). Sample plots of these functions are made.
  597. dirichlet_test
  598. 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.
  599. discrete_pdf_sample_2d_test
  600. 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.
  601. disk_distance_test
  602. 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.
  603. disk_grid_test
  604. 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.
  605. disk_integrals_test
  606. 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.
  607. disk_monte_carlo_test
  608. 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.
  609. disk_positive_distance_test
  610. disk_rule, a MATLAB code which computes quadrature rules for the general disk in 2D.
  611. disk_rule_test
  612. disk_triangle_picking, a MATLAB code which estimates the expected value of the area of a triangle formed by three randomly selected points in the unit disk.
  613. disk_triangle_picking_test
  614. 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.
  615. disk01_integrals_test
  616. disk01_integrands, a MATLAB code which defines several test integrals over the unit disk, making it possible to check the accuracy of quadrature rules.
  617. disk01_integrands_test
  618. 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;
  619. disk01_monte_carlo_test
  620. disk01_rule, a MATLAB code which computes quadrature rules for the unit disk in 2D.
  621. disk01_rule_test
  622. 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;
  623. disk01_positive_monte_carlo_test
  624. disk01_positive_rule, a MATLAB code which computes quadrature rules for the unit positive disk in 2D.
  625. disk01_positive_rule_test
  626. dist_plot, a MATLAB code which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh() code;
  627. dist_plot_test
  628. distance_to_position, a MATLAB code which estimates the positions of cities which minimizes the discrepancy with a city-to-city distance table.
  629. distance_to_position_test
  630. 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.
  631. distance_to_position_sphere_test
  632. distmesh, a MATLAB code which carries out a method of mesh generation; by Per-Olof Persson and Gilbert Strang.
  633. distmesh_test
  634. distmesh_3d, a MATLAB code which carries out a method of mesh generation in 3D, by Per-Olof Persson and Gilbert Strang.
  635. distmesh_3d_test
  636. divdif, a MATLAB code which creates, prints and manipulates divided difference polynomials from a table of values (x,f(x)). The code can compute the coefficients of the Newton and power sum forms of the interpolating polynomial. It can compute the derivative or antiderivate polynomial. It can compute the form of the Lagrange basis polynomials. It can compute the points and weights for Newton Cotes quadrature rules. It can compute the weights for a Lagrange interpolation scheme.
  637. divdif_test
  638. 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.
  639. doomsday_test
  640. 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.
  641. dosage_ode_test
  642. dot_l2, a MATLAB code which interactively estimates the L2 dot product of two functions: dot_l2(f(x),g(x))_= integral ( a <= x <= b ) f(x) g(x) dx
  643. dot_l2_test
  644. double_c_data, a MATLAB code which generates, plots and writes out 2D data that forms two interlocking "C" shapes.
  645. double_c_data_test
  646. 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.
  647. double_well_ode_test
  648. doughnut_exact, a MATLAB code which evaluates an exact solution of a system of ordinary differential equations (ODE) whose trajectories lie on a torus or doughnut, and for which an exact solution is known.
  649. doughnut_exact_test
  650. doughnut_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) whose trajectories lie on a torus or doughnut, and for which an exact solution is known.
  651. doughnut_ode_test
  652. dragon_chaos, a MATLAB code which creates a dot-plot of a dragon by repeatedly applying a randomized linear transformation to a starting point.
  653. dragon_chaos_test
  654. 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.
  655. dream_test
  656. duel_simulation, a MATLAB code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  657. duel_simulation_test
  658. dueling_idiots, a MATLAB code which carries out the probability simulations described in "Dueling Idiots", by Paul Nahin;
  659. dueling_idiots_test
  660. duffing_ode, a MATLAB code which sets up and solves a second-order ordinary differential equation (ODE) whose solution can exhibit chaotic behavior.
  661. duffing_ode_test
  662. e_spigot, a MATLAB code which produces any number of digits of the decimal expansion of e.
  663. e_spigot_test
  664. earth_sphere, a MATLAB code which displays a 3D image of the earth, including oceans, continents, and topography, by Clay Thompson and Will Campbell.
  665. earth_sphere_test
  666. edge, a MATLAB code which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities.
  667. edge_test
  668. eigenfaces, a MATLAB code which applies principal component analysis (PCA) to a set of images.
  669. eigenfaces_test
  670. eigs_test, a MATLAB code which calls eigs(), which is a built-in system function which computes the eigenvalues and eigenvectors of a matrix.
  671. 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.
  672. elfun_test
  673. 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.
  674. ellipse_test
  675. 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.
  676. ellipse_distance_test
  677. ellipse_grid, a MATLAB code which computes a grid of points over the interior of an ellipse in 2D.
  678. ellipse_grid_test
  679. 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.
  680. ellipse_monte_carlo_test
  681. ellipsoid, a MATLAB code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
  682. ellipsoid_test
  683. ellipsoid_grid, a MATLAB code which computes a grid of points over the interior of an ellipsoid in 3D.
  684. ellipsoid_grid_test
  685. 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.
  686. ellipsoid_monte_carlo_test
  687. elliptic_integral, a MATLAB code which evaluates complete elliptic integrals of first, second and third kind, using the Carlson elliptic integral functions.
  688. elliptic_integral_test
  689. epicycloid, a MATLAB code which computes, plots and tabulates an epicycloid curve.
  690. epicycloid_test
  691. equidistribution, investigates equidistribution properties relating to density functions and point sets.
  692. equidistribution_test
  693. eros, a MATLAB code which implements elementary row operations (EROs) for the interactive solution of a system of linear equations.
  694. eros_test
  695. errors, a MATLAB code which illustrates the failure of numerical algorithms;
  696. errors_test
  697. 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.
  698. eternity_test
  699. eternity_hexity, a MATLAB code which evaluates and manipulates a six-fold parity quantity associated with grids and tiles used in the Eternity puzzle.
  700. eternity_hexity_test
  701. 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, as well as tiles for the serenity and trinity puzzles, and the hat and turtle aperiodic monotile.
  702. eternity_tile_test
  703. euclid, a MATLAB code which investigates various versions of Euclid's algorithm for computing the greatest common divisor (GCD) of two integers.
  704. euclid_test
  705. euler, a MATLAB code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
  706. euler_test
  707. 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).
  708. exactness_test
  709. 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.
  710. exm_test
  711. exp_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) whose solution is an exponential function.
  712. exp_ode_test
  713. faces_average, a MATLAB code which averages several images of the same face;
  714. faces_average_test
  715. fair_dice_simulation, a MATLAB code which simulates N tosses of 2 dice, making a histogram of the resulting sums.
  716. fair_dice_simulation_test
  717. faure, a MATLAB code which computes the Faure M dimensional Quasi Mont Carlo (QMC) sequence;
  718. faure_test
  719. fd_predator_prey, a MATLAB code which solves a time-dependent predator prey system using the finite difference method (FDM).
  720. fd_predator_prey_test
  721. fd_to_tec, a MATLAB code which converts finite difference method (FDM) models into tecplot() ASCII files.
  722. fd_to_tec_test
  723. 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.
  724. fd1d_advection_diffusion_steady_test
  725. 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.
  726. fd1d_advection_ftcs_test
  727. 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.
  728. fd1d_advection_lax_test
  729. 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.
  730. fd1d_advection_lax_wendroff_test
  731. 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.
  732. fd1d_burgers_lax_test
  733. 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.
  734. fd1d_burgers_leap_test
  735. fd1d_bvp, a MATLAB code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
  736. fd1d_bvp_test
  737. 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.
  738. fd1d_display_test
  739. fd1d_heat_explicit, a MATLAB code which implements a finite difference method (FDM), explicit in time, to solve the time dependent 1D heat equation;
  740. fd1d_heat_explicit_test
  741. fd1d_heat_implicit, a MATLAB code which implements a finite difference method (FDM), implicit in time, to solve the time dependent 1D heat equation;
  742. fd1d_heat_implicit_test
  743. fd1d_heat_steady, a MATLAB code which implements a finite difference method (FDM) for the steady (time independent) 1D heat equation;
  744. fd1d_heat_steady_test
  745. 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).
  746. fd1d_poisson_test
  747. 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.
  748. fd1d_predator_prey_test
  749. fd1d_predator_prey_plot, a MATLAB code which plots solutions of the predator prey differential equations, by Marcus Garvie.
  750. fd1d_predator_prey_plot_test
  751. 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.
  752. fd1d_wave_test
  753. 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.
  754. fd2d_heat_steady, a MATLAB code which implements a finite difference method (FDM) for the steady (time independent) 2D heat equation;
  755. fd2d_heat_steady_test
  756. 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).
  757. fd2d_poisson_test
  758. 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.
  759. fd2d_predator_prey_test
  760. 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).
  761. fd3d_poisson_test
  762. 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.)
  763. fem_basis_test
  764. 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;
  765. fem_basis_q4_display_test
  766. 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;
  767. fem_basis_t3_display_test
  768. 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;
  769. fem_basis_t4_display_test
  770. 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;
  771. fem_basis_t6_display_test
  772. 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;
  773. fem_io_test
  774. 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).
  775. fem_neumann_test
  776. 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.
  777. fem_to_gmsh_test
  778. 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.
  779. fem_to_medit_test
  780. fem_to_tec, a MATLAB code which converts FEM models into tecplot() ASCII files.
  781. fem_to_tec_test
  782. 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.
  783. fem_to_triangle_test
  784. 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().
  785. fem_to_xml_test
  786. 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;
  787. fem1d_test
  788. 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;
  789. fem1d_adaptive_test
  790. 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.
  791. fem1d_approximate_test
  792. 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.
  793. fem1d_bvp_linear_test
  794. 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.
  795. fem1d_bvp_quadratic_test
  796. 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.
  797. fem1d_display_test
  798. 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.
  799. fem1d_display_function_10_test
  800. 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.
  801. fem1d_heat_explicit_test
  802. 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.
  803. fem1d_heat_implicit_test
  804. fem1d_heat_steady, a MATLAB code which uses the finite element method (FEM) to solve the steady (time independent) 1D heat equation;
  805. fem1d_heat_steady_test
  806. 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.
  807. fem1d_lagrange_test
  808. 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;
  809. fem1d_nonlinear_test
  810. fem1d_pack, a MATLAB code which contains utilities for 1D finite element method (FEM) calculations.
  811. fem1d_pack_test
  812. 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;
  813. fem1d_pmethod_test
  814. 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.
  815. fem1d_project_test
  816. 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.
  817. fem1d_sample_test
  818. 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.
  819. fem1d_spectral_numeric_test
  820. 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.
  821. fem2d_bvp_linear_test
  822. 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.
  823. fem2d_bvp_quadratic_test
  824. 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.
  825. fem2d_bvp_serene_test
  826. 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;
  827. fem2d_heat_test
  828. 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;
  829. fem2d_heat_rectangle_test
  830. 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;
  831. fem2d_heat_sparse_test
  832. 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.
  833. fem2d_mesh_display_test
  834. fem2d_pack, a MATLAB code which performs simple 2D finite element method (FEM) computations;
  835. fem2d_pack_test
  836. 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.
  837. fem2d_poisson_rectangle_test
  838. 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.
  839. fem2d_poisson_rectangle_linear_test
  840. 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.
  841. fem2d_predator_prey_fast_test
  842. 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.
  843. fem2d_project_test
  844. 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.
  845. fem2d_project_function_test
  846. 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.
  847. fem2d_sample_test
  848. 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).
  849. fem2d_scalar_display_test
  850. 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.
  851. fem2d_scalar_display_brief_test
  852. 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), to be displayed by gnuplot().
  853. fem2d_scalar_display_gpl_test,
  854. fem3d_pack, a MATLAB code which contains utilities for 3D finite element method (FEM) calculations.
  855. fem3d_pack_test
  856. 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).
  857. fem3d_project_test
  858. fem3d_sample, a MATLAB code library which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
  859. fem3d_sample_test
  860. fermat_factor, a MATLAB code which uses Fermat's factorization method to decompose an integer N into the product of two factors, N = A^2-B^2 = (A+B)*(A-B).
  861. fermat_factor_test
  862. fern_chaos, a MATLAB code which applies a randomized linear map to a starting point to compute the Barnsley fractal fern.
  863. fern_chaos_test
  864. 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.
  865. feynman_kac_1d_test
  866. 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.
  867. feynman_kac_2d_test
  868. 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.
  869. feynman_kac_3d_test
  870. ffmatlib, a MATLAB code which allows the user to plot finite element method (FEM) results that have been computed by FreeFem++().
  871. fft_serial, a MATLAB code which computes a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.
  872. fft_serial_test
  873. fibonacci_spiral, a MATLAB code which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.
  874. fibonacci_spiral_test
  875. file_increment, a MATLAB code which increments every entry of an integer array which is stored in a file.
  876. file_increment_test
  877. 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.
  878. file_name_sequence_test
  879. files_multiple_test, a MATLAB code which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.
  880. filon_rule, a MATLAB code which approximates integrals which include an oscillatory factor of sin(k*x) or cos(k*x).
  881. filon_rule_test
  882. filum, a MATLAB code which handles files and filenames;
  883. filum_test
  884. fire_simulation, a MATLAB code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
  885. fire_simulation_test
  886. fisher_exact, a MATLAB code which returns an exact solution u(x,t) of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE): ut=uxx+u*(1-u).
  887. fisher_exact_test
  888. fisher_pde_ftcs, a MATLAB code which estimates a solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u), using the forward time centered space (FTCS) method, with an oscillating Dirichlet condition on the left, and a zero Neumann condition on the right. An animation of the solution is created.
  889. fisher_pde_ftcs_test
  890. fitzhugh_nagumo_ode, a MATLAB code which sets up and solves the Fitzhugh-Nagumo system of ordinary differential equations (ODE).
  891. fitzhugh_nagumo_ode_test
  892. flame_exact, a MATLAB code which returns the exact solution y(t) of 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.
  893. flame_exact_test
  894. 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.
  895. flame_ode_test
  896. 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.
  897. flies_simulation_test
  898. florida_cvt_geo, a MATLAB code which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based solely on geometric considerations.
  899. florida_cvt_geo_test
  900. florida_cvt_pop, a MATLAB code which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based on population considerations.
  901. florida_cvt_pop_test
  902. floyd, a MATLAB code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  903. floyd_test
  904. 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.
  905. fly_simulation_test
  906. 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.
  907. 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.
  908. fn_test
  909. football_dynamic, a MATLAB code which uses dynamic programming to count the ways of achieving a given score in football.
  910. football_dynamic_test
  911. 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.
  912. four_fifths_test
  913. 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.
  914. fractal_coastline_test
  915. freefem_msh_io, a MATLAB code which reads and writes files used by the FreeFem finite element program to store mesh information.
  916. freefem_msh_io_test
  917. fresnel, a MATLAB code which evaluates the Fresnel cosine and sine integrals.
  918. fresnel_test
  919. fsolve_test, a MATLAB code which calls fsolve() which seeks the solution x of one or more nonlinear equations f(x)=0.
  920. 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.
  921. full_deck_simulation_test
  922. gamblers_ruin_simulation, a MATLAB code which simulates a game in which a gambler never stops playing until all money is lost.
  923. gamblers_ruin_simulation_test
  924. gauss_seidel, a MATLAB code which implements the Gauss-Seidel iteration for linear systems.
  925. gauss_seidel_test
  926. 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.
  927. gauss_seidel_poisson_1d_test
  928. 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.
  929. gauss_seidel_stochastic_test
  930. gaussian, a MATLAB code which evaluates the Gaussian function for arbitrary mu and sigma, its antiderivative, and derivatives of arbitrary order.
  931. gaussian_test,
  932. gaussian_2d, a MATLAB code which evaluates a general Gaussian function of a 2D argument.
  933. gaussian_2d_test,
  934. gaussian_prime_spiral, a MATLAB code which computes a twisting spiral path along the Gaussian primes, and displays a plot of the total trajectory.
  935. gaussian_prime_spiral_test
  936. ge_to_crs, a MATLAB code which converts a matrix from General (GE) to Compressed Row Storage (CRS) format.
  937. ge_to_crs_test
  938. gegenbauer_cc, a MATLAB code which computes the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
  939. gegenbauer_cc_test
  940. gegenbauer_exactness, a MATLAB code which tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
  941. gegenbauer_exactness_test
  942. gegenbauer_polynomial, a MATLAB code which evaluates the Gegenbauer polynomial and associated functions.
  943. gegenbauer_polynomial_test
  944. gegenbauer_rule, a MATLAB code which computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
  945. gegenbauer_rule_test
  946. gen_hermite_exactness, a MATLAB code which tests the polynomial exactness of generalized Gauss-Hermite quadrature rules.
  947. gen_hermite_exactness_test
  948. gen_hermite_rule, a MATLAB code which computes and writes out a generalized Gauss-Hermite quadrature rule of given order and parameter value.
  949. gen_hermite_rule_test
  950. gen_laguerre_exactness, a MATLAB code which tests the polynomial exactness of generalized Gauss-Laguerre quadrature rules.
  951. gen_laguerre_exactness_test
  952. gen_laguerre_rule, a MATLAB code which prints a generalized Gauss-Laguerre quadrature rule of given order and parameter value.
  953. gen_laguerre_rule_test
  954. 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.
  955. geometry_test
  956. geompack, a MATLAB code which computes Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.
  957. geompack_test
  958. 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.
  959. gl_fast_rule_test
  960. 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.
  961. glomin_test
  962. 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.
  963. glycolysis_ode_test
  964. gmres, a MATLAB code which implements the generalized minimum residual (GMRES) method for solving a nonsymmetric sparse linear system A*x=b.
  965. gmres_test
  966. 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).
  967. gmsh_io_test
  968. 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.
  969. gmsh_to_fem_test
  970. gnuplot_test, a MATLAB code which uses gnuplot() to create various kinds of plots.
  971. 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.
  972. gpl_display_test
  973. gradient_descent, a MATLAB code which uses gradient descent to solve a linear least squares (LLS) problem.
  974. gradient_descent_test
  975. gram_polynomial, a MATLAB code which evaluates the Gram polynomials, also known as the discrete Chebyshev polyomials and associated functions.
  976. gram_polynomial_test
  977. gram_schmidt, a MATLAB code which implements the Gram-Schmidt process to orthogonalize and normalize a set of vectors.
  978. gram_schmidt_test
  979. 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.
  980. graph_adj_test
  981. graph_dist, a MATLAB code which carries out operations on abstract graphs, defined by undirected edges with an associated distance matrix, including the computing of the minimal spanning tree.
  982. graph_dist_test
  983. graph_representation, a MATLAB code which expresses the representation of an abstract mathematical graph in several ways.
  984. graph_representation_test
  985. 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.
  986. 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.
  987. gray_code_display_test
  988. 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.
  989. gray_scott_movie_test
  990. 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.
  991. gray_scott_pde_test
  992. 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.
  993. grazing_ode_test
  994. grf_display, a MATLAB code which reads a grf file defining a mathematical graph and displays it.
  995. grf_display_test
  996. grf_io, a MATLAB code which reads or writes a grf file which represents a mathematical graph;
  997. grf_io_test
  998. 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;
  999. grid_display_test
  1000. gridlines, a MATLAB code which gives the user more control over drawing gridlines on a graph than the builtin grid command.
  1001. gridlines_test
  1002. 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.
  1003. grids_display_test
  1004. 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 to be read by load().
  1005. gurobi_solution_read_test
  1006. gyroscope_ode, a MATLAB code which sets up the ordinary differential equations (ODE) that simulate the angular attitude and rotational speed of a gyroscope.
  1007. gyroscope_ode_test
  1008. haar_transform, a MATLAB code which computes the Haar transform of 1d or 2d data.
  1009. haar_transform_test
  1010. halton, a MATLAB code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
  1011. halton_test
  1012. hammersley, a MATLAB code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
  1013. hammersley_test
  1014. hamming, a MATLAB code which implements some simple versions of Hamming codes which detects and correct errors in data.
  1015. hamming_test
  1016. hand, a MATLAB code which carries out some numerical exercises based on data that came from tracing several points on a hand.
  1017. hand_test
  1018. hand_area, a MATLAB code which estimates the area of a curve which outlines a hand.
  1019. hand_area_test
  1020. hand_data, a MATLAB code which creates a data set which is presumably the (x,y) coordinates of points that outline a user's hand which has been pressed to the screen.
  1021. hand_data_test
  1022. 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.
  1023. hand_mesh2d_test
  1024. 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.
  1025. hankel_cholesky_test
  1026. hankel_inverse, a MATLAB code which computes the inverse of a Hankel matrix.
  1027. hankel_inverse_test
  1028. 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'.
  1029. hankel_spd_test
  1030. hb_io, a MATLAB code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
  1031. hb_io_test
  1032. hb_to_mm, a MATLAB code which converts a sparse matrix from Harwell Boeing (HB) to Matrix Market (MM) format.
  1033. hb_to_mm_test
  1034. hb_to_msm, a MATLAB code which converts a sparse matrix stored in a Harwell Boeing (HB) format to MATLAB sparse matrix (MSM) format;
  1035. hb_to_msm_test
  1036. hb_to_st, a MATLAB code which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.
  1037. hb_to_st_test
  1038. 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.
  1039. heartbeat_ode_test
  1040. 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.
  1041. 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.
  1042. heated_plate_test
  1043. hello, a MATLAB code which prints out "Hello, world!".
  1044. hello_test
  1045. hello_parfor, a MATLAB code which uses the parfor() statement for parallel execution and simply prints "Hello, world!" multiple times.
  1046. hello_parfor_test
  1047. helmholtz_exact, a MATLAB code which evaluates an exact solution z(x,y) for the Helmholtz equation, a sort of eigenvalue version of a partial differential equation (PDE) arising after separation of variables is a applied to the wave equation. This example considers a problem in which z(x,y) represents the vertical deflection of the surface of a vibrating circular membrane such as a drumhead. The Helmholtz equation has the form - del^2 Z = k^2 Z.
  1048. helmholtz_exact_test
  1049. 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.
  1050. henon_heiles_ode_test
  1051. henon_orbit, a MATLAB code which computes the orbit of the Henon map for various sets of initial data.
  1052. henon_orbit_test
  1053. 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.
  1054. hermite_cubic_test
  1055. 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).
  1056. hermite_exactness_test
  1057. hermite_integrands, a MATLAB code which defines test integrands for Hermite integrals with density exp(-x^2) over the interval (-oo,+oo).
  1058. hermite_integrands_test
  1059. hermite_interpolant, a MATLAB code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
  1060. hermite_interpolant_test
  1061. hermite_polynomial, a MATLAB code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
  1062. hermite_polynomial_test
  1063. 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).
  1064. hermite_product_display_test
  1065. hermite_product_polynomial, a MATLAB code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
  1066. hermite_product_polynomial_test
  1067. 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).
  1068. hermite_rule_test
  1069. hexagon_integrals, a MATLAB code which returns the exact value of the integral of a monomial over the interior of a hexagon in 2D.
  1070. hexagon_integrals_test
  1071. hexagon_lyness_rule, a MATLAB code which computes one of 13 Lyness quadrature rules over the interior of the unit hexagon.
  1072. hexagon_lyness_rule_test
  1073. 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;
  1074. hexagon_monte_carlo_test
  1075. hexagon_stroud_rule, a MATLAB code which computes one of four Stroud quadrature rules over the interior of the unit hexagon.
  1076. hexagon_stroud_rule_test
  1077. hexahedron_jaskowiec_rule, a MATLAB code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
  1078. hexahedron_jaskowiec_rule_test
  1079. hexahedron_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
  1080. hexahedron_witherden_rule_test
  1081. 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.
  1082. high_card_parfor_test
  1083. 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.
  1084. high_card_simulation_test
  1085. hilbert_curve, a MATLAB code which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.
  1086. hilbert_curve_test
  1087. hilbert_curve_3d, a MATLAB code which converts 3D Hilbert curve data between spatial coordinates of a lattice point (x,y,z) and the linear coordinate H which describes the ordering of that point on the curve.
  1088. hilbert_curve_3d_test
  1089. hilbert_curve_display, a MATLAB code which plots a Hilbert curve of given order.
  1090. hilbert_curve_display_test
  1091. 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.
  1092. histogram_data_2d_sample_test
  1093. histogram_discrete, a MATLAB code which tries to make a histogram of data without using bins.
  1094. histogram_discrete_test
  1095. 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;
  1096. histogram_display_test
  1097. 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.
  1098. histogram_pdf_sample_test
  1099. 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.
  1100. histogram_pdf_2d_sample_test
  1101. 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.
  1102. histogramize_test
  1103. hits, a MATLAB code which uses the HITS algorithm to assign authority and hub indices to a set of nodes in a directed network.
  1104. hits_test
  1105. 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.
  1106. house_test
  1107. house_data, a MATLAB code which returns the coordinates of 11 points which are the vertices of a (degenerate) polygon which has the shape of a house.
  1108. house_data_test
  1109. 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.
  1110. human_data_test
  1111. human_mesh2d, a MATLAB code which retrieves data for an outline of a human body, and then uses mesh2d() to triangulate the data to make a mesh of the region.
  1112. human_mesh2d_test
  1113. humps, a MATLAB code which evaluates the humps() function, its first and second derivatives and its antiderivative.
  1114. humps_test
  1115. humps_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) whose solution is a double hump curve.
  1116. humps_ode_test
  1117. 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.
  1118. hyper_2f1_test
  1119. 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.
  1120. hyperball_distance_test
  1121. 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.
  1122. hyperball_integrals_test
  1123. 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;
  1124. hyperball_monte_carlo_test
  1125. 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.
  1126. hyperball_positive_distance_test
  1127. 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.
  1128. hypercube_distance_test
  1129. hypercube_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule over the interior of the unit hypercube in M dimensions.
  1130. hypercube_exactness_test
  1131. hypercube_grid, a MATLAB code which computes a grid of points over the interior of a hypercube in M dimensions.
  1132. hypercube_grid_test
  1133. 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.
  1134. hypercube_integrals_test
  1135. 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.
  1136. hypercube_monte_carlo_test
  1137. 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.
  1138. hypercube_surface_distance_test
  1139. 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.
  1140. 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.
  1141. hypersphere_test
  1142. 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.
  1143. hypersphere_angle_test
  1144. 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.
  1145. hypersphere_distance_test
  1146. 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.
  1147. hypersphere_integrals_test
  1148. 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;
  1149. hypersphere_monte_carlo_test
  1150. 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.
  1151. hypersphere_positive_distance_test
  1152. i4lib, a MATLAB code which contains utilities using single precision integer (I4) arithmetic.
  1153. i4lib_test
  1154. i4mat_rref2, a MATLAB code which computes a version of the reduced row echelon form of an integer matrix.
  1155. i4mat_rref2_test
  1156. ice_io, a MATLAB code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
  1157. ice_io_test
  1158. ice_to_medit, a MATLAB code which reads a netcdf() file containing an ICE dataset and rewrites the information as a medit() MESH file.
  1159. ice_to_medit_test
  1160. 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.
  1161. ill_bvp_test
  1162. image_boundary, a MATLAB code which reports the pixels which form the boundary between the black and white regions of a simple image.
  1163. image_boundary_test
  1164. image_contrast, a MATLAB code which applies image processing techniques to increase the contrast in an image.
  1165. image_contrast_test
  1166. image_decimate, a MATLAB code which drops the even rows and columns from an image.
  1167. image_decimate_test
  1168. image_denoise, a MATLAB code which applies simple filtering operations to a noisy image.
  1169. image_denoise_test
  1170. image_diffuse, a MATLAB code which uses diffusion to smooth out an image.
  1171. image_diffuse_test
  1172. image_double, a MATLAB code which doubles the height and width of an image by repeating each row and column.
  1173. image_double_test
  1174. image_edge, a MATLAB code which detects edges in an image.
  1175. image_edge_test
  1176. image_mesh2d, a MATLAB code which starts with a list of points that bound some region, and calls mesh2d() to create a mesh of the interior.
  1177. image_mesh2d_test
  1178. image_noise, a MATLAB code which adds noise to an image.
  1179. image_noise_test
  1180. 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.
  1181. image_normalize_test
  1182. image_quantization, a MATLAB code which uses kmeans() to reduce the number of colors or shades of gray in an image.
  1183. image_quantization_test
  1184. image_rgb_to_gray, a MATLAB code which makes a grayscale version of an RGB image.
  1185. image_rgb_to_gray_test
  1186. 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.
  1187. image_sample_test
  1188. 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.
  1189. image_threshold_test
  1190. imshow_numeric, a MATLAB code which accepts a numeric 2D array and displays it as a grayscale image.
  1191. imshow_numeric_test
  1192. 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.
  1193. index_test
  1194. 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.
  1195. insurance_simulation_test
  1196. interp, a MATLAB code which parameterizes and interpolates data;
  1197. interp_test
  1198. 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.
  1199. interp_chebyshev_test
  1200. 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.
  1201. interp_equal_test
  1202. 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.
  1203. interp_ncs_test
  1204. interp_spline, a MATLAB code which interactively constructs a cubic spline interpolant to a function f(x), using the 'not-a-knot' end condition.
  1205. interp_spline_test
  1206. interp_spline_data, a MATLAB code which interactively constructs a cubic spline interpolant to (x,y) data, using the 'not-a-knot' end condition.
  1207. interp_spline_data_test
  1208. 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.
  1209. interp_trig_test
  1210. iplot, a MATLAB code which interactively plots a function f(x) over a domain a ≤ x ≤ b;
  1211. iplot_test
  1212. is_gaussian_prime, a MATLAB code which is true if a given complex number c is a Gaussian prime.
  1213. is_gaussian_prime_test
  1214. is_prime, a MATLAB code which is true if a given integer n is prime.
  1215. is_prime_test
  1216. isbn, a MATLAB code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
  1217. isbn_test
  1218. 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.
  1219. ising_2d_simulation_test
  1220. jaccard_distance, a MATLAB code which computes the Jaccard distance between two sets.
  1221. jaccard_distance_test
  1222. jacobi, a MATLAB code which implements the Jacobi iteration for the iterative solution of linear systems.
  1223. jacobi_test
  1224. jacobi_eigenvalue, a MATLAB code which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.
  1225. jacobi_eigenvalue_test
  1226. jacobi_exactness, a MATLAB code which tests the polynomial exactness of rules for integrals with a Jacobi weight function.
  1227. jacobi_exactness_test
  1228. jacobi_poisson_1d, a MATLAB code which uses Jacobi iteration to solve the linear system for a discretized steady 1D Poisson equation.
  1229. jacobi_poisson_1d_test
  1230. jacobi_polynomial, a MATLAB code which evaluates the Jacobi polynomial and associated functions.
  1231. jacobi_polynomial_test
  1232. jacobi_rule, a MATLAB code which computes a Gauss-Jacobi quadrature rule.
  1233. jacobi_rule_test
  1234. jai_alai_simulation, a MATLAB code which simulates a sequence matches of the game of jai alai.
  1235. jai_alai_simulation_test
  1236. jordan_matrix, a MATLAB code which returns a random matrix in Jordan canonical form.
  1237. jordan_matrix_test
  1238. joukowsky_transform, a MATLAB code which applies the Joukowsky transform to data, mapping between a circle in the complex plane and various airfoil shapes.
  1239. joukowsky_transform_test
  1240. 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.
  1241. julia_set_test
  1242. jumping_bean_simulation, a MATLAB code which simulates the motion of several jumping beans which prefer cooler locations.
  1243. jumping_bean_simulation_test
  1244. 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.
  1245. kdv_etdrk4_test
  1246. kdv_exact, a MATLAB code which evaluates an exact solution u(x,t) of the Korteweg-deVries (KdV) partial differential equation (PDE), representing the motion of a soliton. The equation has the form u' - 6 u ux + uxxx = 0.
  1247. kdv_exact_test
  1248. 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.
  1249. kdv_ift_test
  1250. kelley, a MATLAB code which implements iterative methods for linear and nonlinear problems, by Tim Kelley.
  1251. kelley_test
  1252. kepler_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) for a Kepler two-body gravitational system.
  1253. kepler_ode_test
  1254. kepler_perturbed_ode, a MATLAB code which sets up and solves the ordinary differential equations (ODE) for a perturbed Kepler two-body gravitational system.
  1255. kepler_perturbed_ode_test
  1256. keyword_test, a MATLAB code which accepts named keywords, using the Name/Value paired argument convention.
  1257. kmeans, a MATLAB code which handles the K-Means problem, which organizes a set of N points in M dimensions into K clusters;
  1258. kmeans_test
  1259. 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.
  1260. kmeans_fast_test
  1261. knapsack_01_brute, a MATLAB code which uses brute force to solve small versions of the 0/1 knapsack problem, in which a knapsack of limited weight capacity is to be packed as full as possible, selecting items from a set of varying weights;
  1262. knapsack_01_brute_test
  1263. knapsack_brute, a MATLAB code which uses brute force to solve small versions of the knapsack problem, in which N items are available, each with given value and weight. A thief's knapsack can carry no more than Wmax pounds. The thief seeks a selection of items to carry in the knapsack of maximum total value.
  1264. knapsack_brute_test
  1265. knapsack_dynamic, a MATLAB code which uses dynamic programming to solve a knapsack problem.
  1266. knapsack_dynamic_test
  1267. knapsack_greedy, a MATLAB code which uses a greedy algorithm to estimate a solution of the knapsack problem;
  1268. knapsack_greedy_test
  1269. knapsack_random, a MATLAB code which randomly chooses a subset of N items, each with given value and weight. It then evaluates whether this is a feasible solution to a problem in which a thief's knapsack can carry no more than Wmax pounds, and it is desired to maximum the total value of the selected items.
  1270. knapsack_random_test
  1271. knapsack_rational, a MATLAB code which solves the rational knapsack problem, in which a knapsack of limited weight capacity is filled with profitable items. This variation of the knapsack problem allows a fractional part of an item to be included in the knapsack. The result is an upper bound on the maximum possible profit for the knapsack problem.
  1272. knapsack_rational_test
  1273. knapsack_values, a MATLAB code which returns some simple examples of the knapsack problem, in which N items are available, each with given value V and weight W. A thief's knapsack can carry no more than K pounds. The thief seeks a selection S of items to carry in the knapsack of maximum total value.
  1274. knapsack_values_test
  1275. kronrod_rule, a MATLAB code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  1276. kronrod_rule_test
  1277. 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.
  1278. kursiv_pde_etdrk4_test
  1279. l4lib, a MATLAB code which contains functions for working with logical variables.
  1280. l4lib_test
  1281. lagrange, a MATLAB code which evaluates any Lagrange basis polynomial L(i)(x), its antiderivative, or its first or second derivatives. Sample plots are made.
  1282. lagrange_test
  1283. 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)).
  1284. lagrange_approx_1d_test
  1285. lagrange_basis_display, a MATLAB code which displays the basis functions associated with a given set of nodes used with the Lagrange interpolation scheme.
  1286. lagrange_basis_display_test
  1287. 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).
  1288. lagrange_interp_1d_test
  1289. 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).
  1290. lagrange_interp_2d_test
  1291. 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).
  1292. lagrange_interp_nd_test
  1293. lagrange_nd, a MATLAB code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
  1294. lagrange_nd_test
  1295. 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).
  1296. laguerre_exactness_test
  1297. laguerre_integrands, a MATLAB code which implements test problems for approximate integration over a semi-infinite interval, often carried out using Gauss-Laguerre quadrature.
  1298. laguerre_integrands_test
  1299. laguerre_polynomial, a MATLAB code which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
  1300. laguerre_polynomial_test
  1301. laguerre_product, a MATLAB code which computes weighted integrals of products of Laguerre polynomials.
  1302. laguerre_product_test
  1303. laguerre_rule, a MATLAB code which returns a Gauss-Laguerre quadrature rule of given order.
  1304. laguerre_rule_test
  1305. lambert_w, a MATLAB code which evaluates Lambert's W function.
  1306. lambert_w_test
  1307. langford_ode, a MATLAB code which sets up and solves the Langford system of ordinary differential equations (ODE).
  1308. langford_ode_test
  1309. 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.
  1310. laplace_radial_exact, a MATLAB code which evaluates exact solutions u(x,y) or u(x,y,z), with radial symmetry, to the Laplace equation: del^2 U = 0.
  1311. laplace_radial_exact_test
  1312. laplacian, a MATLAB code which evaluates a discretized approximation to the Laplacian operator on data on an evenly spaced grid, within a circle, an interval, or a torus. For the case of the interval, the data may be supplied on an unevenly spaced grid.
  1313. laplacian_test
  1314. laplacian_matrix, 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.
  1315. laplacian_matrix_test
  1316. latin_center, a MATLAB code which computes N points in an M dimensional Latin Center square;
  1317. latin_center_test
  1318. latin_cover, a MATLAB code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
  1319. latin_cover_test
  1320. latin_edge, a MATLAB code which returns N points in an M dimensional Latin Edge square;
  1321. latin_edge_test
  1322. latin_random, a MATLAB code which returns N points in an M dimensional Latin Random square;
  1323. latin_random_test
  1324. latinize, a MATLAB code which adjusts N points in M dimensions to form a Latin hypercube;
  1325. latinize_test
  1326. lattice_rule, a MATLAB code which returns lattice rules for M dimensional integration;
  1327. lattice_rule_test
  1328. leaf_chaos, a MATLAB code which creates a dot-plot of a leaf by repeatedly applying a randomized linear transformation to a starting point.
  1329. leaf_chaos_test
  1330. 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).
  1331. leapfrog_test
  1332. least_squares_approximant, a MATLAB code which finds a polynomial approximant to data using linear least squares (LLS).
  1333. least_squares_approximant_test
  1334. 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.
  1335. lebesgue_test
  1336. 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].
  1337. legendre_exactness_test
  1338. legendre_fast_rule, a MATLAB code which uses a fast (order N) algorithm to compute a Gauss-Legendre quadrature rule of given order.
  1339. legendre_fast_rule_test
  1340. legendre_polynomial, a MATLAB code which evaluates the Legendre polynomial and associated functions.
  1341. legendre_polynomial_test
  1342. legendre_product, a MATLAB code which computes weighted integrals of products of Legendre polynomials.
  1343. legendre_product_test
  1344. legendre_product_display, a MATLAB code which displays the points in a 2D Gauss-Legendre product quadrature rule;
  1345. legendre_product_display_test
  1346. legendre_product_polynomial, a MATLAB code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
  1347. legendre_product_polynomial_test
  1348. legendre_rule, a MATLAB code which returns a Gauss-Legendre quadrature rule of given order.
  1349. legendre_rule_test
  1350. legendre_shifted_polynomial, a MATLAB code which evaluates the shifted Legendre polynomial, with the domain [0,1].
  1351. legendre_shifted_polynomial_test
  1352. levels, a MATLAB code which makes a contour plot, choosing the contour levels using random sampling.
  1353. levels_test
  1354. levenshtein_distance, a MATLAB code which returns the Levenshtein distance between two strings.
  1355. levenshtein_distance_test
  1356. levenshtein_matrix, a MATLAB code which returns the Levenshtein distance matrix defined by two strings.
  1357. levenshtein_matrix_test
  1358. levy_dragon_chaos, a MATLAB code which creates a dot-plot of the Levy dragon by repeatedly applying a randomized linear transformation to a starting point.
  1359. levy_dragon_chaos_test
  1360. 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.
  1361. life_test
  1362. lights_out, a MATLAB code which analyzes the "Lights Out" game, in which lights on a 5x5 board are randomly lit up. Pushing a light reverses its status, as well as the status of the north, south, east and west neighbor lights. The user seeks to push buttons in such a way that all the lights are turned off.
  1363. lights_out_test
  1364. lights_out_game, 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.
  1365. lindberg_exact, a MATLAB code which evaluates the exact solution y(t) of the Lindberg ordinary differential equation (ODE), a system that is extremely difficult to solve accurately.
  1366. lindberg_exact_test
  1367. lindberg_ode, a MATLAB code which sets up and solves a system of 4 ordinary differential equations (ODE) which are very stiff.
  1368. lindberg_ode_test
  1369. 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.
  1370. line_cvt_lloyd_test
  1371. 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.
  1372. line_distance_test
  1373. 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.
  1374. line_fekete_rule_test
  1375. line_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a line segment in 1D.
  1376. line_felippa_rule_test
  1377. line_grid, a MATLAB code which computes a grid of points over the interior of a line segment in 1D.
  1378. line_grid_test
  1379. 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.
  1380. line_integrals_test
  1381. line_lines_packing, a MATLAB code which tries to randomly pack as many non-overlapping equal line segments as possible into a larger line segment, estimating Renyi's parking constant of 0.7475979202. This is an example of random sequential adsorption (RSA).
  1382. line_lines_packing_test
  1383. 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.
  1384. line_monte_carlo_test
  1385. 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.
  1386. line_ncc_rule_test
  1387. 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.
  1388. line_nco_rule_test
  1389. linear_algebra, a MATLAB code which carries out various linear algebra operations for matrices stored in a variety of formats.
  1390. linpack_bench, a MATLAB code which carries out the LINPACK Benchmark, which measures the time required to factor and solve a large linear system.
  1391. linpack_bench_test
  1392. linpack_bench_backslash, a MATLAB code which is a version of the LINPACK benchmark using the "backslash" linear system solver;
  1393. linpack_bench_backslash_test
  1394. linpack_d, a MATLAB code which factors and solves linear systems using real 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
  1395. linpack_d_test
  1396. linpack_z, a MATLAB code which factors and solves linear systems using complex 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be complex.
  1397. linpack_z_test
  1398. lissajous, a MATLAB code which displays a Lissajous figure, of the form x = sin ( a1 t + b1 ), y = sin ( a2 t + b2 ).
  1399. lissajous_test
  1400. 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.
  1401. llsq_test
  1402. load_test, a MATLAB code which calls the load() function, which reads data from a file into a variable.
  1403. lobatto_polynomial, a MATLAB code which evaluates Lobatto polynomials, which are similar to Legendre polynomials except that they are 0 at both endpoints.
  1404. lobatto_polynomial_test
  1405. 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.
  1406. local_min_test
  1407. 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.
  1408. local_min_rc_test
  1409. 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.
  1410. locker_simulation_test
  1411. log_norm, a MATLAB code which computes the logarithmic norm of a matrix, for norms 1, 2 and oo.
  1412. log_norm_test
  1413. log_normal, a MATLAB code which returns quantities related to the log normal Probability Distribution Function (PDF).
  1414. log_normal_test
  1415. 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].
  1416. log_normal_truncated_ab_test
  1417. logistic_bifurcation, a MATLAB code which plots the bifurcation diagram for the logistic equation, by John D Cook.
  1418. logistic_bifurcation_test
  1419. logistic_exact, a MATLAB code which evaluates an exact solution y(t) of the logistic equation, which models population growth in the face of a limited carrying capacity, an ordinary differential equation (ODE) of the y' = r * ( y - y^2 / k ).
  1420. logistic_exact_test
  1421. 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.
  1422. logistic_ode_test
  1423. lorenz_ode, sets up and solves the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
  1424. lorenz_ode_test
  1425. 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.
  1426. 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.
  1427. lorenz96_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) devised by Edward Lorenz, as a test of predictability for data assimilation applications.
  1428. lorenz96_ode_test
  1429. luhn, a MATLAB code which computes the Luhn check digit for a string, and validates a string.
  1430. luhn_test
  1431. machar, a MATLAB code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
  1432. machar_test
  1433. machine, a MATLAB code which returns values of arithmetic constants for a given machine.
  1434. machine_test
  1435. 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.
  1436. mackey_glass_dde_test
  1437. magic_matrix, a MATLAB code which computes a magic matrix, for any odd order n, such that all rows, columns, the diagonal and antidiagonal have the same sum.
  1438. magic_matrix_test
  1439. magic4_matrix, a MATLAB code which computes an nxn magic matrix, where n is a multiple of 4, such that all rows, columns, the diagonal and antidiagonal have the same sum.
  1440. magic4_matrix_test
  1441. mandelbrot, a MATLAB code which generates an image of the Mandelbrot set;
  1442. mandelbrot_test
  1443. mandelbrot_orbit, a MATLAB code which generates the Mandelbrot iterates arising from a single starting point;
  1444. mandelbrot_orbit_test
  1445. 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.
  1446. maple_area_test
  1447. maple_data, a MATLAB code which reads an image of a maple leaf and extracts the list of pixels that form the boundary.
  1448. maple_data_test
  1449. mario, a MATLAB code which creates a sort of "needlepoint" image of Mario, as an array of colored squares.
  1450. mario_test
  1451. markov_letters, a MATLAB code which counts the occurences of letter pairs in a text.
  1452. markov_letters_test
  1453. matlab_test, a MATLAB code which illustrates the use of scripts and M-files;
  1454. matlab_combinatorics, a MATLAB code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
  1455. matlab_commandline, a MATLAB code which illustrates how to execute code from the UNIX command line, that is, not with the usual command window.
  1456. matlab_compiler, a MATLAB code which illustrates the use of the compiler, which allows you to run an application outside of the Matlab environment.
  1457. 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.
  1458. matlab_exact, a MATLAB code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
  1459. matlab_graphics, a MATLAB code which demonstrates a few issues that arise when producing graphic images.
  1460. matlab_grid, a MATLAB code which generates a regular grid of points inside a variety of regions in one, two, three or many dimensions.
  1461. matlab_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the surface or interior of some geometric object, including a line, quadrilateral, box, circle, disk, sphere, ball and others.
  1462. matlab_kmeans_test, a MATLAB code which calls the built in kmeans() function, which clusters N sets of M-dimensional data into K clusters.
  1463. matlab_map, a MATLAB code which uses the mapping toolbox to draw maps of the world, countries, the US, or individual states.
  1464. matlab_mistake, a MATLAB code which illustrates some simple but devious programming mistakes.
  1465. matlab_monte_carlo, a MATLAB code which uses Monte Carlo sampling to estimate areas and integrals.
  1466. matlab_movie, a MATLAB code which creates a movie or animation by generating a sequence of graphics frames and then stringing them together.
  1467. matlab_ode, a MATLAB code which sets up various systems of ordinary differential equations (ODE).
  1468. matlab_ode_solver, a MATLAB code which solves one or more differential equations (ODE) using a method of a particular order, either explicit or implicit. Some methods require a nonlinear equation solver. Some methods used a fixed stepsize, while others adapt the stepsize based on an error estimate.
  1469. matlab_os, a MATLAB code which illustrates how the system command can be used to issue commands to the computer operating system (UNIX or DOS);
  1470. matlab_plots, a MATLAB code which uses plotting to illustrate a mathematical structure, such as an iterative map, a fractal, a curve or surface.
  1471. matlab_polynomial, a MATLAB code which analyzes a variety of polynomial families, returning the polynomial values, coefficients, derivatives, integrals, roots, or other information.
  1472. matlab_random_test, a MATLAB code which demonstrates random number generation.
  1473. matlab_rule, a MATLAB code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as a circle, a triangle, a quadrilateral, a polygon, or a higher dimensional region, and which might include an associated weight function w(x).
  1474. 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.
  1475. matrix_analyze, a MATLAB code which reports whether a matrix has various properties.
  1476. matrix_analyze_test
  1477. matrix_assemble_parfor, a MATLAB code which demonstrates the parfor() parallel programming feature by assembling the Hilbert matrix in a parallel loop.
  1478. matrix_assemble_parfor_test
  1479. matrix_chain_brute, a MATLAB code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using brute force.
  1480. matrix_chain_brute_test
  1481. matrix_chain_dynamic, a MATLAB code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
  1482. matrix_chain_dynamic_test
  1483. matrix_exponential, a MATLAB code which computes the exponential of a matrix.
  1484. matrix_exponential_test
  1485. 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.
  1486. mcnuggets_test
  1487. 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.
  1488. mcnuggets_diophantine_test
  1489. md, a MATLAB code which carries out a molecular dynamics simulation, and is intended as a starting point for implementing a parallel version.
  1490. md_test
  1491. 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.
  1492. md_fast_test
  1493. md_parfor, a MATLAB code which runs the md() molecular dynamics program, running in parallel using parfor().
  1494. md_parfor_test
  1495. medit_mesh_io, a MATLAB code which reads or writes medit() MESH files defining a finite element mesh.
  1496. medit_mesh_io_test
  1497. 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.
  1498. medit_to_fem_test
  1499. medit_to_ice, a MATLAB code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
  1500. medit_to_ice_test
  1501. 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.
  1502. memory_test
  1503. menger_sponge_chaos, a MATLAB code which creates a dot-plot of the 3D Menger sponge by repeatedly applying a randomized linear transformation to a starting point.
  1504. menger_sponge_chaos_test
  1505. 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.
  1506. mesh_bandwidth_test
  1507. 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.
  1508. mesh_boundary_test
  1509. mesh_display, a MATLAB code which plots the nodes and elements of a polygonal mesh, with optional numbering.
  1510. mesh_display_test
  1511. mesh_etoe, a MATLAB code which uses ETOV, the mesh element-to-vertex connectivity, to construct ETOE, the element-to-element connectivity.
  1512. mesh_etoe_test
  1513. mesh_vtoe, a MATLAB code which uses ETOV, the mesh element-to-vertex connectivity, to construct VTOE, the vertex-to-element connectivity.
  1514. mesh_vtoe_test
  1515. mesh2d, a MATLAB code which automatically creates a triangular mesh for a given polygonal region, by Darren Engwirda.
  1516. mesh2d_test
  1517. 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.
  1518. mesh2d_to_medit_test
  1519. mesh2d_write, a MATLAB code which writes mesh2d() node and element data to files.
  1520. mesh2d_write_test
  1521. 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.
  1522. mgmres_test
  1523. 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.
  1524. mgs_test
  1525. mhd_exact, a MATLAB code which evaluates Hartmann's exact formula for a velocity/pressure/magnetic field solution (u,v), p, (b1,b2) of the partial differential equations (PDE) for steady magnetohydrodynamic (MHD) fluid flow in a 2D rectangular channel.
  1526. mhd_exact_test
  1527. 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.
  1528. middle_square_test
  1529. 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.
  1530. midpoint_test
  1531. 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. Plots of the solution and timestep history are created.
  1532. midpoint_adaptive_test
  1533. 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.
  1534. midpoint_explicit_test
  1535. 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.
  1536. midpoint_fixed_test
  1537. minimal_surface_exact, a MATLAB code which evaluates exact solutions u(x,y) to the minimal surface equation: (1+Ux^2) Uyy - 2 Ux Uy Uxy + (1+Uy^2) Uxx = 0
  1538. minimal_surface_exact_test
  1539. mm_io, a MATLAB code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
  1540. mm_io_test
  1541. 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.
  1542. mm_to_hb_test
  1543. 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.
  1544. mm_to_msm_test
  1545. 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.
  1546. mm_to_st_test
  1547. mnist_neural, a MATLAB code which constructs a neural network in order to classify images of digits.
  1548. mnist_neural_test
  1549. monoalphabetic, a MATLAB code which applies a monoalphabetic substitution cipher to a string of text.
  1550. monoalphabetic_test
  1551. 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.
  1552. monomial_test
  1553. monomial_symmetrize, a MATLAB code which symmetrizes the coefficients of equivalent monomials in a polynomial.
  1554. monomial_symmetrize_test
  1555. monomial_value, a MATLAB code which evaluates a monomial in M dimensions.
  1556. monomial_value_test
  1557. monopoly_matrix, a MATLAB code which computes the adjacency and transition matrices for the game of Monopoly.
  1558. monopoly_matrix_test
  1559. 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.
  1560. monty_hall_simulation_test
  1561. mortality, a MATLAB code which processes some sample mortality data.
  1562. mortality_test
  1563. msm_to_hb, a MATLAB code which writes a MATLAB sparse matrix (MSM) to a Harwell Boeing (HB) file;
  1564. msm_to_hb_test
  1565. msm_to_mm, a MATLAB code which writes a MATLAB sparse matrix (MSM) to a Matrix Market (MM) file;
  1566. msm_to_mm_test
  1567. msm_to_st, a MATLAB code which writes a MATLAB sparse matrix (MSM) to a Sparse Triplet (ST) file;
  1568. msm_to_st_test
  1569. 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.
  1570. mxm_test
  1571. 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.
  1572. naca_test
  1573. nas, a MATLAB code which runs the NASA kernel benchmark.
  1574. nas_test
  1575. 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.
  1576. navier_stokes_2d_exact_test
  1577. 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.
  1578. navier_stokes_3d_exact_test
  1579. 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.
  1580. navier_stokes_mesh2d_test
  1581. 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.
  1582. navier_stokes_mesh3d_test
  1583. 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.
  1584. ncm_test
  1585. nearest_interp_1d, a MATLAB code which interpolates a set of data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion.
  1586. nearest_interp_1d_test
  1587. nearest_neighbor, a MATLAB code which is given two sets of M-dimensional points R and S; For each point in S, it finds the closest point in R. The code is by Richard Brown.
  1588. nearest_neighbor_test
  1589. neighbor_risk, a MATLAB code which records information about neighboring pairs of territories in the game of RISK.
  1590. neighbor_risk_test
  1591. neighbor_states, a MATLAB code which records information about pairs of US states which are neighbors.
  1592. neighbor_states_test
  1593. neighbors_to_metis_graph, a MATLAB code which reads a file describing the neighbor structure of a mesh of triangles or tetrahedrons, and writes a metis_graph() file suitable for input to one of the family of programs based on metis();
  1594. neighbors_to_metis_graph_test
  1595. nelder_mead, a MATLAB code which implements the Nelder-Mead algorithm for the minimization of a scalar function of several variables, by Jeff Borggaard.
  1596. nelder_mead_test
  1597. nested_sequence_display, a MATLAB code which displays nested sequences.
  1598. nested_sequence_display_test
  1599. netcdf_test, a MATLAB code which reads and writes netcdf files.
  1600. 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.
  1601. neural_network_test
  1602. newton_interp_1d, a MATLAB code which finds a polynomial interpolant to data using Newton divided differences.
  1603. newton_interp_1d_test
  1604. newton_rc, a MATLAB code which solves a system of nonlinear equations by Newton's method, using reverse communication (RC).
  1605. newton_rc_test
  1606. niederreiter2, a MATLAB code which computes the Niederreiter M dimensional Quasi Mont Carlo (QMC) sequence, base 2;
  1607. niederreiter2_test
  1608. nint_exactness_mixed, a MATLAB code which measures the exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.
  1609. nint_exactness_mixed_test
  1610. nintlib, a MATLAB code which implements approximate integration (quadrature) in M dimensions;
  1611. nintlib_test
  1612. nonlin_bisect, a MATLAB code which interactively uses bisection to seek a zero of a function f(x) within a domain a ≤ x ≤ b;
  1613. nonlin_bisect_test
  1614. 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;
  1615. nonlin_fixed_point_test
  1616. 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.
  1617. nonlin_newton_test
  1618. 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];
  1619. nonlin_regula_test
  1620. 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.
  1621. nonlin_secant_test
  1622. 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];
  1623. nonlin_snyder_test
  1624. 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.
  1625. norm_l1_test
  1626. 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.
  1627. norm_l2_test
  1628. 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.
  1629. norm_loo_test
  1630. 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.
  1631. norm_rms_test
  1632. normal, a MATLAB code which implements normal random number generators (RNG) for real and complex arithmetic, for scalars, vectors, and matrices.
  1633. normal_test
  1634. normal_dataset, a MATLAB code which creates a multivariate normal random dataset and writes it to a file.
  1635. normal_dataset_test
  1636. normal_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) defining the normal probability density function (PDF).
  1637. normal_ode_test
  1638. 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.
  1639. normal01_multivariate_distance_test
  1640. 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.
  1641. numgrid_test
  1642. obj_display, a MATLAB code which displays an OBJ 3D graphics file;
  1643. obj_display_test
  1644. obj_io, a MATLAB code which reads and writes the data in an OBJ 3D graphics file;
  1645. obj_io_test
  1646. 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.
  1647. obj_to_tri_surface_test
  1648. octopus, a MATLAB code which contains some Octave utilities.
  1649. octopus_test
  1650. 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.
  1651. ode_euler_test
  1652. 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.
  1653. ode_euler_backward_test
  1654. 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.
  1655. ode_euler_system_test
  1656. 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.
  1657. ode_midpoint_test
  1658. 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.
  1659. ode_midpoint_system_test
  1660. 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.
  1661. ode_rk4_test
  1662. 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.
  1663. ode_trapezoidal_test
  1664. 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).
  1665. ode_sweep_parfor_test
  1666. 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.
  1667. ode_trapezoidal_test
  1668. 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.
  1669. 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.
  1670. 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].
  1671. opt_golden_test
  1672. 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.
  1673. opt_gradient_descent_test
  1674. 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.
  1675. opt_quadratic_test
  1676. 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.
  1677. opt_sample_test
  1678. 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.
  1679. oregonator_ode_test
  1680. 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.
  1681. ornstein_uhlenbeck_test
  1682. oscillator_ode, a MATLAB code which sets up and solves the highly oscillatory ordinary differential equation (ODE).
  1683. oscillator_ode_test
  1684. outliers_test, a MATLAB code which uses the isoutlier() function, and other techniques, to identify outliers in data.
  1685. 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.
  1686. ozone_ode_test
  1687. 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.
  1688. ozone2_ode_test
  1689. 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.
  1690. padua_test
  1691. pagerank, a MATLAB code which uses the eigenvalue (power method) and surfer (Markov Chain Monte Carlo MCMC) approaches to ranking web pages.
  1692. pagerank_test
  1693. pagerank2, a MATLAB code which considers a specific application of the page rank algorithm.
  1694. pagerank2_test
  1695. paraheat_functional, a MATLAB code which sets up and solves a parameterized steady heat equation in a 2D spatial domain, using diffusivity parameterized by vc, and reporting selected solution values vs, using a functional framework vs=f(vc).
  1696. paraheat_functional_test
  1697. 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.
  1698. pariomino_test
  1699. partial_digest, a MATLAB code which seeks solutions of the partial digest problem.
  1700. partial_digest_test
  1701. 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.
  1702. partition_brute_test
  1703. 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.
  1704. partition_greedy_test
  1705. 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.
  1706. patterson_rule_test
  1707. pbma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
  1708. pbma_io_test
  1709. 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.
  1710. pce_burgers_test
  1711. 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.
  1712. pce_legendre_test
  1713. 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.
  1714. pce_ode_hermite_test
  1715. pdepe_test, a MATLAB code which uses pdepe(), which solves an initial boundary value problem (IBVP) in one spatial dimension.
  1716. 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.
  1717. pdflib_test
  1718. peaks_movie, a MATLAB code which creates a sequence of frames, and then an animation or movie from the data displayed by the peaks() function.
  1719. peaks_movie_test
  1720. 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.
  1721. pendulum_comparison_ode_test
  1722. pendulum_double_ode, a MATLAB code which sets up and solves the double pendulum ordinary differential equation (ODE).
  1723. pendulum_double_ode_test
  1724. 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.
  1725. pendulum_double_ode_movie_test
  1726. 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.
  1727. pendulum_elastic_ode_test
  1728. pendulum_nonlinear_exact, a MATLAB code which evaluates an exact formula y(t) 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, y''=-G/L sin(y).
  1729. pendulum_nonlinear_exact_test
  1730. 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.
  1731. pendulum_nonlinear_ode_test
  1732. 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.
  1733. pendulum_ode_test
  1734. 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.
  1735. pendulum_ode_period_test
  1736. pentominoes, a MATLAB code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
  1737. pentominoes_test
  1738. perceptron_test, a MATLAB code which calculates a classifier of linearly separable data using the perceptron algorithm.
  1739. 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.
  1740. percolation_simulation_test
  1741. 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.
  1742. permutation_distance_test
  1743. persistence, a MATLAB code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
  1744. persistence_test
  1745. pgma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
  1746. pgma_io_test
  1747. pi_spigot, a MATLAB code which produces any number of digits of the decimal expansion of pi.
  1748. pi_spigot_test
  1749. 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.
  1750. pic_test
  1751. pink_noise, a MATLAB code which computes a pink noise signal obeying a 1/f power law.
  1752. pink_noise_test
  1753. plasma_matrix, a MATLAB code which sets up a matrix associated with a problem in plasma physics.
  1754. plasma_matrix_test
  1755. ply_display, a MATLAB code which displays an image of a 3D graphics file in PLY format;
  1756. ply_display_test
  1757. ply_io, a MATLAB code which reads or writes a 3D graphics file in PLY format, by Greg Turk;
  1758. ply_io_test
  1759. ply_to_tri_surface, a MATLAB code which reads a PLY file describing a 3D polygonal mesh, and reformulates the surface mesh data as 3D mesh of triangles, a TRI_SURFACE dataset.
  1760. ply_to_tri_surface_test
  1761. poisson_1d, a MATlAB code which solves a discretized version of the Poisson equation -uxx = f(x) on the interval a ≤ x ≤ b, with Dirichlet boundary conditions u(a) = ua, u(b) = ub. The linear system is solved using Gauss-Seidel iteration.
  1762. poisson_1d_test
  1763. poisson_1d_multigrid, a MATLAB code which applies the multigrid method to a discretized version of the 1D Poisson equation.
  1764. poisson_1d_multigrid_test
  1765. poisson_2d, a MATLAB code which solves the Poisson equation in a rectangle, using finite differences and Jacobi iteration.
  1766. poisson_2d_test
  1767. poisson_2d_exact, a MATLAB code which evaluates exact solutions u(x,y) to the Poisson partial differential equation (PDE): del^2 U = f(x,y) over a specified region with given boundary conditions.
  1768. poisson_2d_exact_test
  1769. 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.
  1770. poisson_simulation, a MATLAB code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda.
  1771. poisson_simulation_test
  1772. 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.
  1773. polar_ode_test
  1774. 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, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Number, Tau, Tribonacci, Zernike.
  1775. polpak_test
  1776. 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.
  1777. polygon_test
  1778. 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.
  1779. polygon_average_test
  1780. 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.
  1781. polygon_distance_test
  1782. polygon_grid, a MATLAB code which generates a grid of points over the interior of a polygon in 2D.
  1783. polygon_grid_test
  1784. polygon_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
  1785. polygon_integrals_test
  1786. polygon_minkowski, a MATLAB code which converts polygons between the vertex representation and the Minkowski representation, which uses a sequence of (non-unit) normal vectors.
  1787. polygon_minkowski_test
  1788. 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.
  1789. polygon_monte_carlo_test
  1790. polygon_sample, a MATLAB code which uniformly samples points in a polygon.
  1791. polygon_sample_test
  1792. polygon_triangulate, a MATLAB code which triangulates a (possibly nonconvex) polygon in 2D, based on a C program by Joseph ORourke;
  1793. polygon_triangulate_test
  1794. polygonal_surface_display, a MATLAB code which displays a surface in 3D described as a set of polygons;
  1795. polygonal_surface_display_test
  1796. polyiamonds, a MATLAB code which works with polyiamonds, simple shapes constructed by edgewise connections of congruent equilateral triangles.
  1797. polyiamonds_test
  1798. polynomial, a MATLAB code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  1799. polynomial_test
  1800. polynomial_conversion, a MATLAB code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
  1801. polynomial_conversion_test
  1802. polynomial_multiply, a MATLAB code which multiplies two polynomials p(x) and q(x).
  1803. polynomial_multiply_test
  1804. polynomial_resultant, a MATLAB code which computes the resultant R of univariate polynomials P and Q.
  1805. polynomial_resultant_test
  1806. polynomial_resultant_symbolic_test, a MATLAB code which calls the symbolic function resultant(), which computes the resultant R of univariate polynomials P and Q.
  1807. polynomial_root_bound, a MATLAB code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
  1808. polynomial_root_bound_test
  1809. 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.
  1810. polynomials_test
  1811. polyomino_parity, a MATLAB code which uses parity considerations to determine whether a given set of polyominoes tile a specified region.
  1812. polyomino_parity_test
  1813. 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.
  1814. polyominoes_test
  1815. porous_medium_exact, a MATLAB code which returns an exact solution u(x,t) of the porous medium equation (PME), related to the diffusion equation, and based on the Barenblatt solution. The partial differential equation (PDE) has the form dudt=Del^2(u^m). This system reduces to a diffusion equation if the exponent m is set to 1.
  1816. porous_medium_exact_test
  1817. power_method, a MATLAB code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  1818. power_method_test
  1819. power_rule, a MATLAB code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
  1820. power_rule_test
  1821. 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!
  1822. ppma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
  1823. ppma_io_test
  1824. 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.
  1825. pram_test
  1826. 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.
  1827. 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.
  1828. praxis, a MATLAB code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
  1829. praxis_test
  1830. 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.
  1831. predator_prey_ode_test
  1832. 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.
  1833. predator_prey_ode_period_test
  1834. 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.
  1835. prime_test
  1836. prime_factors, a MATLAB code which returns a list of the prime factors of an integer.
  1837. prime_factors_test
  1838. prime_fermat, a MATLAB code which applies Fermat's primality test to an integer n, which always correctly identifies primes, but sometimes also accepts nonprimes. Nonetheless, the test is useful for weeding out most nonprimes. The accuracy of the test can be improved by running it for several bases.
  1839. prime_fermat_test
  1840. prime_parfor, a MATLAB code which counts primes between 1 and N, running in parallel using the parfor() feature of MATLAB.
  1841. prime_parfor_test
  1842. prime_pi, a MATLAB code which evaluates Pi(n), the number of primes less than or equal to an integer n.
  1843. prime_pi_test
  1844. prime_plot, a MATLAB code which displays a box plot of the prime and composite numbers.
  1845. prime_plot_test
  1846. 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.
  1847. prism_jaskowiec_rule_test
  1848. 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.
  1849. prism_witherden_rule_test
  1850. 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.
  1851. prob_test
  1852. product_rule, a MATLAB code which creates an M dimensional quadrature rule from a product of distinct 1d quadrature rules;
  1853. product_rule_test
  1854. profile_data, a MATLAB code which returns the (x,y) coordinates of points that came from tracing the profile of a face.
  1855. profile_data_test
  1856. profile_interp, a MATLAB code which interpolates (x,y) data that came from tracing the profile of a face.
  1857. profile_interp_test
  1858. puzzles, a MATLAB code which solves simple puzzles;
  1859. pwc_plot_1d, a MATLAB code which converts the definition of a piecewise constant (PWC) function of a 1D argument into plottable data.
  1860. pwc_plot_1d_test
  1861. pwc_plot_2d, a MATLAB code which converts the definition of a piecewise constant (PWC) function of a 2D argument into plottable data.
  1862. pwc_plot_2d_test
  1863. pwl_approx_1d, a MATLAB code which approximates a set of data using a piecewise linear (PWL) function.
  1864. pwl_approx_1d_test
  1865. pwl_interp_1d, a MATLAB code which interpolates a set of data using a piecewise linear (PWL) function.
  1866. pwl_interp_1d_test
  1867. pwl_interp_2d, a MATLAB code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
  1868. pwl_interp_2d_test
  1869. 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.
  1870. pwl_interp_2d_scattered_test
  1871. 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).
  1872. pwl_product_integral_test
  1873. pyramid_exactness, a MATLAB code which investigates the polynomial exactness of a quadrature rule over the interior of the unit pyramid in 3D.
  1874. pyramid_exactness_test
  1875. pyramid_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
  1876. pyramid_felippa_rule_test
  1877. pyramid_grid, a MATLAB code which computes a grid of points over the interior of the unit pyramid in 3D;
  1878. pyramid_grid_test
  1879. 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.
  1880. pyramid_integrals_test
  1881. 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.
  1882. pyramid_jaskowiec_rule_test
  1883. 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;
  1884. pyramid_monte_carlo_test
  1885. pyramid_rule, a MATLAB code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D.
  1886. pyramid_rule_test
  1887. 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.
  1888. pyramid_witherden_rule_test
  1889. qr_solve, a MATLAB code which computes the linear least squares (LLS) solution of a system A*x=b using the QR factorization.
  1890. qr_solve_test
  1891. quad_fast_rule, a MATLAB code which rapidly defines certain quadrature rules for approximating an integral;
  1892. quad_fast_rule_test
  1893. 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].
  1894. quad_gauss_test
  1895. 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].
  1896. quad_monte_carlo_test
  1897. quad_parfor, a MATLAB code which estimates an integral using quadrature, using parfor() to enable parallel execution.
  1898. quad_parfor_test
  1899. quad_rule, a MATLAB code which defines quadrature rules for approximating an integral;
  1900. quad_rule_test
  1901. quad_serial, a MATLAB code which applies a quadrature rule to estimate an integral, intended as a starting point for parallelization exercises.
  1902. quad_serial_test
  1903. 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].
  1904. quad_trapezoid_test
  1905. quad2d, a MATLAB code which estimates an integral over a 2D rectangle using quadrature, intended as the starting point for program optimization or parallelization.
  1906. quad2d_test
  1907. 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.
  1908. quadex_ode_test
  1909. 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).
  1910. quadmom_test
  1911. quadprog_test, a MATLAB code which calls quadprog() to solve problems in quadratic programming.
  1912. quadrature_golub_welsch, a MATLAB code which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure.
  1913. quadrature_golub_welsch_test
  1914. 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.
  1915. quadrature_least_squares_test
  1916. 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.
  1917. quadrature_weights_vandermonde_test
  1918. 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.
  1919. quadrature_weights_vandermonde_2d_test
  1920. quadrilateral, a MATLAB code which carries out geometric calculations on quadrilaterals, including angles, area, distances, nearest point, point containment, perimeter, and random generation.
  1921. quadrilateral_test
  1922. quadrilateral_mesh, a MATLAB code which handles meshes of quadrilaterals over a 2D region;
  1923. quadrilateral_mesh_test
  1924. quadrilateral_mesh_order1_display, a MATLAB code which plots piecewise constant (PWC) data associated with a mesh of quadrilaterals;
  1925. quadrilateral_mesh_order1_display_test
  1926. quadrilateral_mesh_rcm, a MATLAB code which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
  1927. quadrilateral_mesh_rcm_test
  1928. 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;
  1929. quadrilateral_surface_display_test
  1930. quadrilateral_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
  1931. quadrilateral_witherden_rule_test
  1932. quality, a MATLAB code which measures the dispersion of pointsets in M dimensions;
  1933. quality_test
  1934. quasiperiodic_ode, a MATLAB code which sets up and solves a system of ordinary differential equations (ODE) for a problem with a quasiperiodic solution.
  1935. quasiperiodic_ode_test
  1936. quaternions, a MATLAB code which carries out some simple arithmetic operations for quaternions.
  1937. quaternions_test
  1938. r8_scale, a MATLAB code which computes the "next" and "previous" real numbers.
  1939. r8_scale_test
  1940. r83, a MATLAB code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
  1941. r83_test
  1942. r83_np, a MATLAB code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
  1943. r83_np_test
  1944. r83p, a MATLAB code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
  1945. r83p_test
  1946. r83s, a MATLAB code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
  1947. r83s_test
  1948. r83t, a MATLAB code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
  1949. r83t_test
  1950. r83v, a MATLAB code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
  1951. r83v_test
  1952. r85, a MATLAB code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
  1953. r85_test
  1954. r8bb, a MATLAB code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
  1955. r8bb_test
  1956. r8blt, a MATLAB code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
  1957. r8blt_test
  1958. r8bto, a MATLAB code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
  1959. r8bto_test
  1960. r8but, a MATLAB code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
  1961. r8but_test
  1962. r8cb, a MATLAB code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
  1963. r8cb_test
  1964. r8cbb, a MATlAB code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
  1965. r8cbb_test
  1966. r8ccs, a MATLAB code which contains linear algebra routines for r8ccs matrices: real, 64 bit, Compressed Column Storage (CCS) format.
  1967. r8ccs_test
  1968. r8ci, a MATLAB code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
  1969. r8ci_test
  1970. 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.
  1971. r8col_test
  1972. r8crs, a MATLAB code which contains linear algebra routines for R8CRS matrices: real, 64 bit, Compressed Row Storage (CRS) format.
  1973. r8crs_test
  1974. r8gb, a MATLAB code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
  1975. r8gb_test
  1976. r8gd, a MATLAB code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
  1977. r8gd_test
  1978. r8ge, a MATLAB code which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).
  1979. r8ge_test
  1980. r8ge_np, a MATLAB code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
  1981. r8ge_np_test
  1982. r8lib, a MATLAB code which contains utilities for real 64 bit (R8) arithmetic.
  1983. r8lib_test
  1984. r8lt, a MATLAB code which contains linear algebra routines for R8LT matrices: real, 64 bit, Lower Triangular.
  1985. r8lt_test
  1986. r8ltt, a MATLAB code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
  1987. r8ltt_test
  1988. r8ncf, a MATLAB code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
  1989. r8ncf_test
  1990. r8pbl, a MATLAB code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
  1991. r8pbl_test
  1992. r8pbu, a MATLAB code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
  1993. r8pbu_test
  1994. r8po, a MATLAB code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
  1995. r8po_test
  1996. 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.
  1997. r8poly_test
  1998. r8pp, a MATLAB code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
  1999. r8pp_test
  2000. r8ri, a MATLAB code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
  2001. r8ri_test
  2002. 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.
  2003. r8row_test
  2004. r8sd, a MATLAB code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
  2005. r8sd_test
  2006. r8sm, a MATLAB code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
  2007. r8sm_test
  2008. r8sr, a MATLAB code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
  2009. r8sr_test
  2010. r8ss, a MATLAB code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
  2011. r8ss_test
  2012. r8st, a MATLAB code which contains linear algebra routines for R8ST matrices: real, 64 bit, Sparse Triplet.
  2013. r8st_test
  2014. r8sto, a MATLAB code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
  2015. r8sto_test
  2016. r8to, a MATLAB code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
  2017. r8to_test
  2018. r8ut, a MATLAB code which contains linear algebra routines for r8ut matrices: real, 64 bit, Upper Triangular.
  2019. r8ut_test
  2020. r8utp, a MATLAB code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
  2021. r8utp_test
  2022. r8utt, a MATLAB code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
  2023. r8utt_test
  2024. r8vm, a MATLAB code which contains linear algebra routines for r8vm matrices (real, 64 bit, vandermonde format).
  2025. r8vm_test
  2026. randlc, a MATLAB code which implements a random number generator (RNG) used by the nas() benchmarks.
  2027. randlc_test
  2028. 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.
  2029. random_data_test
  2030. random_sorted, a MATLAB code which generates vectors of random values which are already sorted.
  2031. random_sorted_test
  2032. random_walk_1d_simulation, a MATLAB code which simulates a random walk in a 1-dimensional region.
  2033. random_walk_1d_simulation_test
  2034. random_walk_2d_avoid_simulation, a MATLAB code which simulates a self-avoiding random walk in a 2-dimensional region.
  2035. random_walk_2d_avoid_simulation_test
  2036. random_walk_2d_simulation, a MATLAB code which simulates a random walk in a 2-dimensional region.
  2037. random_walk_2d_simulation_test
  2038. random_walk_3d_simulation, a MATLAB code which simulates a random walk in a 3-dimensional region.
  2039. random_walk_3d_simulation_test
  2040. 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.
  2041. ranlib_test
  2042. rbf_interp_1d, a MATLAB code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
  2043. rbf_interp_1d_test
  2044. rbf_interp_2d, a MATLAB code which defines radial basis function (RBF) interpolants to 2D data.
  2045. rbf_interp_2d_test
  2046. rbf_interp_nd, a MATLAB code which defines and evaluates radial basis function (RBF) interpolants to M dimensional data.
  2047. rbf_interp_nd_test
  2048. rcm, a MATLAB code which applies the Reverse Cuthill McKee (RCM) algorithm for reordering the nodes of a graph, and reducing the bandwidth of a corresponding sparse matrix;
  2049. rcm_test
  2050. 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.
  2051. reaction_ode_test
  2052. 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.
  2053. reaction_twoway_ode_test
  2054. 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."
  2055. reactor simulation_test
  2056. 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.
  2057. 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.
  2058. 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.
  2059. rectangle_distance_test
  2060. region_test, a MATLAB code which plots data from an interesting region that was meshed by FreeFem++() and transferred using the ffmatlib() library.
  2061. reid_tiling, a MATLAB code which uses the reduced row echelon form (RREF) to determine solutions to the problem of tiling the Reid polyomino.
  2062. reid_tiling_test
  2063. rejection_sample, a MATLAB code which demonstrates acceptance/rejection sampling.
  2064. rejection_sample_test
  2065. reversi_game, a MATLAB code which sets up a match of the game reversi (also called Othello) between the computer and a player, using MATLAB graphics.
  2066. 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.
  2067. rigid_body_ode_test
  2068. ring_data, a MATLAB code which creates, plots, or saves data generated by sampling a number of concentric, possibly overlapping rings.
  2069. ring_data_test
  2070. ripple_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) whose solutions start as ripples and end as hyperbolas.
  2071. ripple_ode_test
  2072. risk_matrix, a MATLAB code which returns the transition and adjacency matrix for the game of RISK.
  2073. risk_matrix_test
  2074. rk1, a MATLAB code which solves one or more ordinary differential equations (ODE) using an explicit Runge-Kutta method of order 1, usually known as Euler's explicit method.
  2075. rk1_test
  2076. rk1_implicit, a MATLAB code which solves one or more ordinary differential equations (ODE) using the Runge-Kutta order 1 implicit method, using fsolve() to solve the implicit equation, and using a fixed time step. rk1_implicit() is commonly called the backward Euler method.
  2077. rk1_implicit_test
  2078. 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.
  2079. rk12_test
  2080. rk12_adapt, a MATLAB code which defines an adaptive ordinary differential equation (ODE) solver, using Runge-Kutta (RK) solvers of order 1 and 2.
  2081. rk12_adapt_test
  2082. rk2, a MATLAB code which solves one or more ordinary differential equations (ODE) using an explicit Runge-Kutta method of order 2, also known as Heun's method, the modified Euler method, or the explicit midpoint method.
  2083. rk2_test
  2084. rk2_implicit, a MATLAB code which solves one or more ordinary differential equations (ODE) using the Runge-Kutta order 2 implicit method, using fsolve() to solve the implicit equation, and using a fixed time step. rk2_implicit() is also known as the implicit midpoint method.
  2085. rk2_implicit_test
  2086. rk23, a MATLAB code which applies Runge-Kutta (RK) solvers of order 2 and 3 to a system of ordinary differential equations (ODE);
  2087. rk23_test
  2088. rk3, a MATLAB code which solves one or more ordinary differential equations (ODE) using an explicit Runge-Kutta method of order 3.
  2089. rk3_test
  2090. rk34, a MATLAB code which applies Runge-Kutta (RK) solvers of order 3 and 4 to a system of ordinary differential equations (ODE);
  2091. rk34_test
  2092. 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.
  2093. rk4_test
  2094. rk45, a MATLAB code which applies Runge-Kutta (RK) solvers of order 4 and 5 to a system of ordinary differential equations (ODE);
  2095. rk45_test
  2096. rkf45, a MATLAB code which applies a Runge-Kutta-Fehlberg (RKF) solver to a system of ordinary differential equations (ODE);
  2097. rkf45_test
  2098. rng_cliff, a MATLAB code which computes a sequence of values from the Cliff random number generator (RNG).
  2099. rng_cliff_test
  2100. 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.
  2101. rnglib_test
  2102. 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.
  2103. robertson_ode_test
  2104. roessler_ode, a MATLAB code which sets up and solves the right hand side of the 3D Roessler system of ordinary differential equations (ODE).
  2105. roessler_ode_test
  2106. root_rc, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Gaston Gonnet.
  2107. root_rc_test
  2108. roots_rc, a MATLAB code which seeks solutions of a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.
  2109. roots_rc_test
  2110. rot13, a MATLAB code which enciphers a string using the ROT13 cipher for letters, and the ROT5 cipher for digits.
  2111. rot13_test
  2112. roulette_simulation, a MATLAB code which simulates the spinning of a roulette wheel and the evaluation of certain common roulette bets.
  2113. roulette_simulation_test
  2114. 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.
  2115. row_echelon_integer_test
  2116. rref_test, a MATLAB code which calls rref(), which is a built-in function for the reduced row echelon form (RREF) of a matrix, which can be singular or rectangular.
  2117. rref2, a MATLAB code which involves a user-written approach to compute the reduced row echelon form (RREF) of a matrix, which can be used to analyze matrices which are square or rectangular, singular or invertible.
  2118. rref2_test
  2119. 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.
  2120. rubber_band_ode_test
  2121. 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.
  2122. rucklidge_ode_test
  2123. runge, a MATLAB code which evaluates the Runge() function, its first and second derivatives, and its antiderivative. This function causes a breakdown for polynomial interpolation over equally spaced nodes in [-1,+1].
  2124. runge_test
  2125. sammon_data, a MATLAB code which generates six M dimensional datasets for cluster analysis.
  2126. sammon_data_test
  2127. sandia_cubature, a MATLAB code which computes M-dimensional quadrature rules for certain regions and weight functions.
  2128. sandia_cubature_test
  2129. 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.
  2130. sandia_rules_test
  2131. sandia_sgmgg, a MATLAB code which explores a generalized construction method for sparse grids.
  2132. sandia_sgmgg_test
  2133. 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.
  2134. sandia_sparse_test
  2135. 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.
  2136. satisfy_brute_test
  2137. 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.
  2138. satisfy_parfor_test
  2139. 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).
  2140. sawtooth_ode_test
  2141. 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.
  2142. schroedinger_linear_pde_test
  2143. 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.
  2144. schroedinger_nonlinear_pde_test
  2145. 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.
  2146. scip_solution_read_test
  2147. sde, a MATLAB code which illustrates properties of stochastic ordinary differential equations (SDE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;
  2148. sde_test
  2149. search_test, a MATLAB code which searches integers between A and B for a value J such that F(J) = C.
  2150. sensitive_ode, a MATLAB code which sets up a second order ordinary differential equation (ODE) which exhibits sensitive dependence on the initial condition.
  2151. sensitive_ode_test
  2152. 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.
  2153. serenity_test
  2154. 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.
  2155. 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.
  2156. set_theory, a MATLAB code which implements set theory operations such as union, intersection, complement, symmetric difference.
  2157. set_theory_test
  2158. sftpack, a MATLAB code which implements the slow Fourier transform (SFT), intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
  2159. sftpack_test
  2160. shallow_water_1d, a MATLAB code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations (SWE).
  2161. shallow_water_1d_test
  2162. 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().
  2163. shallow_water_1d_display_test
  2164. 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.
  2165. shallow_water_1d_movie_test
  2166. shepard_interp_1d, a MATLAB code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
  2167. shepard_interp_1d_test
  2168. shepard_interp_2d, a MATLAB code which defines and evaluates Shepard interpolants to 2D data, based on inverse distance weighting.
  2169. shepard_interp_2d_test
  2170. shepard_interp_nd, a MATLAB code which defines and evaluates Shepard interpolants to M dimensional data, based on inverse distance weighting.
  2171. shepard_interp_nd_test
  2172. sierpinski_carpet_chaos, a MATLAB code which creates a dot-plot of the Sierpinski carpet by repeatedly applying a randomized linear transformation to a starting point.
  2173. sierpinski_carpet_chaos_test
  2174. sierpinski_triangle_chaos, a MATLAB code which creates a dot-plot of the Sierpinski triangle by repeatedly applying a randomized linear transformation to a starting point.
  2175. sierpinski_triangle_chaos_test
  2176. sigmoid, a MATLAB code which evaluates derivatives of any order for the sigmoid function s(x)=1/(1+exp(-x)).
  2177. sigmoid_test
  2178. simplex_coordinates, a MATLAB code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  2179. simplex_coordinates_test
  2180. 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.
  2181. simplex_gm_rule_test
  2182. simplex_grid, a MATLAB code which generates a regular grid of points over the interior of an arbitrary simplex in M dimensions.
  2183. simplex_grid_test
  2184. 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.
  2185. simplex_integrals_test
  2186. 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.
  2187. simplex_monte_carlo_test
  2188. sinc, a MATLAB code which evaluates the sinc() function, its first and second derivative and its antiderivative. The normalized function is defined by sincn=sin(pi*x)/(pi*x), the unnormalized function is sincu=sin(x)/x. Plots of these functions are made.
  2189. sinc_test
  2190. sine_gordon_exact, a MATLAB code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
  2191. sine_gordon_exact_test
  2192. sine_integral, a MATLAB code which evaluates the Sine Integral, by Shanjie Zhang, Jianming Jin;
  2193. sine_integral_test
  2194. sine_transform, a MATLAB code which demonstrates properties of the discrete sine transform (DST).
  2195. sine_transform_test
  2196. single_linkage_test, a MATLAB code which uses the MATLAB single linkage clustering functions.
  2197. 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.
  2198. sir_ode_test
  2199. 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.
  2200. sir_simulation_test
  2201. slap_io, a MATLAB code which reads and writes sparse matrix files in the SLAP format;
  2202. slap_io_test
  2203. 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.
  2204. sling_ode_test
  2205. smolyak_display, a MATLAB code which displays the exactness diagram for a 2D Smolyak sparse grid, by displaying and summing the exactness diagrams for the component product rules.
  2206. smolyak_display_test
  2207. snakes_and_ladders, a MATLAB code which provides tools for studying the game of Snakes and Ladders.
  2208. 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.
  2209. snakes_and_ladders_simulation_test
  2210. snakes_game, a MATLAB code which simulates a one-player version of the game of Snakes and Ladders, by Mina Aymin.
  2211. snakes_matrix, a MATLAB code which returns the transition matrix for the game of Snakes and Ladders.
  2212. snakes_matrix_test
  2213. snakes_probability, a MATLAB code which computes the game length probabilities for the game of Snakes and Ladders, by Desmond Higham and Nicholas Higham.
  2214. snakes_probability_test
  2215. sncndn, a MATLAB code which evaluates the Jacobi elliptic functions sn(u,m), cn(u,m), and dn(u,m).
  2216. sncndn_test
  2217. sobol, a MATLAB code which generates elements of the Sobol M dimensional Quasi Mont Carlo (QMC) sequence, by Bennett Fox.
  2218. sobol_test
  2219. solve, a MATLAB code which uses Gauss elimination to solve a linear system A*x=b.
  2220. solve_test
  2221. sor, a MATLAB code which uses the successive over-relaxation (SOR) iteration to solve a linear system of equations.
  2222. sor_test
  2223. sort_rc, a MATLAB code which sorts a list of any kind of objects, using reverse communication (RC).
  2224. sort_rc_test
  2225. sort_test, a MATLAB code which calls the sort() function to sort objects of several types.
  2226. sparse_test, a MATLAB code which tests the sparse() function for creating sparse matrices and carrying out linear algebraic functions on them;
  2227. sparse_count, a MATLAB code which analyzes sparse grids in which a single family of 1D quadrature rules is used for all spatial dimensions, with a variety of growth rules.
  2228. sparse_count_test
  2229. 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.
  2230. sparse_display_test
  2231. sparse_grid_cc, a MATLAB code which creates sparse grids based on Clenshaw-Curtis (CC) quadrature rules.
  2232. sparse_grid_cc_test
  2233. sparse_grid_gl, a MATLAB code which creates sparse grids based on Gauss-Legendre (GL) rules.
  2234. sparse_grid_gl_test
  2235. sparse_grid_hermite, a MATLAB code which creates sparse grids based on Gauss-Hermite rules.
  2236. sparse_grid_hermite_test
  2237. 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.
  2238. sparse_grid_hw_test
  2239. sparse_grid_laguerre, a MATLAB code which creates sparse grids based on Gauss-Laguerre rules.
  2240. sparse_grid_laguerre_test
  2241. sparse_grid_mixed, a MATLAB code which creates a sparse grid dataset based on a mixed set of 1D factor rules.
  2242. sparse_grid_mixed_test
  2243. sparse_grid_total_poly, a MATLAB code which investigates the total polynomial approximation using sparse grids.
  2244. sparse_grid_total_poly_test
  2245. sparse_interp_nd, a MATLAB code which defines a sparse interpolant to a function f(x) of a M dimensional argument.
  2246. sparse_interp_nd_test
  2247. 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.
  2248. sparse_parfor_test
  2249. spd_test, a MATLAB code which performs a few tests on a real matrix to determine whether it is symmetric positive definite (SPD).
  2250. 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.
  2251. sphere_cubed_grid_test
  2252. sphere_cvt, a MATLAB code which carries out the Centroidal Voronoi Tessellation (CVT) iteration on the surface of the unit sphere in 3D.
  2253. sphere_cvt_test
  2254. sphere_delaunay, a MATLAB code which computes the Delaunay triangulation of points on the surface of the unit sphere in 3D.
  2255. sphere_delaunay_test
  2256. 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.
  2257. sphere_distance_test
  2258. sphere_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule on the surface of the unit sphere in 3D.
  2259. sphere_exactness_test
  2260. 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.
  2261. sphere_fibonacci_grid_test
  2262. 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.
  2263. sphere_grid_test
  2264. 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.
  2265. sphere_integrals_test
  2266. sphere_lebedev_rule, a MATLAB code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
  2267. sphere_lebedev_rule_test
  2268. 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.
  2269. sphere_lebedev_rule_display_test
  2270. 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.
  2271. sphere_llq_grid_test
  2272. 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.
  2273. sphere_llt_grid_test
  2274. 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.
  2275. sphere_monte_carlo_test
  2276. 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.
  2277. sphere_positive_distance_test
  2278. sphere_quad, a MATLAB code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
  2279. sphere_quad_test
  2280. 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.
  2281. sphere_stereograph_test
  2282. 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.
  2283. sphere_stereograph_display_test
  2284. 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;
  2285. sphere_triangle_monte_carlo_test
  2286. 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.
  2287. sphere_triangle_quad_test
  2288. sphere_voronoi, a MATLAB code which computes the Voronoi diagram of points on the surface of the unit sphere in 3D.
  2289. sphere_voronoi_test
  2290. spherical_harmonic, a MATLAB code which evaluates spherical harmonic functions.
  2291. spherical_harmonic_test
  2292. 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.
  2293. spinterp_test
  2294. 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.
  2295. spiral_pde_test
  2296. 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.
  2297. spiral_pde_movie_test
  2298. spline, a MATLAB code which interpolates and approximates via splines;
  2299. spline_test
  2300. 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.
  2301. spquad_test
  2302. 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.
  2303. spring_double_ode_test
  2304. 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.
  2305. spring_ode_test
  2306. 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.
  2307. spring_sweep_ode_test
  2308. 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.
  2309. square_arbq_rule_test
  2310. 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.
  2311. square_distance_test
  2312. 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.
  2313. square_exactness_test
  2314. square_felippa_rule, a MATLAB code which returns Felippa quadrature rules for approximating integrals over the interior of a square in 2D.
  2315. square_felippa_rule_test
  2316. square_grid, a MATLAB code which computes a grid of points over the interior of a square in 2D.
  2317. square_grid_test
  2318. square_hex_grid, a MATLAB code which computes a hexagonal grid of points over the interior of a square in 2D.
  2319. square_hex_grid_test
  2320. 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.
  2321. square_integrals_test
  2322. 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.
  2323. square_minimal_rule_test
  2324. 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.
  2325. square_monte_carlo_test
  2326. 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.
  2327. square_surface_distance_test
  2328. 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.
  2329. square_symq_rule_test
  2330. 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).
  2331. squircle_ode_test
  2332. st_io, a MATLAB code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
  2333. st_io_test
  2334. st_to_ccs, a MATLAB code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format;
  2335. st_to_ccs_test
  2336. st_to_hb, a MATLAB code which converts sparse matrix data from Sparse Triplet (ST) format to Harwell Boeing (HB) format;
  2337. st_to_hb_test
  2338. st_to_mm, a MATLAB code which converts sparse matrix data from Sparse Triplet (ST) format to Matrix Market (MM) format;
  2339. st_to_mm_test
  2340. st_to_msm, a MATLAB code which reads a Sparse Triplet (ST) file and creates a corresponding MATLAB Sparse Matrix (MSM).
  2341. st_to_msm_test
  2342. standing_wave_exact, a MATLAB code which returns an exact standing wave solution u(x,t) of the partial differential equation (PDE): utt = c^2 uxx, describing a wave in a 1D spatial region with propagation speed c.
  2343. standing_wave_exact_test
  2344. 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. Plots are made of several of the functions.
  2345. steinerberger_test
  2346. 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.
  2347. stetter_ode_test
  2348. stiff_exact, a MATLAB code which returns an exact solution y(t) to a stiff ordinary differential equation (ODE) of the form y' = lambda * ( cos(t-t0) - y).
  2349. stiff_exact_test
  2350. stiff_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which is an example of a stiff ODE.
  2351. stiff_ode_test
  2352. stla_display, a MATLAB code which displays an ASCII stereolithography (STL) 3D graphics file;
  2353. stla_display_test
  2354. stla_io, a MATLAB code which reads and writes an ASCII stereolithography (STL) 3D graphics file;
  2355. stla_io_test
  2356. 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.
  2357. stla_to_tri_surface_test
  2358. stla_to_tri_surface_fast, a MATLAB code which is a faster version of stla_to_tri_surface().
  2359. stla_to_tri_surface_fast_test
  2360. stochastic_diffusion, a MATLAB code which implements several versions of a stochastic diffusivity coefficient.
  2361. stochastic_diffusion_test
  2362. stochastic_heat2d, a MATLAB code which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.
  2363. stochastic_heat2d_test
  2364. stochastic_rk, a MATLAB code which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SDE).
  2365. stochastic_rk_test
  2366. stokes_2d_exact, a MATLAB code which evaluates exact solutions (u,v,p)(x,y) to the incompressible steady Stokes equations in 2D, which are a system of partial differential equations (PDE) of the form: -uxx-uyy+px=f, -vxx-vyy+py=g, ux+vy=h.
  2367. stokes_2d_exact_test
  2368. 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().
  2369. string_pde_test
  2370. stroud_rule, 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.
  2371. stroud_rule_test
  2372. subpak, a MATLAB code which includes a number of utility routines.
  2373. subpak_test
  2374. 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.
  2375. subset_test
  2376. 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.
  2377. subset_distance_test
  2378. 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.
  2379. subset_sum_test
  2380. 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.
  2381. subset_sum_backtrack_test
  2382. subset_sum_brute, a MATLAB code which seeks solutions of the subset sum problem, using a brute force approach.
  2383. subset_sum_brute_test
  2384. subset_sum_swap, a MATLAB code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
  2385. subset_sum_swap_test
  2386. sudoku, a MATLAB code which handles Sudoku puzzles;
  2387. sudoku_test
  2388. supreme_vacancy, a MATLAB code which estimates the probablity that, during a 4 year term, at least one of the Supreme Court justices will die, creating a vacancy. A simple statistical model is used to create the probability of a person of given age and sex dying within a period of years.
  2389. supreme_vacancy_test,
  2390. surf_test, calls surf(), which displays a 3D surface or contour plot for data of the form Z=F(X,Y).
  2391. svd_basis, a MATLAB code which applies the singular value decomposition (SVD) to a collection of data vectors, extracting dominant modes;
  2392. svd_basis_test
  2393. 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).
  2394. svd_circle_test
  2395. svd_faces, a MATLAB code which applies singular value decomposition (SVD) analysis to a set of images.
  2396. svd_faces_test
  2397. 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.
  2398. svd_fingerprint_test
  2399. 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.
  2400. svd_gray_test
  2401. 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.
  2402. svd_lls_test
  2403. svd_powers, a MATLAB code which applies singular value decomposition (SVD) analysis to a set of powers x(i)^(j-1).
  2404. svd_powers_test
  2405. svd_snowfall, a MATLAB code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).
  2406. svd_snowfall_test
  2407. 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).
  2408. svd_sphere_test
  2409. svd_test, a MATLAB code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
  2410. 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.
  2411. 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.
  2412. t_puzzle_test
  2413. 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.
  2414. t_puzzle_gui, a MATLAB code which sets up a graphical user interface for the T puzzle, by Cleve Moler.
  2415. 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.
  2416. table_io, a MATLAB code which reads and writes a simple table file;
  2417. table_io_test
  2418. 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.
  2419. task_division_test
  2420. tec_io, a MATLAB code which reads or writes a tecplot() ASCII TEC file containing a model associated with the finite element method (FEM).
  2421. tec_io_test
  2422. tec_to_fem, a MATLAB code which converts a tecplot() ASCII TEC file into an FEM model.
  2423. tec_to_fem_test
  2424. tec_to_vtk, a MATLAB code which converts a tecplot() TEC file into a set of VTK files.
  2425. tec_to_vtk_test
  2426. tennis_matrix, a MATLAB code which computes the transition matrix for a game of tennis, which has 17 distinct states.
  2427. tennis_matrix_test
  2428. 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.
  2429. tensor_grid_display_test
  2430. test_approx, a MATLAB code which implements test problems for approximation, provided as a set of (x,y) data.
  2431. test_approx_test
  2432. test_con, a MATLAB code which implements test problems for numerical continuation.
  2433. test_con_test
  2434. test_eigen, a MATLAB code which implements test matrices for eigenvalue analysis.
  2435. test_eigen_test
  2436. test_int, a MATLAB code which implements test problems for approximate integration (quadrature) in one dimension.
  2437. test_int_test
  2438. test_int_2d, a MATLAB code which implements test problems for approximate integration (quadrature) in two dimensions.
  2439. test_int_2d_test
  2440. test_int_nd, a MATLAB code which defines test functions for M-dimensional quadrature routines.
  2441. test_int_nd_test
  2442. test_interp, a MATLAB code which defines test problems for interpolation, provided as a set of (x,y(x)) data.
  2443. test_interp_test
  2444. test_interp_1d, a MATLAB code which defines test problems for interpolation of data y(x), which depends on a 1D argument.
  2445. test_interp_1d_test
  2446. test_interp_2d, a MATLAB code which defines test problems for interpolation of data z(x,y), which depends on a 2D argument.
  2447. test_interp_2d_test
  2448. test_interp_fun, a MATLAB code which defines test problems for interpolation which are available in functional form.
  2449. test_interp_fun_test
  2450. test_interp_nd, a MATLAB code which defines test problems for interpolation of data z(x), depending on an M dimensional argument.
  2451. test_interp_nd_test
  2452. test_lls, a MATLAB code which implements linear least squares (LLS) test problems of the form A*x=b.
  2453. test_lls_test
  2454. 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.
  2455. test_matrix_test
  2456. test_matrix_exponential, a MATLAB code which defines a set of test cases for computing the matrix exponential.
  2457. test_matrix_exponential_test
  2458. test_min, a MATLAB code which implements test problems for minimization of a scalar function of a scalar variable.
  2459. test_min_test
  2460. test_nearest, a MATLAB code which tests the time complexity of various procedures for solving the nearest neighbor problem.
  2461. test_nearest_test
  2462. test_nonlin, a MATLAB code which implements test problems for the solution of systems of nonlinear equations.
  2463. test_nonlin_test
  2464. test_opt, a MATLAB code which implements test problems for optimization of a scalar function of several variables.
  2465. test_opt_test
  2466. 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.
  2467. test_opt_con_test
  2468. test_optimization, a MATLAB code which implements test problems for optimization of a scalar function of several variables, as described by Molga and Smutnicki.
  2469. test_optimization_test
  2470. test_partial_digest, a MATLAB code which generates example cases of the partial digest problem.
  2471. test_partial_digest_test
  2472. test_triangulation, a MATLAB code which defines test problems for triangulation;
  2473. test_triangulation_test
  2474. 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 Elliptic functions sn(), cn(), dn(), the Julian Ephemeris Date, Kelvin, Knapsack, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mersenne primes, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, 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.
  2475. test_values_test
  2476. test_zero, a MATLAB code which defines some functions f(x) suitable for testing software that solves a nonlinear equation f(x)=0;
  2477. test_zero_test
  2478. tester, a BASH script which runs the MATLAB tests.
  2479. tet_mesh, a MATLAB code which works with tetrahedral meshes in 3D;
  2480. tet_mesh_test
  2481. 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.
  2482. tet_mesh_boundary_test
  2483. tet_mesh_display, a MATLAB code which reads data defining a tetrahedral mesh, and displays a wireframe image of the nodes and edges;
  2484. tet_mesh_display_test
  2485. 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;
  2486. tet_mesh_l2q_test
  2487. 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;
  2488. tet_mesh_q2l_test
  2489. tet_mesh_quad, a MATLAB code which estimates the integral of a function over a region defined by a tetrahedral mesh.
  2490. tet_mesh_quad_test
  2491. tet_mesh_quality, a MATLAB code which computes various quality measures for a tetrahedral mesh of a set of nodes in 3D;
  2492. tet_mesh_quality_test
  2493. 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.
  2494. tet_mesh_rcm_test
  2495. tet_mesh_refine, a MATLAB code which refines a mesh of tetrahedrons;
  2496. tet_mesh_refine_test
  2497. tet_mesh_tet_neighbors, a MATLAB code which reads information about a tetrahedral mesh and lists the tetrahedrons adjacent to a given tetrahedron;
  2498. tet_mesh_tet_neighbors_test
  2499. tet_mesh_to_gmsh, a MATLAB code which write a gmsh() file describing a tetrahedral mesh;
  2500. tet_mesh_to_gmsh_test
  2501. tet_mesh_to_xml, a MATLAB code which write an XML file describing a tetrahedral mesh;
  2502. tet_mesh_to_xml_test
  2503. tet_mesh_volumes, a MATLAB code which computes the volume of each tetrahedron in a mesh of tetrahedrons;
  2504. tet_mesh_volumes_test
  2505. 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.
  2506. tetrahedron_test
  2507. 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.
  2508. tetrahedron_arbq_rule_test
  2509. tetrahedron_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.
  2510. tetrahedron_exactness_test
  2511. tetrahedron_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
  2512. tetrahedron_felippa_rule_test
  2513. tetrahedron_grid, a MATLAB code which computes a grid of points over the interior of a tetrahedron in 3D.
  2514. tetrahedron_grid_test
  2515. 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.
  2516. tetrahedron_integrals_test
  2517. 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.
  2518. tetrahedron_jaskowiec_rule_test
  2519. 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.
  2520. tetrahedron_keast_rule_test
  2521. 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.
  2522. tetrahedron_monte_carlo_test
  2523. tetrahedron_ncc_rule, a MATLAB code which defines Newton-Cotes closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
  2524. tetrahedron_ncc_rule_test
  2525. tetrahedron_nco_rule, a MATLAB code which defines Newton-Cotes open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
  2526. tetrahedron_nco_rule_test
  2527. tetrahedron_slice_display, a MATLAB code which determines the intersection between a tetrahedron and a plane and displays the result.
  2528. tetrahedron_slice_display_test
  2529. 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.
  2530. tetrahedron_slice_movie_test
  2531. tetrahedron_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
  2532. tetrahedron_witherden_rule_test
  2533. 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.
  2534. tetrahedron01_monte_carlo_test
  2535. 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.
  2536. theodolite_test
  2537. theta_method, a MATLAB code which solves one or more ordinary differential equations (ODE) using the theta method.
  2538. theta_method_test
  2539. 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.
  2540. three_body_ode_test
  2541. tictoc_test, a MATLAB code which calls tic() and toc(), which compute elapsed time.
  2542. timer_test, a MATLAB code which demonstrates and compares several ways of timing code execution.
  2543. timestamp, a MATLAB code which prints the current YMDHMS date as a timestamp;
  2544. timestamp_test
  2545. toeplitz_cholesky, a MATLAB code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
  2546. toeplitz_cholesky_test
  2547. toeplitz_inverse, a MATLAB code which computes the inverse of a Toeplitz matrix.
  2548. toeplitz_inverse_test
  2549. toms097, a MATLAB code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm.
  2550. toms097_test
  2551. 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.
  2552. toms112_test
  2553. 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.
  2554. toms178_test
  2555. toms179, a MATLAB code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
  2556. toms179_test
  2557. toms243, a MATLAB code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
  2558. toms243_test
  2559. toms291, a MATLAB code which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.
  2560. toms291_test
  2561. toms443, a MATLAB code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
  2562. toms443_test
  2563. toms446, a MATLAB code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
  2564. toms446_test
  2565. 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.
  2566. toms462_test
  2567. 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.
  2568. toms515_test
  2569. 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;
  2570. toms577_test
  2571. 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.
  2572. toms655_test
  2573. 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.
  2574. toms743_test
  2575. 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;
  2576. toms847_test
  2577. 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.
  2578. 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.
  2579. toms886_test
  2580. toms923, a MATLAB code which evaluates the Pfaffian for a dense or banded skew symmetric matrix, by Michael Wimmer.
  2581. toms923_test
  2582. toms1040, a MATLAB code which is the Sparse Grids Matlab Kit, by Chiara Piazzolo, Lorenzo Tamellini.
  2583. toms1040_test
  2584. toms1040_doc, a PDF document which describes ACM TOMS algorithm 1040, by Chiara Piazzolo, Lorenzo Tamellini.
  2585. toms1040_manual, a PDF document which is the user manual accompanying ACM TOMS algorithm 1040, "The Sparse Grids Matlab Kit user manual", by Chiara Piazzolo, Lorenzo Tamellini.
  2586. toms1040_manual_test
  2587. 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.
  2588. tortoise_test
  2589. 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.
  2590. 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.
  2591. 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.
  2592. tough_ode_test
  2593. traffic_simulation, a MATLAB code which simulates the cars waiting to get through a traffic light.
  2594. traffic_simulation_test
  2595. 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.
  2596. trapezoidal_test
  2597. trapezoidal_explicit, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (explicit) trapezoidal method.
  2598. trapezoidal_explicit_test
  2599. trapezoidal_fixed, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, using the fixed point method.
  2600. trapezoidal_fixed_test
  2601. traveling_wave_exact, a MATLAB code which returns an exact traveling wave solution u(x,t) of the partial differential equation (PDE): utt = c^2 uxx, describing a wave in a 1D spatial region with propagation speed c.
  2602. traveling_wave_exact_test
  2603. tree_chaos, a MATLAB code which creates a dot-plot of a tree by repeatedly applying a randomized linear transformation to a starting point.
  2604. tree_chaos_test
  2605. 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.
  2606. treepack_test
  2607. tri_surface_display, a MATLAB code which displays a TRI_SURFACE describing a triangulated surface;
  2608. tri_surface_display_test
  2609. tri_surface_io, a MATLAB code which reads and writes the graphics information in a tri_surface file, describing a surface in 3D consisting of a collection of connected triangles;
  2610. tri_surface_io_test
  2611. tri_surface_to_obj, a MATLAB code which reads a TRI_SURFACE dataset and extracts the surface mesh data as an OBJ file.
  2612. tri_surface_to_obj_test
  2613. tri_surface_to_ply, a MATLAB code which reads a TRI_SURFACE dataset and extracts the surface mesh data as a PLY file.
  2614. tri_surface_to_ply_test
  2615. 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.
  2616. tri_surface_to_stla_test
  2617. 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.
  2618. triangle_test
  2619. 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.
  2620. triangle_analyze_test
  2621. 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.
  2622. triangle_display_test
  2623. 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.
  2624. triangle_distance_test
  2625. triangle_dunavant_rule, a MATLAB code which returns a Dunavant quadrature rule over the interior of a triangle in 2D.
  2626. triangle_dunavant_rule_test
  2627. triangle_exactness, a MATLAB code which tests the polynomial exactness of a quadrature rule over the interior of a triangle in 2D.
  2628. triangle_exactness_test
  2629. 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.
  2630. triangle_fekete_rule_test
  2631. triangle_felippa_rule, a MATLAB code which returns Felippa quadrature rules for approximating integrals over the interior of a triangle in 2D.
  2632. triangle_felippa_rule_test
  2633. triangle_grid, a MATLAB code which computes a grid of points over the interior of a triangle in 2D.
  2634. triangle_grid_test
  2635. triangle_histogram, a MATLAB code which computes histograms of data over the interior of a unit triangle in 2D.
  2636. triangle_histogram_test
  2637. 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.
  2638. triangle_integrals_test
  2639. triangle_integrands, a MATLAB code which defines integrands for testing quadrature rules over a triangle.
  2640. triangle_integrands_test
  2641. triangle_interpolate, a MATLAB code which shows how vertex data can be interpolated at any point in the interior of a triangle.
  2642. triangle_interpolate_test
  2643. triangle_io, a MATLAB code which reads or writes files created by Jonathan Shewchuk's triangle() program.
  2644. triangle_io_test
  2645. triangle_lyness_rule, a MATLAB code which returns a Lyness-Jespersen quadrature rule over the interior of a triangle in 2D;
  2646. triangle_lyness_rule_test
  2647. 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.
  2648. triangle_monte_carlo_test
  2649. triangle_quadrature_symmetry, a MATLAB code which determines the symmetries of a quadrature rule for a triangle.
  2650. triangle_quadrature_symmetry_test
  2651. triangle_refine, a MATLAB code which divides a triangle into c^2 copies of itself, and implements a simple centroid-based quadrature scheme.
  2652. triangle_refine_test
  2653. 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.
  2654. triangle_svg_test
  2655. 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.
  2656. triangle_symq_rule_test
  2657. triangle_symq_rule_convert, a MATLAB code which takes quadrature rules defined for the equilateral triangle and converts them to the reference triangle (0,0), (1,0), (0,1).
  2658. triangle_symq_rule_convert_test
  2659. triangle_symq_rule_original, 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.
  2660. triangle_symq_rule_original_test
  2661. 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.
  2662. triangle_symq_to_ref_test
  2663. 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.
  2664. triangle_to_fem_test
  2665. 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.
  2666. triangle_to_medit_test
  2667. 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().
  2668. triangle_to_xml_test
  2669. 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.
  2670. triangle_twb_rule_test
  2671. 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.
  2672. triangle_wandzura_rule_test
  2673. triangle_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
  2674. triangle_witherden_rule_test
  2675. triangle01_integrals, a MATLAB code which returns the integral of any monomial over the interior of the unit triangle in 2D.
  2676. triangle01_integrals_test
  2677. 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.
  2678. triangle01_monte_carlo_test-
  2679. triangulate, a MATLAB code which triangulates a polygonal region, based on a C program by Joseph ORourke;
  2680. triangulate_test
  2681. triangulate_rectangle, a MATLAB code which sets up a grid of triangles in a rectangular region.
  2682. triangulate_rectangle_test
  2683. 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.
  2684. triangulation_test
  2685. 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.
  2686. triangulation_boundary_test
  2687. 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.
  2688. triangulation_boundary_edges_test
  2689. 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;
  2690. triangulation_boundary_nodes_test
  2691. triangulation_corner, a MATLAB code which patches triangulations so that no triangle has two sides on the boundary.
  2692. triangulation_corner_test
  2693. triangulation_delaunay_discrepancy, a MATLAB code which measures the amount by which a triangulation fails the local Delaunay test;
  2694. triangulation_delaunay_discrepancy_test
  2695. triangulation_display, a MATLAB code which displays the nodes and elements of a triangulation;
  2696. triangulation_display_test
  2697. triangulation_histogram, a MATLAB code which computes histograms of data over a triangulation.
  2698. triangulation_histogram_test
  2699. triangulation_l2q, a MATLAB code which reads information about a 3-node linear triangulation and creates data defining a corresponding 6-node quadratic triangulation;
  2700. triangulation_l2q_test
  2701. triangulation_mask, a MATLAB code which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;
  2702. triangulation_mask_test
  2703. 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.
  2704. triangulation_node_to_element_test
  2705. triangulation_order1_display, a MATLAB code which plots piecewise constant (PWC) data associated with a triangulation;
  2706. triangulation_order1_display_test
  2707. 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.
  2708. triangulation_order3_contour_test
  2709. 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.
  2710. triangulation_order6_contour_test
  2711. triangulation_orient, a MATLAB code which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;
  2712. triangulation_orient_test
  2713. triangulation_plot, a MATLAB code which plots the nodes and elements of a triangulation as a PostScript file;
  2714. triangulation_plot_test
  2715. triangulation_q2l, a MATLAB code which reads information about a 6-node quadratic triangulation and creates data defining a corresponding 3-node linear triangulation;
  2716. triangulation_q2l_test
  2717. 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.
  2718. triangulation_quad_test
  2719. triangulation_quality, a MATLAB code which reads information about a triangulation and computes various quality measures;
  2720. triangulation_quality_test
  2721. triangulation_rcm, a MATLAB code which reads files describing a triangulation of nodes in 2D, and applies the Reverse Cuthill McKee (RCM) algorithm to produce a renumbering of the triangulation with a reduced bandwidth.
  2722. triangulation_rcm_test
  2723. triangulation_refine, a MATLAB code which refines a triangulation;
  2724. triangulation_refine_test
  2725. 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.
  2726. triangulation_refine_local_test
  2727. triangulation_svg, a MATLAB code which creates a Scalable Vector graphics (SVG) image of a triangulation, which can be displayed by a web browser.
  2728. triangulation_svg_test
  2729. triangulation_t3_to_t4, a MATLAB code which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation (vertices + centroid);
  2730. triangulation_t3_to_t4_test
  2731. 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;
  2732. triangulation_triangle_neighbors_test
  2733. tridiagonal_solver, a MATLAB code which solves a tridiagonal linear system.
  2734. tridiagonal_solver_test
  2735. trig_interp, a MATLAB code which uses trigonometric functions for interpolation.
  2736. trig_interp_test
  2737. trig_interp_basis, a MATLAB code which evaluates the cardinal basis functions for trigonometric interpolation of equally spaced data.
  2738. trig_interp_basis_test
  2739. 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.
  2740. trinity_test
  2741. 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.
  2742. 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.
  2743. 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.
  2744. truel_simulation, a MATLAB code which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
  2745. truel_simulation_test
  2746. 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.
  2747. truncated_normal_test
  2748. 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].
  2749. truncated_normal_rule_test
  2750. 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].
  2751. truncated_normal_sparse_grid_test
  2752. 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.
  2753. tsp_brute_test
  2754. 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).
  2755. tsp_descent_test
  2756. 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.
  2757. tsp_greedy_test
  2758. tsp_moler, a MATLAB code which tries to optimize the traveling salesperson problem (TSP), written by Cleve Moler.
  2759. tsp_moler_test
  2760. 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.
  2761. tsp_random_test
  2762. tumor_pde, a MATLAB code which solves the tumor angiogenesis partial differential equations (PDE) using MATLAB's pdepe() function.
  2763. tumor_pde_test
  2764. 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.
  2765. two_body_ode_test
  2766. ubvec, a MATLAB code which demonstrates how nonnegative integers can be stored as unsigned binary vectors, and arithmetic can be performed on them.
  2767. ubvec_test
  2768. 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.
  2769. ulam_spiral_test
  2770. unicycle, a MATLAB code which considers permutations containing a single cycle, sometimes called cyclic permutations.
  2771. unicycle_test
  2772. uniform, a MATLAB code which implements a uniform random number generator (RNG) for a variety of arithmetic types.
  2773. uniform_test
  2774. 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.
  2775. unstable_ode_test
  2776. upc, a MATLAB code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
  2777. upc_test
  2778. urn_simulation, a MATLAB code which simulates the experiment of sampling K balls from an urn containing N balls of various colors.
  2779. urn_simulation_test
  2780. 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.
  2781. usa_box_plot_test
  2782. 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.
  2783. usa_cvt_geo_test
  2784. usa_matrix, a MATLAB code which defines the adjacency matrix for US states, using a variety of matrix formats.
  2785. usa_matrix_test
  2786. 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.
  2787. van_der_corput_test
  2788. vandermonde, a MATLAB code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.
  2789. vandermonde_test
  2790. 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.
  2791. vandermonde_approx_1d_test
  2792. 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.
  2793. vandermonde_approx_2d_test
  2794. 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.
  2795. vandermonde_interp_1d_test
  2796. 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.
  2797. vandermonde_interp_2d_test
  2798. 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.
  2799. vanderpol_ode_test
  2800. 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.
  2801. vanderpol_ode_period_test
  2802. vanloan, a MATLAB code which contains programs and tests from Charles van Loan's Scientific Computing text.
  2803. vanloan_test
  2804. 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.
  2805. variomino_test
  2806. 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.
  2807. vector_test
  2808. 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).
  2809. velocity_verlet_test
  2810. verlet_simulation, a MATLAB code which demonstates the use of Verlet integration to simulate simple problems in dynamics, involving changes in position and velocity.
  2811. verlet_simulation_test
  2812. vin, a MATLAB code which computes the check digit for a Vehicle Identification Number (VIN), or verifies that a given VIN is legitimate.
  2813. vin_test
  2814. 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.
  2815. voronoi_city_test
  2816. voronoi_display, a MATLAB code which computes and displays the Voronoi diagram of a set of points.
  2817. voronoi_display_test
  2818. 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.
  2819. voronoi_mountains_test
  2820. 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.
  2821. voronoi_neighbors_test
  2822. 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;
  2823. voronoi_plot_test
  2824. voronoi_test, a MATLAB code which calls the built-in voronoi() function, which computes the Voronoi diagram of a set of points.
  2825. vpa_test, a MATLAB code which uses the Variable Precision Arithmetic (VPA) feature of the Symbolic Math Toolbox to compute arbitrary precision quantities.
  2826. walker_sample, a MATLAB code which efficiently samples a discrete probability vector using Walker sampling.
  2827. walker_sample_test
  2828. walsh_transform, a MATLAB code which implements the Walsh data transform.
  2829. walsh_transform_test
  2830. 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).
  2831. wathen_matrix_test
  2832. 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.
  2833. wave_pde_test
  2834. wavelet, a MATLAB code which does some simple calculations with wavelet transforms;
  2835. wavelet_test
  2836. 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.
  2837. web_matrix_test
  2838. wedge_exactness, a MATLAB code which investigates the polynomial exactness of a quadrature rule over the interior of the unit wedge in 3D.
  2839. wedge_exactness_test
  2840. wedge_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
  2841. wedge_felippa_rule_test
  2842. wedge_grid, a MATLAB code which computes a grid of points over the interior of the unit wedge in 3D.
  2843. wedge_grid_test
  2844. 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.
  2845. wedge_integrals_test
  2846. 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.
  2847. wedge_monte_carlo_test
  2848. 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.
  2849. weekday_test
  2850. 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.
  2851. weekday_zeller_test
  2852. 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.
  2853. welzl_test
  2854. 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.
  2855. whale_test
  2856. 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.
  2857. 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.
  2858. 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;
  2859. will_you_be_alive_test
  2860. wishart_matrix, a MATLAB code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
  2861. wishart_matrix_test
  2862. wtime, a MATLAB code which returns a reading of the wall clock time in seconds.
  2863. wtime_test
  2864. xml2struct, a MATLAB code which reads a file containing XML data, and produces a corresponding MATLAB struct.
  2865. xml2struct_test
  2866. xy_display, a MATLAB code which reads a set of 2D points from a simple XY graphics file and plots them.
  2867. xy_io, a MATLAB code which reads and writes simple graphic files in the XY, XYL and XYF formats.
  2868. xy_io_test
  2869. xyf_display, a MATLAB code which reads XYF information containing a list of 2D point coordinates, and the indices of points that form faces, and displays a plot.
  2870. xyl_display, a MATLAB code which reads XYL information containing a list of 2D point coordinates, and the indices of points that form lines, and displays a plot.
  2871. xyz_display, a MATLAB code which displays a 3D plot from a file of (X,Y,Z) point coordinates.
  2872. xyz_display_test
  2873. xyz_io, a MATLAB code which reads and writes simple graphics files in the XYZ, XYZL and XYZF formats.
  2874. xyz_io_test
  2875. xyzf_display, a MATLAB code which reads XYZF information containing a list of 3D point coordinates, and the indices of points that form faces, and displays a plot in the MATLAB graphics window.
  2876. xyzl_display, a MATLAB code which reads XYZL information containing a list of 3D point coordinates, and the indices of points that form lines, and displays a plot.
  2877. zero_brent, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x)=0, by Richard Brent.
  2878. zero_brent_test
  2879. zero_chandrupatla, a MATLAB code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
  2880. zero_chandrupatla_test
  2881. 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.
  2882. zero_itp_test
  2883. zero_laguerre, a MATLAB code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
  2884. zero_laguerre_test
  2885. zero_muller, a MATLAB code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
  2886. zero_muller_test
  2887. zero_rc, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Richard Brent.
  2888. zero_rc_test
  2889. ziggurat, a MATLAB code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
  2890. ziggurat_test
  2891. 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.
  2892. zombie_ode_test
  2893. zoomin, a MATLAB code which implements procedures for finding the zero of a scalar nonlinear function.
  2894. zoomin_test

Last revised on 20 August 2025.