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