jburkardt-m
文件大小: unknow
源码售价: 5 个金币 积分规则     积分充值
资源说明:An official Git Mirror of John Burkardt's great collection of MATLAB Software
MATLAB Source Codes
===================

------------------------------------------------------------------------

1.  [analemma](analemma/analemma.html), a program 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.
2.  [area\_under\_curve](area_under_curve/area_under_curve.html), a function which displays the area under a curve, that is, the points (x,y) between the x axis and the curve y=f(x).
3.  [args](args/args.html), a program which shows how to count and report command line arguments;
4.  [arpack](arpack/arpack.html), a library which computes eigenvalues and eigenvectors of large sparse matrices, accessible via MATLAB's built-in eigs() command;
5.  [asa005](asa005/asa005.html), a library which evaluates the lower tail of the noncentral Student's T distribution, by BE Cooper. This is a version of Applied Statistics Algorithm 5;
6.  [asa006](asa006/asa006.html), a library which computes the Cholesky factor of a positive definite symmetric matrix, by Michael Healy; This is a version of Applied Statistics Algorithm 6;
7.  [asa007](asa007/asa007.html), a library which computes the inverse of a positive definite symmetric matrix, by Michael Healy; This is a version of Applied Statistics Algorithm 7.
8.  [asa032](asa032/asa032.html), a library which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32;
9.  [asa047](asa047/asa047.html), a library 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;
10. [asa053](asa053/asa053.html), a library which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
11. [asa058](asa058/asa058.html), a library which carries out clustering of data, by David Sparks. This is a version of Applied Statistics Algorithm 58;
12. [asa063](asa063/asa063.html), a library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63;
13. [asa066](asa066/asa066.html), a library which computes the cumulative density function (CDF) of the standard normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66;
14. [asa076](asa076/asa076.html), a library which evaluates Owen's T function, by Young and Minder. This is a version of Applied Statistics Algorithm 76;
15. [asa091](asa091/asa091.html), a library which computes the percentage points of the Chi-square distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91;
16. [asa103](asa103/asa103.html), a library which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103;
17. [asa109](asa109/asa109.html) a library which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109;
18. [asa111](asa111/asa111.html) a library which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111;
19. [asa113](asa113/asa113.html) a library which clusters data using a transfer and swap algorithm, by Banfield and Bassill; This is a version of Applied Statistics Algorithm 113;
20. [asa121](asa121/asa121.html), a library which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121;
21. [asa136](asa136/asa136.html), a library which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136;
22. [asa144](asa144/asa144.html), a library which randomly generates tables with given row and column sums, by James Boyett. This is a version of Applied Statistics Algorithm 144;
23. [asa147](asa147/asa147.html), a library which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147;
24. [asa152](asa152/asa152.html), a library 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;
25. [asa159](asa159/asa159.html), a library which computes a random table with given row and column sums, by Michael Patefield; This is a version of Applied Statistics Algorithm 159;
26. [asa172](asa172/asa172.html), a library 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;
27. [asa183](asa183/asa183.html), a library which implements a random number generator (RNG), by Wichman and Hill; this is a version of Applied Statistics Algorithm 183;
28. [asa226](asa226/asa226.html), a library which evaluates the noncentral incomplete Beta function, by Russell Lenth; this is a version of Applied Statistics Algorithm 226;
29. [asa239](asa239/asa239.html), a library which evaluates the incomplete Gamma function, by Shea; this is a version of Applied Statistics Algorithm 239;
30. [asa241](asa241/asa241.html), a library which computes the inverse of the normal cumulative density function (CDF), by Michael Wichura; this is a version of Applied Statistics Algorithm 241;
31. [asa243](asa243/asa243.html), a library which evaluates the lower tail of the noncentral Student's T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243;
32. [asa245](asa245/asa245.html), a library which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245;
33. [asa266](asa266/asa266.html), a library which evaluates various properties of the Dirichlet probability density function (PDF); this is a version of Applied Statistics Algorithm 266;
34. [asa299](asa299/asa299.html), a library which computes the lattice points (integer coordinates) in an M dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
35. [asa310](asa310/asa310.html), a library which evaluates the noncentral incomplete Beta function, by Chattamvelli and Shanmugam. This is a version of Applied Statistics Algorithm 310;
36. [asa314](asa314/asa314.html), a library 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.
37. [backtrack\_binary\_rc](backtrack_binary_rc/backtrack_binary_rc.html), a library which carries out a backtrack search for a set of binary decisions, using reverse communication.
38. [ball\_and\_stick\_display](ball_and_stick_display/ball_and_stick_display.html), a program which demonstrates the creation of a 3D image constructed from balls and sticks;
39. [ball\_grid](ball_grid/ball_grid.html), a library which computes a grid of points over the interior of the unit ball in 3D.
40. [ball\_integrals](ball_integrals/ball_integrals.html), a library which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
41. [ball\_monte\_carlo](ball_monte_carlo/ball_monte_carlo.html), a library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
42. [barycentric\_interp\_1d](barycentric_interp_1d/barycentric_interp_1d.html), a library 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.
43. [bellman\_ford](bellman_ford/bellman_ford.html), a library 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.
44. [bernstein\_polynomial](bernstein_polynomial/bernstein_polynomial.html), a library which evaluates the Bernstein polynomials;
45. [beta\_nc](beta_nc/beta_nc.html), a library which evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
46. [bezier\_surface](bezier_surface/bezier_surface.html), a library which reads, writes, prints and manipulates the data that defines a Bezier surface;
47. [bezier\_surface\_display](bezier_surface_display/bezier_surface_display.html), a program which displays a Bezier surface;
48. [birthday\_remote](birthday_remote/birthday_remote.html), a program which runs a Monte Carlo simulation of the birthday paradox, and includes instructions on how to run the job, via MATLAB's batch facility, on a remote system such as Virginia Tech's Ithaca cluster.
49. [bisection\_integer](bisection_integer/bisection_integer.html), a library which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval \[A,B\].
50. [bisection\_rc](bisection_rc/bisection_rc.html), a library 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.
51. [black\_scholes](black_scholes/black_scholes.html), a library which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
52. [blas](blas/blas.html), a library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1, 2 and 3, for single and double precision, and for real and complex arithmetic.
53. [blas0](blas0/blas0.html), a library which contains auxiliary functions for the Basic Linear Algebra Subprograms (BLAS).
54. [blas1](blas1/blas1.html), a library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations), for single and double precision, and for real and complex arithmetic.
55. [blas1\_c](blas1_c/blas1_c.html), a library which implements the Level 1 Basic Linear Algebra Subprograms (BLAS), using single precision complex arithmetic;
56. [blas1\_d](blas1_d/blas1_d.html), a library which implements the Level 1 Basic Linear Algebra Subprograms (BLAS), using double precision real arithmetic;
57. [blas1\_s](blas1_s/blas1_s.html), a library which implements the Level 1 Basic Linear Algebra Subprograms (BLAS), using single precision real arithmetic;
58. [blas1\_z](blas1_z/blas1_z.html), a library which implements the Level 1 Basic Linear Algebra Subprograms (BLAS), using double precision complex arithmetic;
59. [blas2](blas2/blas2.html), a library which contains the Level 2 Basic Linear Algebra Subprograms (BLAS) for matrix-vector operations;
60. [blas3](blas3/blas3.html), a library which contains the Level 3 Basic Linear Algebra Subprograms (BLAS) for matrix-matrix operations.
61. [blend](blend/blend.html), a library which carries out 1D/2D/3D blending interpolation;
62. [blsprice](blsprice/blsprice.html), programs which demonstrate the use of the BLSPRICE function, for Black-Scholes option pricing, from the MATLAB Financial Mathematics toolbox.
63. [box\_behnken](box_behnken/box_behnken.html), a library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;
64. [box\_display](box_display/box_display.html), a program which displays a box plot, over integer pairs of data, of a function defined by two formulas.
65. [box\_plot](box_plot/box_plot.html), a program which displays a box plot of data that consists of pairs of integers;
66. [brain\_sensor\_pod](brain_sensor_pod/brain_sensor_pod.html), a program which applies the method of Proper Orthogonal Decomposition (POD) to seek underlying patterns in sets of 40 sensor readings of brain activity.
67. [brent](brent/brent.html), a library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, including a reverse communication option, by Richard Brent.
68. [brownian\_motion\_simulation](brownian_motion_simulation/brownian_motion_simulation.html), a library which simulates Brownian motion in an M dimensional region.
69. [buckling\_spring](buckling_spring/buckling_spring.html), a program which plots solutions of the buckling spring equations.
70. [burgers\_solution](burgers_solution/burgers_solution.html), a library which evaluates an exact solution of the time-dependent 1D viscous Burgers equation.
71. [burgers\_steady\_viscous](burgers_steady_viscous/burgers_steady_viscous.html), a library which solves the steady (time-independent) viscous Burgers equation using the finite difference method (FDM) applied to the conservative form of the equation, using Newton's method to solve the resulting nonlinear system.
72. [burgers\_time\_inviscid](burgers_time_inviscid/burgers_time_inviscid.html), a library which solves the time-dependent inviscid Burgers equation using the finite difference method (FDM), and one of six solution methods selected by the user.
73. [burgers\_time\_viscous](burgers_time_viscous/burgers_time_viscous.html), a library which solves the time-dependent viscous Burgers equation using the finite difference method (FDM) applied to the conservative form of the equation.
74. [bvec](bvec/bvec.html), a library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
75. [bvp4c](bvp4c/bvp4c.html), programs which illustrate how to use the MATLAB command **bvp4c()**, which can solve boundary value problems (BVP's) in one spatial dimension.
76. [c4lib](c4lib/c4lib.html), a library which implements certain elementary functions for single precision complex ("C4") variables;
77. [c8lib](c8lib/c8lib.html), a library which implements certain elementary functions for double precision complex ("C8") variables;
78. [calendar\_nyt](calendar_nyt/calendar_nyt.html), a library which shows the correspondence between dates and the New York Times volume and issue number;
79. [calpak](calpak/calpak.html), a library which makes various calendar calculations;
80. [cauchy\_principal\_value](cauchy_principal_value/cauchy_principal_value.html), a library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
81. [cavity\_flow\_display](cavity_flow_display/cavity_flow_display.html), a library which displays a single velocity field solution for the driven cavity;
82. [cavity\_flow\_movie](cavity_flow_movie/cavity_flow_movie.html), a library which animates the velocity solutions for the driven cavity;
83. [cc\_display](cc_display/cc_display.html), a program which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
84. [cc\_io](cc_io/cc_io.html) a library which reads and writes sparse linear systems stored in the Compressed Column (CC) format.
85. [cc\_project](cc_project/cc_project.html), a library which investigates generalized Clenshaw-Curtis quadrature rules for semi-infinite and infinite intervals, by John Boyd.
86. [cc\_to\_st](cc_to_st/cc_to_st.html) a library which converts a sparse matrix from compressed column (CC) to sparse triplet (ST) format.
87. [ccn\_rule](ccn_rule/ccn_rule.html), a program which defines a nested Clenshaw Curtis quadrature rule.
88. [ccvt\_box](ccvt_box/ccvt_box.html), a program which calculates a constrained Centroidal Voronoi Tessellation (CVT) for points constrained to lie in a box, with some points moved to the boundary;
89. [ccvt\_reflect](ccvt_reflect/ccvt_reflect.html), a program which calculates a constrained Centroidal Voronoi Tessellation (CVT) for points constrained to lie in a box, with some points pushed towards the boundary;
90. [cell](cell/cell.html), a library which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.
91. [cell\_detection\_tasks](cell_detection_tasks/cell_detection_tasks.html), a program which creates modified versions of a sequence of gray-scale tagged image files (TIF's) containing images of biological cells; the process of each file is carried out independently, using the task feature of MATLAB's parallel computing toolbox.
92. [cellular\_automaton](cellular_automaton/cellular_automaton.html), a program which demonstrates the 1D Cellular Automaton known as rule \#30.
93. [centralize](centralize/centralize.html), a library which estimates the centroid and radius of a shape, or a set of data points, in a space of arbitrary dimension.
94. [cg](cg/cg.html), a library 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 positive definite (only real, positive eigenvalues) and symmetric.
95. [cg\_distributed](cg_distributed/cg_distributed.html), a program which implements a version of the NAS conjugate gradient (CG) benchmark, using distributed memory.
96. [cg\_lab\_triangles](cg_lab_triangles/cg_lab_triangles.html), a collection of programs associated with a computer lab assignment on computational geometry and triangles;
97. [cg\_rc](cg_rc/cg_rc.html), a library which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A\*x=b, using reverse communication (RC).
98. [chain\_letter\_tree](chain_letter_tree/chain_letter_tree.html), a program 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.
99. [change\_making](change_making/change_making.html), a library which considers the change making problem, in which a given sum is to be formed using coins of various denominations.
100. [chebyshev](chebyshev/chebyshev.html), a library which computes the Chebyshev interpolant/approximant to a given function over an interval.
101. [chebyshev\_interp\_1d](chebyshev_interp_1d/chebyshev_interp_1d.html), a library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).
102. [chebyshev\_polynomial](chebyshev_polynomial/chebyshev_polynomial.html), a library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
103. [chebyshev\_series](chebyshev_series/chebyshev_series.html), a library which can evaluate 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.
104. [chebyshev1\_rule](chebyshev1_rule/chebyshev1_rule.html), a program which computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
105. [chebyshev2\_rule](chebyshev2_rule/chebyshev2_rule.html), a program which computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
106. [chrpak](chrpak/chrpak.html), a library which manipulates characters and strings;
107. [circle\_arc\_grid](circle_arc_grid/circle_arc_grid.html), a program which computes grid points along a circular arc.
108. [circle\_grid\_display](circle_grid_display/circle_grid_display.html) a program which reads a matrix of integers, and draws a corresponding grid of circles filled with color.
109. [circle\_integrals](circle_integrals/circle_integrals.html), a library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
110. [circle\_monte\_carlo](circle_monte_carlo/circle_monte_carlo.html), a library which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
111. [circle\_rule](circle_rule/circle_rule.html), a library which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).
112. [circle\_segment](circle_segment/circle_segment.html), a library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.
113. [cities](cities/cities.html), a library which works with city-to-city distance matrices;
114. [clenshaw\_curtis\_rule](clenshaw_curtis_rule/clenshaw_curtis_rule.html), a program which implements a Clenshaw Curtis quadrature rule;
115. [cnoise](cnoise/cnoise.html), a library which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
116. [collatz](collatz/collatz.html), a library which computes and analyzes the Collatz sequence, also known as the hailstone sequence or 3n+1 sequence;
117. [collatz\_parfor](collatz_parfor/collatz_parfor.html), a program which seeks the maximum Collatz sequence between 1 and N; it runs in parallel using MATLAB's parfor facility.
118. [collatz\_recursive](collatz_recursive/collatz_recursive.html), a library which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
119. [collocation](collocation/collocation.html), a library which demonstrates some simple examples of 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.
120. [color\_remote](color_remote/color_remote.html), a program which carries out the color segmentation of an image in parallel, using MATLAB's spmd facility; this includes instructions on how to run the job, via MATLAB's batch facility, on a remote system such as Virginia Tech's ithaca cluster.
121. [colored\_noise](colored_noise/colored_noise.html), a library which generates samples of noise obeying a 1/f^alpha power law.
122. [combination\_lock](combination_lock/combination_lock.html), a program which simulates the process of determining the secret combination of a lock.
123. [combo](combo/combo.html), a library 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.
124. [compass\_search](compass_search/compass_search.html), a library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
125. [complex\_numbers](complex_numbers/complex_numbers.html), a program which demonstrates some simple features involved in the use of complex numbers in programming.
126. [complexity](complexity/complexity.html), programs which measure the complexity of a few simple algorithms with increasing problem size.
127. [condition](condition/condition.html), a library which implements methods of computing or estimating the condition number of a matrix.
128. [continuation](continuation/continuation.html), a library which implements the continuation method for a simple 2D problem, which involves finding a point on the unit circle, and then finding a sequence of nearby points which 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.
129. [contour\_gradient](contour_gradient/contour_gradient.html), a program which displays contours and gradient vectors for a function f(x,y).
130. [contour\_gradient\_3d](contour_gradient_3d/contour_gradient_3d.html), a program which displays contours and gradient vectors for a function f(x,y) in a 3D display.
131. [contour\_sequence4](contour_sequence4/contour_sequence4.html), a program which creates images suitable for animation from one XY file and a sequence of u(x,y) data files;
132. [contrast\_spmd](contrast_spmd/contrast_spmd.html), a program which demonstrates spmd parallel programming for image operations; the client reads an image, the workers heighten contrast over portions of it, and the client assembles and displays the results.
133. [contrast2\_spmd](contrast2_spmd/contrast2_spmd.html), a program which demonstrates spmd parallel programming for image operations; it improves on contrast\_spmd by allowing the workers to communicate, and so eliminates artificial seams that would otherwise appear in the processed image.
134. [convex\_hull](convex_hull/convex_hull.html), a program which demonstrates the computation of the convex hull of a set of 2D points.
135. [coordinate\_search](coordinate_search/coordinate_search.html), a program which seeks the minimizer of a scalar function of several variables, by Jeff Borggaard.
136. [cordic](cordic/cordic.html), a library which computes a few special functions using the CORDIC algorithm.
137. [correlation](correlation/correlation.html), a library which contains examples of statistical correlation functions.
138. [correlation\_chebfun](correlation_chebfun/correlation_chebfun.html), a library which uses the chebfun library to compute truncated Karhunen-Loeve expansions of stochastic processes with a given correlation function.
139. [cube\_arbq\_rule](cube_arbq_rule/cube_arbq_rule.html), a library 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.
140. [cube\_exactness](cube_exactness/cube_exactness.html), a library which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.
141. [cube\_felippa\_rule](cube_felippa_rule/cube_felippa_rule.html), a library which returns Felippa's quadratures rules for approximating integrals over the interior of a cube in 3D.
142. [cube\_grid](cube_grid/cube_grid.html), a library which computes a grid of points over the interior of a cube in 3D.
143. [cube\_integrals](cube_integrals/cube_integrals.html), a library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
144. [cube\_monte\_carlo](cube_monte_carlo/cube_monte_carlo.html), a library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
145. [cvt](cvt/cvt.html), a library which computes an N-point Centroidal Voronoi Tessellation (CVT) in M dimensions;
146. [cvt\_1d\_nonuniform](cvt_1d_nonuniform/cvt_1d_nonuniform.html), a program 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;
147. [cvt\_1d\_sampling](cvt_1d_sampling/cvt_1d_sampling.html), a program 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.
148. [cvt\_2d\_sampling](cvt_2d_sampling/cvt_2d_sampling.html), a program 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.
149. [cvt\_3d\_sampling](cvt_3d_sampling/cvt_3d_sampling.html), a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube \[0,1\]x\[0,1\]x\[0,1\], under a uniform density, using sampling to estimate the Voronoi regions.
150. [cvt\_corn](cvt_corn/cvt_corn.html), a program 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.
151. [cvt\_dataset](cvt_dataset/cvt_dataset.html), a program which creates a Centroidal Voronoi Tessellation (CVT) dataset;
152. [cvt\_demo](cvt_demo/cvt_demo.html), a program which interactively, graphically demonstrates a Centroidal Voronoi Tessellation (CVT) calculation;
153. [cvt\_metric](cvt_metric/cvt_metric.html), a program which computes a Centroidal Voronoi Tessellation (CVT) under a spatially varying metric;
154. [cvt\_movie](cvt_movie/cvt_movie.html), a program which creates an animation of the evolution of a Centroidal Voronoi Tessellation (CVT);
155. [cvt\_movie2](cvt_movie2/cvt_movie2.html), a program which creates a Centroidal Voronoi Tessellation (CVT) movie;
156. [cvt\_movie3](cvt_movie3/cvt_movie3.html), a program which creates a Centroidal Voronoi Tessellation (CVT) movie in a region of unusual shape;
157. [cvt\_movie4](cvt_movie4/cvt_movie4.html), a program which creates a Centroidal Voronoi Tessellation (CVT) movie in a square, with a density function that drives points to the corners;
158. [cvt\_movie5](cvt_movie5/cvt_movie5.html), a program which repeats cvt\_movie3, but with hexagonal grid initialization, fixed points, and boundary projection;
159. [cycle\_brent](cycle_brent/cycle_brent.html), a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.
160. [cycle\_floyd](cycle_floyd/cycle_floyd.html), a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.
161. [cyclic\_reduction](cyclic_reduction/cyclic_reduction.html), a library which solves a tridiagonal linear system using cyclic reduction;
162. [dfield8](dfield8/dfield8.html), a program which interactively displays the direction field of an ordinary differential equation (ODE), by John Polking.
163. [diaphony](diaphony/diaphony.html), a program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
164. [dice\_simulation](dice_simulation/dice_simulation.html), a program which simulates N tosses of M dice, making a histogram of the results.
165. [differ](differ/differ.html), determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.
166. [dijkstra](dijkstra/dijkstra.html), a library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.
167. [dijkstra\_spmd](dijkstra_spmd/dijkstra_spmd.html), a program which uses the spmd feature to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.
168. [discrete\_pdf\_sample\_2d](discrete_pdf_sample_2d/discrete_pdf_sample_2d.html), a program 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.
169. [disk\_grid](disk_grid/disk_grid.html), a library 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.
170. [disk\_integrals](disk_integrals/disk_integrals.html), a library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
171. [disk\_monte\_carlo](disk_monte_carlo/disk_monte_carlo.html), a library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
172. [disk\_rule](disk_rule/disk_rule.html), a library which computes a quadrature rule over the interior of the unit disk in 2D.
173. [dist\_plot](dist_plot/dist_plot.html), a program which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh() code;
174. [distance\_to\_position](distance_to_position/distance_to_position.html), a program which estimates the positions of cities which minimizes the discrepancy with a city-to-city distance table.
175. [distance\_to\_position\_sphere](distance_to_position_sphere/distance_to_position_sphere.html), a program which estimates the positions of cities on a sphere (such as the earth) based on a city-to-city distance table.
176. [distmesh](distmesh/distmesh.html), a library which carries out a method of mesh generation; by Per-Olof Persson and Gilbert Strang.
177. [distmesh\_3d](distmesh_3d/distmesh_3d.html), a library which carries out a method of mesh generation in 3D, by Per-Olof Persson and Gilbert Strang.
178. [divdif](divdif/divdif.html), a library which uses divided differences to compute the polynomial interpolant to a given set of data.
179. [dlap\_io](dlap_io/dlap_io.html), a library which reads and writes DLAP sparse matrix files;
180. [doomsday](doomsday/doomsday.html), a library 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.
181. [double\_c\_data](double_c_data/double_c_data.html), programs which generate, plot or write out 2D data that forms two interlocking "C" shapes.
182. [duel\_simulation](duel_simulation/duel_simulation.html), a program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
183. [edge](edge/edge.html), a library which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities.
184. [ellipse\_grid](ellipse_grid/ellipse_grid.html), a library which computes a grid of points over the interior of an ellipse in 2D.
185. [ellipse\_monte\_carlo](ellipse_monte_carlo/ellipse_monte_carlo.html), a library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.
186. [ellipsoid\_grid](ellipsoid_grid/ellipsoid_grid.html), a library which computes a grid of points over the interior of an ellipsoid in 3D.
187. [ellipsoid\_monte\_carlo](ellipsoid_monte_carlo/ellipsoid_monte_carlo.html), a library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
188. [entrust](entrust/entrust.html), a library which uses trust-region methods to solve problems in scalar optimization or nonlinear least squares, by Jeff Borggaard and Gene Cliff.
189. [exactness](exactness/exactness.html), a library 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).
190. [face\_spmd](face_spmd/face_spmd.html), a program which demonstrates the spmd parallel programming feature; the client has a 3D box that has been dissected into tetrahedrons. Multiple workers cooperate to construct a list of the triangular faces that lie on the boundaries of the box.
191. [fair\_dice\_simulation](fair_dice_simulation/fair_dice_simulation.html), a program which simulates N tosses of 2 dice, making a histogram of the results.
192. [faure](faure/faure.html), a library which computes the Faure M dimensional quasirandom sequence;
193. [faure\_dataset](faure_dataset/faure_dataset.html), a program which creates an M dimensional Faure quasirandom dataset;
194. [fd\_predator\_prey](fd_predator_prey/fd_predator_prey.html), a program which solves a time-dependent predator prey system using the finite difference method (FDM).
195. [fd\_to\_tec](fd_to_tec/fd_to_tec.html), a program which converts FD files storing finite difference method (FDM) models into tecplot ASCII files.
196. [fd1d\_advection\_diffusion\_steady](fd1d_advection_diffusion_steady/fd1d_advection_diffusion_steady.html), a program 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.
197. [fd1d\_advection\_ftcs](fd1d_advection_ftcs/fd1d_advection_ftcs.html), a program 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.
198. [fd1d\_advection\_lax](fd1d_advection_lax/fd1d_advection_lax.html), a program 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.
199. [fd1d\_advection\_lax\_wendroff](fd1d_advection_lax_wendroff/fd1d_advection_lax_wendroff.html), a program 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.
200. [fd1d\_burgers\_lax](fd1d_burgers_lax/fd1d_burgers_lax.html), a program 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.
201. [fd1d\_burgers\_leap](fd1d_burgers_leap/fd1d_burgers_leap.html), a program which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
202. [fd1d\_bvp](fd1d_bvp/fd1d_bvp.html), a program which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
203. [fd1d\_display](fd1d_display/fd1d_display.html), a program which reads a pair of files defining a 1D model for the finite difference method (FDM), and plots the data.
204. [fd1d\_heat\_explicit](fd1d_heat_explicit/fd1d_heat_explicit.html), a library which implements a finite difference method (FDM), explicit in time, to solve the time dependent 1D heat equation;
205. [fd1d\_heat\_implicit](fd1d_heat_implicit/fd1d_heat_implicit.html), a program which implements a finite difference method (FDM), implicit in time, to solve the time dependent 1D heat equation;
206. [fd1d\_heat\_steady](fd1d_heat_steady/fd1d_heat_steady.html), a program which implements a finite difference method (FDM) for the steady (time independent) 1D heat equation;
207. [fd1d\_predator\_prey](fd1d_predator_prey/fd1d_predator_prey.html), a program which implements a finite difference method (FDM) for a time and 1D space dependent predator-prey system, by Marcus Garvie.
208. [fd1d\_predator\_prey\_plot](fd1d_predator_prey_plot/fd1d_predator_prey_plot.html), a program which plots solutions from the fd1d\_predator\_prey program, by Marcus Garvie.
209. [fd1d\_wave](fd1d_wave/fd1d_wave.html), a library which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c \* uxx in one spatial dimension.
210. [fd2d\_heat\_explicit\_spmd](fd2d_heat_explicit_spmd/fd2d_heat_explicit_spmd.html), a program which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 2D. A black and white image is used as the initial condition. MATLAB's spmd facility is used to carry out the computation in parallel.
211. [fd2d\_heat\_steady](fd2d_heat_steady/fd2d_heat_steady.html), a program which implements a finite difference method (FDM) for the steady (time independent) 2D heat equation;
212. [fd2d\_predator\_prey](fd2d_predator_prey/fd2d_predator_prey.html), a program which implements a finite difference method (FDM) for a time and 2D space dependent predator-prey system, by Marcus Garvie.
213. [fe2d\_predator\_prey\_fast](fe2d_predator_prey_fast/fe2d_predator_prey_fast.html), programs which implement 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 Matlab optimizations, by Marcus Garvie.
214. [featool](featool/featool.html), a program which can set up and solve a variety of finite element problems;
215. [fem\_basis](fem_basis/fem_basis.html), a library which can define and evaluate finite element method (FEM) basis functions for any degree in an M dimensional simplex (1D interval, 2D triangle, 3D tetrahedron, and higher dimensional generalizations.)
216. [fem\_basis\_q4\_display](fem_basis_q4_display/fem_basis_q4_display.html), a program which displays any single finite element method (FEM) basis function associated with an arbitrary linear quadrilateral Q4 mesh;
217. [fem\_basis\_t3\_display](fem_basis_t3_display/fem_basis_t3_display.html), a program which displays a basis function for the finite element method (FEM) associated with an arbitrary 3-node triangle T3 mesh;
218. [fem\_basis\_t4\_display](fem_basis_t4_display/fem_basis_t4_display.html), a program which displays a basis function for the finite element method (FEM) associated with an arbitrary 4-node triangle T4 mesh;
219. [fem\_basis\_t6\_display](fem_basis_t6_display/fem_basis_t6_display.html), a program which displays a basis function for the finite element method (FEM) associated with an arbitrary 6-node triangle T6 mesh;
220. [fem\_io](fem_io/fem_io.html), a library which reads or writes FEM files, which describe the nodes, elements, and function values associated with a finite element method (FEM) model;
221. [fem\_meshing](fem_meshing/fem_meshing.html), a library which looks at some simple issues in defining a geometric mesh for the finite element method (FEM) in 2D.
222. [fem\_neumann](fem_neumann/fem_neumann.html), a program which sets up a time-dependent reaction-diffusion equation in 1D, with Neumann boundary conditions, discretized using the finite element method (FEM).
223. [fem\_to\_gmsh](fem_to_gmsh/fem_to_gmsh.html), a program 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.
224. [fem\_to\_medit](fem_to_medit/fem_to_medit.html), a program which reads a pair of FEM files defining node coordinates and elements, of a 2D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding MEDIT mesh file.
225. [fem\_to\_triangle](fem_to_triangle/fem_to_triangle.html), a program 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.
226. [fem\_to\_xml](fem_to_xml/fem_to_xml.html), 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.
227. [fem\_to\_tec](fem_to_tec/fem_to_tec.html), a program which reads a set of FEM files, (three text files describing a finite element model), and writes a TECPLOT ASCII file.
228. [fem1d](fem1d/fem1d.html), a program which applies the finite element method (FEM), using piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
229. [fem1d\_adaptive](fem1d_adaptive/fem1d_adaptive.html), a program 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;
230. [fem1d\_bvp\_linear](fem1d_bvp_linear/fem1d_bvp_linear.html), a program which applies the finite element method (FEM), with piecewise linear 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.
231. [fem1d\_bvp\_quadratic](fem1d_bvp_quadratic/fem1d_bvp_quadratic.html), a program which applies the finite element method (FEM), with piecewise quadratic 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.
232. [fem1d\_display](fem1d_display/fem1d_display.html), a program which reads three files defining a 1D arbitrary degree basis function associated with the finite element method (FEM), and displays a plot.
233. [fem1d\_function\_10\_display](fem1d_function_10_display/fem1d_function_10_display.html), a program which reads three files defining a 1D piecewise linear finite element method (FEM) function and displays a plot.
234. [fem1d\_heat\_explicit](fem1d_heat_explicit/fem1d_heat_explicit.html), a program which uses the finite element method (FEM) and explicit time stepping to solve the time dependent heat equation in 1D.
235. [fem1d\_heat\_implicit](fem1d_heat_implicit/fem1d_heat_implicit.html), a program which uses the finite element method (FEM) and implicit time stepping to solve the time dependent heat equation in 1D.
236. [fem1d\_heat\_steady](fem1d_heat_steady/fem1d_heat_steady.html), a program which implements the finite element method (FEM) for the steady (time independent) 1D heat equation;
237. [fem1d\_lagrange](fem1d_lagrange/fem1d_lagrange.html), a library 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.
238. [fem1d\_nonlinear](fem1d_nonlinear/fem1d_nonlinear.html), a program which applies the finite element method (FEM), with piecewise linear basis functions, to a nonlinear two point boundary value problem (BVP) in 1D;
239. [fem1d\_pack](fem1d_pack/fem1d_pack.html), a library which contains utilities for 1D finite element method (FEM) calculations.
240. [fem1d\_pmethod](fem1d_pmethod/fem1d_pmethod.html), a program which applies the p-method version of the finite element method (FEM) to a linear two point boundary value problem (BVP) in 1D;
241. [fem1d\_project](fem1d_project/fem1d_project.html), a program 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.
242. [fem1d\_sample](fem1d_sample/fem1d_sample.html), a program which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.
243. [fem1d\_spectral\_numeric](fem1d_spectral_numeric/fem1d_spectral_numeric.html), a program 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 MATLAB's quad() function, by Miro Stoyanov.
244. [fem1d\_spectral\_symbolic](fem1d_spectral_symbolic/fem1d_spectral_symbolic.html), a program 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 using MATLAB's symbolic toolbox, by Miro Stoyanov.
245. [fem2d\_bvp\_linear](fem2d_bvp_linear/fem2d_bvp_linear.html), a program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
246. [fem2d\_bvp\_quadratic](fem2d_bvp_quadratic/fem2d_bvp_quadratic.html), a program which applies the finite element method (FEM), with piecewise quadratic elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
247. [fem2d\_bvp\_serene](fem2d_bvp_serene/fem2d_bvp_serene.html), a program 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.
248. [fem2d\_heat](fem2d_heat/fem2d_heat.html), a program which applies the finite element method (FEM) to the time dependent heat equation on an arbitrary triangulated region in 2D;
249. [fem2d\_heat\_rectangle](fem2d_heat_rectangle/fem2d_heat_rectangle.html), a program which applies the finite element method (FEM) for the time-dependent heat equation on a triangulated square in 2D;
250. [fem2d\_heat\_rectangle\_steady\_spmd](fem2d_heat_rectangle_steady_spmd/fem2d_heat_rectangle_steady_spmd.html), a program which uses the MATLAB Parallel Computing Toolbox in spmd mode to set up and solve a distributed linear system associated with the finite element method (FEM) solution of the steady 2d heat equation.
251. [fem2d\_heat\_sparse](fem2d_heat_sparse/fem2d_heat_sparse.html), a program which applies the finite element method (FEM) to the heat equation on an arbitrary triangulated region in 2D, using MATLAB's sparse matrix features;
252. [fem2d\_heat\_sparse\_square](fem2d_heat_sparse_square/fem2d_heat_sparse_square.html), a library which defines the geometry of a square region, as well as boundary and initial conditions for a given heat problem, so that fem2d\_heat\_sparse can be called for a solution.
253. [fem2d\_heat\_square](fem2d_heat_square/fem2d_heat_square.html), a library which defines the geometry of a square region, as well as boundary and initial conditions for a given heat problem, so that fem2d\_heat can be called for a solution.
254. [fem2d\_mesh\_display](fem2d_mesh_display/fem2d_mesh_display.html), a program 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.
255. [fem2d\_pack](fem2d_pack/fem2d_pack.html), a library which performs simple 2D finite element method (FEM) computations;
256. [fem2d\_poisson\_rectangle](fem2d_poisson_rectangle/fem2d_poisson_rectangle.html), a program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.
257. [fem2d\_poisson\_rectangle\_linear](fem2d_poisson_rectangle_linear/fem2d_poisson_rectangle_linear.html), a program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.
258. [fem2d\_poisson\_sparse](fem2d_poisson_sparse/fem2d_poisson_sparse.html), a program which uses the finite element method to solve Poisson's equation on an arbitrary triangulated region in 2D; This is a version of fem2d\_poisson which replaces the banded storage and direct solver by a sparse storage format.
259. [fem2d\_poisson\_sparse\_baffle](fem2d_poisson_sparse_baffle/fem2d_poisson_sparse_baffle.html), a library which defines the geometry of a rectangular channel with 13 baffles, as well as boundary conditions for a given Poisson problem, and is called by fem2d\_poisson\_sparse as part of a solution procedure.
260. [fem2d\_poisson\_sparse\_ell](fem2d_poisson_sparse_ell/fem2d_poisson_sparse_ell.html), a library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d\_poisson\_sparse as part of a solution procedure.
261. [fem2d\_poisson\_sparse\_lake](fem2d_poisson_sparse_lake/fem2d_poisson_sparse_lake.html), a library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d\_poisson\_sparse as part of a solution procedure.
262. [fem2d\_project](fem2d_project/fem2d_project.html), a program which projects a function f(x,y), given as data, into a given finite element space of piecewise linear triangular elements.
263. [fem2d\_project\_function](fem2d_project_function/fem2d_project_function.html), a program which projects a function f(x,y), given as a formula, into a given finite element space of piecewise linear triangular elements.
264. [fem2d\_sample](fem2d_sample/fem2d_sample.html), a program which samples a finite element function, defined by FEM files, (three text files describing the nodes, triangles, and coefficients); at arbitrary points.
265. [fem2d\_scalar\_display](fem2d_scalar_display/fem2d_scalar_display.html), a program 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), using the MATLAB graphics system.
266. [fem2d\_scalar\_display\_brief](fem2d_scalar_display_brief/fem2d_scalar_display_brief.html), a program 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), using the MATLAB graphics system, in 5 lines of code.
267. [fem2d\_scalar\_display\_gpl](fem2d_scalar_display_gpl/fem2d_scalar_display_gpl.html), a program 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.
268. [fem3d\_pack](fem3d_pack/fem3d_pack.html), a library which contains utilities for 3D finite element method (FEM) calculations.
269. [fem3d\_project](fem3d_project/fem3d_project.html), a program 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).
270. [fem3d\_sample](fem3d_sample/fem3d_sample.html), a program library which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
271. [fern](fern/fern.html), a program which uses MATLAB graphics to compute and display the Barnsley fractal fern.
272. [feynman\_kac\_1d](feynman_kac_1d/feynman_kac_1d.html), a program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.
273. [feynman\_kac\_2d](feynman_kac_2d/feynman_kac_2d.html), a program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.
274. [feynman\_kac\_3d](feynman_kac_3d/feynman_kac_3d.html), a program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
275. [fft\_serial](fft_serial/fft_serial.html), a program which computes a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.
276. [fibonacci\_spiral](fibonacci_spiral/fibonacci_spiral.html), a program which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.
277. [file\_increment](file_increment/file_increment.html), a program which makes a copy of a file containing an integer array, after incrementing each entry by a given value.
278. [file\_name\_sequence](file_name_sequence/file_name_sequence.html), a program which demonstrates ways to generate a sequence of filenames, which can be useful when generating a sequence of still snapshots to be animated later.
279. [files\_multiple](files_multiple/files_multiple.html), a program which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.
280. [filon](filon/filon.html), a library which can approximate integrals in which the integrand includes an oscillatory factor of sin(k\*x) or cos(k\*x).
281. [filum](filum/filum.html), a library which handles files and filenames;
282. [fire\_serial](fire_serial/fire_serial.html), a program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.
283. [flame\_ode](flame_ode/flame_ode.html), a library which considers an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process.
284. [floyd](floyd/floyd.html), a library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.
285. [fmincon](fmincon/fmincon.html), programs which illustrate the use of fmincon() from MATLAB's Optimization Toolbox, which seeks the minimizer of a scalar function of multiple variables, within a region specified by linear constraints and bounds.
286. [fmincon\_parallel](fmincon_parallel/fmincon_parallel.html), a program which demonstrates the use of MATLAB's fmincon() constrained minimization function, taking advantage of the Parallel Computing Toolbox for faster execution.
287. [fn](fn/fn.html), a library which evaluates elementary and special functions using Chebyshev polynomials; functions include Airy, Bessel I, J, K and Y, beta, confluent hypergeometric, error, gamma, log gamma, Pochhammer, Spence; integrals include hyperbolic cosine, cosine, Dawson, exponential, logarithmic, hyperbolic sine, sine; by Wayne Fullerton.
288. [freefem++\_msh\_io](freefem++_msh_io/freefem++_msh_io.html), a library which can read and write files used by the FreeFem++ finite element program to store mesh information.
289. [gamblers\_ruin\_simulation](gamblers_ruin_simulation/gamblers_ruin_simulation.html), a program which simulates the game of gambler's ruin.
290. [gauss\_seidel](gauss_seidel/gauss_seidel.html), a program which implements the Gauss-Seidel iteration for linear systems.
291. [gauss\_seidel\_poisson\_1d](gauss_seidel_poisson_1d/gauss_seidel_poisson_1d.html), a program which demonstrates how the linear system for a discretized version of the steady 1D Poisson equation can be solved by the Gauss-Seidel iteration.
292. [gegenbauer\_rule](gegenbauer_rule/gegenbauer_rule.html), a program which computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
293. [gen\_hermite\_rule](gen_hermite_rule/gen_hermite_rule.html), a program which computes and writes out a generalized Gauss-Hermite quadrature rule of given order and parameter value.
294. [gen\_laguerre\_rule](gen_laguerre_rule/gen_laguerre_rule.html), a program which computes and writes out a generalized Gauss-Laguerre quadrature rule of given order and parameter value.
295. [geometry](geometry/geometry.html), a library which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.
296. [gl\_display](gl_display/gl_display.html), a program which displays the points used in a 2D Gauss-Legendre quadrature rule;
297. [gmsh\_io](gmsh_io/gmsh_io.html), a library which can read or write some of the files created by the Gmsh program for 1D, 2D or 3D meshes used by the finite element method (FEM).
298. [gmsh\_to\_fem](gmsh_to_fem/gmsh_to_fem.html), a program 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.
299. [gnuplot](gnuplot/gnuplot.html), programs which illustrate how a program can write data and command files so that gnuplot can create plots of the program results.
300. [gpl\_display](gpl_display/gpl_display.html), a library which tries to read the data in a typical gnuplot GPL file, and display it in a more attractive way than gnuplot is capable of.
301. [graph\_representation](graph_representation/graph_representation.html), a library which can express the representation of an abstract mathematical graph in several ways.
302. [graphics\_examples](graphics_examples/graphics_examples.html), programs which illustrate how various kinds of data can be displayed and analyzed graphically.
303. [gray\_code\_display](gray_code_display/gray_code_display.html), a program 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.
304. [grf\_display](grf_display/grf_display.html), a program which reads a GRF file defining a mathematical graph and displays it in the MATLAB graphics window.
305. [grf\_io](grf_io/grf_io.html), a library which reads or writes a GRF file;
306. [grid\_display](grid_display/grid_display.html), a program which reads a file of points on a grid or sparse grid, displays the grid and saves the image in a png file;
307. [gridlines](gridlines/gridlines.html), a library which gives the user more control over drawing gridlines on a graph than the built in "grid on" command.
308. [grids\_display](grids_display/grids_display.html), a program which reads two files of grids or sparse grids, displaying the first with hollow blue dots, the second with solid red dots.
309. [haar](haar/haar.html), a library which computes the Haar transform of data.
310. [halton](halton/halton.html), a library which calculates the Halton M dimensional quasirandom sequence;
311. [halton\_dataset](halton_dataset/halton_dataset.html), a program which creates N elements of an M dimensional Halton sequence and writes them to a file.
312. [hammersley](hammersley/hammersley.html), a library which computes the Hammersley M dimensional quasirandom sequence;
313. [hammersley\_dataset](hammersley_dataset/hammersley_dataset.html), a program which creates N elements of an M dimensional Hammersley sequence and writes them to a file.
314. [hand\_data](hand_data/hand_data.html), programs which carry out some numerical exercises based on data that came from tracing several points on a person's hand.
315. [hb\_io](hb_io/hb_io.html), a library which reads and writes files in the Harwell Boeing (HB) sparse matrix format;
316. [hb\_to\_mm](hb_to_mm/hb_to_mm.html), a program which converts a sparse matrix stored in a Harwell Boeing (HB) file to Matrix Market (MM) format;
317. [hb\_to\_msm](hb_to_msm/hb_to_msm.html), a program which converts a sparse matrix stored in a Harwell Boeing (HB) file to MATLAB sparse matrix format;
318. [hb\_to\_st](hb_to_st/hb_to_st.html), a program which reads a sparse matrix in a Harwell Boeing (HB) file and writes an equivalent Sparse Triplet (ST) file.
319. [hcell\_flow\_display](hcell_flow_display/hcell_flow_display.html), a program which plots the physical data, pressures or velocities, from a run of the hcell program;
320. [heat\_oned](heat_oned/heat_oned.html), a program which solves the time-dependent 1D heat equation, using the finite element method in space, and the backward Euler method in time, by Jeff Borggaard.
321. [heated\_plate](heated_plate/heated_plate.html), a program which solves the steady state heat equation in a 2D rectangular region, and is intended as a starting point for a parallel version.
322. [heated\_plate\_parfor](heated_plate_parfor/heated_plate_parfor.html), a program which solves the steady state heat equation in a 2D rectangular region, using MATLAB's parfor command to execute in parallel.
323. [hello](hello/hello.html), a program which prints out "Hello, world!".
324. [hello\_parfor](hello_parfor/hello_parfor.html), a program which prints out "Hello, world!" multiple times, using MATLAB's parfor command for parallel execution.
325. [hermite](hermite/hermite.html), a library which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
326. [hermite\_cubic](hermite_cubic/hermite_cubic.html), a library which can compute the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.
327. [hermite\_exactness](hermite_exactness/hermite_exactness.html), a program 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).
328. [hermite\_polynomial](hermite_polynomial/hermite_polynomial.html), a library which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
329. [hermite\_product\_display](hermite_product_display/hermite_product_display.html), a program 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).
330. [hermite\_product\_polynomial](hermite_product_polynomial/hermite_product_polynomial.html), a library which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
331. [hermite\_rule](hermite_rule/hermite_rule.html), a program which computes and writes out a Gauss-Hermite quadrature rule to estimate the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
332. [hermite\_test\_int](hermite_test_int/hermite_test_int.html), a library which defines test integrands for Hermite integrals with density exp(-x^2) over the interval (-oo,+oo).
333. [high\_card\_parfor](high_card_parfor/high_card_parfor.html), a program which uses the parfor statement to compute in parallel the statistics for a card game in which you are required to guess the location of the highest card.
334. [high\_card\_simulation](high_card_simulation/high_card_simulation.html), a program 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.
335. [histogram\_discrete](histogram_discrete/histogram_discrete.html), a library which tries to make a histogram of data without using bins.
336. [histogram\_display](histogram_display/histogram_display.html), a program 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;
337. [hyperball\_integrals](hype

本源码包内暂不包含可直接显示的源代码文件,请下载源码包。