Thursday, May 31, 2012

MATLAB Source Codes


MATLAB Source Codes

Click on below links


  1. args, a program which shows how to count and report command line arguments;
  2. arpack, a library which computes eigenvalues and eigenvectors of large sparse matrices, accessible via the built-in EIGS command;
  3. asa005 a library which evaluates the lower tail of the noncentral Student's T distribution; this is Applied Statistics Algorithm 5;
  4. asa006 a library which computes the Cholesky factor of a positive definite symmetric matrix; this is Applied Statistics Algorithm 6;
  5. asa007 a library which computes the inverse of a positive definite symmetric matrix; this is Applied Statistics Algorithm 7;
  6. asa032 a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 32;
  7. asa047 a library which minimizes a scalar function of several variables using the Nelder-Mead algorithm; this is Applied Statistics Algorithm 47;
  8. asa058 a library which carries out clustering of data; this is Applied Statistics Algorithm 58;
  9. asa063 a library which evaluates the incomplete Beta function; this is Applied Statistics Algorithm 63;
  10. asa066 a library which computes the cumulative density function of the standard normal distribution; this is Applied Statistics Algorithm 66;
  11. asa076 a library which evaluates Owen's T function; this is Applied Statistics Algorithm 76;
  12. asa091, a library which computes the percentage points of the Chi-square distribution; this is Applied Statistics Algorithm 91;
  13. asa103, a library which evaluates the digamma or psi function; this is Applied Statistics Algorithm 103;
  14. asa109 a library which inverts the incomplete Beta function; this is Applied Statistics Algorithm 109;
  15. asa111 a library which evaluates the percentage points of the normal distribution; this is Applied Statistics Algorithm 111;
  16. asa113 a library which clusters data using the Banfield and Bassill transfer and swap algorithm; this is Applied Statistics Algorithm 113;
  17. asa121, a library which evaluates the trigamma function; this is Applied Statistics Algorithm 121;
  18. asa136 a library which clusters data using the Hartigan and Wong algorithm; this is Applied Statistics Algorithm 136;
  19. asa144 a library which randomly generates tables with given row and column sums; this is Applied Statistics Algorithm 144;
  20. asa147 a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 147;
  21. asa152, a library which evaluates point and cumulative probabilities associated with the hypergeometric distribution; this is Applied Statistics Algorithm 152;
  22. asa159, a library which computes a random table with given row and column sums; this is Applied Statistics Algorithm 159;
  23. asa172 a library which simulates the generation of a set of multi-indices by nested DO-Loops; this is Applied Statistics Algorithm 172;
  24. asa183, a library which implements the Wichman-Hill pseudorandom number generator; this is Applied Statistics Algorithm 183;
  25. asa226 a library which evaluates the noncentral incomplete Beta function; this is Applied Statistics Algorithm 226;
  26. asa239 a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 239;
  27. asa241, a library which computes the inverse of the normal CDF; this is Applied Statistics Algorithm 241;
  28. asa243 a library which evaluates the lower tail of the noncentral Student's T distribution; this is Applied Statistics Algorithm 243;
  29. asa245 a library which evaluates the logarithm of the Gamma function; this is Applied Statistics Algorithm 245;
  30. asa266, a library which evaluates various properties of the Dirichlet probability density function; this is Applied Statistics Algorithm 266;
  31. asa299, a library which computes the lattice points (integer coordinates) in an M-dimensional simplex; this is Applied Statistics Algorithm 299;
  32. asa310 a library which evaluates the noncentral incomplete Beta function; this is Applied Statistics Algorithm 310;
  33. ball_and_stick_display, a program which demonstrates the creation of a 3D "ball and stick" image;
  34. ball_grid, a library which computes grid points inside a ball.
  35. ball_volume_monte_carlo, a program which applies a Monte Carlo procedure to estimate the volume of the M-dimensional unit ball;
  36. beta_nc, a library which evaluates the CDF of the noncentral Beta distribution;
  37. bezier_surface, a library which reads, writes, prints and manipulates the data that defines a Bezier surface;
  38. bezier_surface_display, a program which displays a Bezier surface;
  39. birthday_remote, 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.
  40. black_scholes, a library which implements some simple approaches to the Black-Scholes option valuation theory;
  41. blas1_c, a library which implements the Level 1 Basic Linear Algebra Subprograms, using single precision complex arithmetic;
  42. blas1_d, a library which implements the Level 1 Basic Linear Algebra Subprograms, using double precision real arithmetic;
  43. blas1_s, a library which implements the Level 1 Basic Linear Algebra Subprograms, using single precision real arithmetic;
  44. blas1_z, a library which implements the Level 1 Basic Linear Algebra Subprograms, using double precision complex arithmetic;
  45. blend, a library which carries out 1D/2D/3D blending interpolation;
  46. box_behnken, a library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;
  47. box_plot, a program which displays a box plot of data that consists of pairs of integers;
  48. brain_sensor_pod a program which applies the method of Proper Orthogonal Decomposition to seek underlying patterns in sets of 40 sensor readings of brain activity.
  49. brent a library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  50. buckling_spring a program which plots solutions of the buckling spring equations.
  51. c8lib, a library which implements certain elementary functions for double precision complex variables;
  52. calendar_nyt, a library which shows the correspondence between dates and the New York Times volume and issue number;
  53. cavity_flow_display, a library which displays a single velocity field solution for the driven cavity;
  54. cavity_flow_movie, a library which animates the velocity solutions for the driven cavity;
  55. cc_display, a program which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
  56. ccvt_box, a program which calculates a constrained CVT for points constrained to lie in a box, with some points moved to the boundary;
  57. ccvt_reflect, a program which calculates a constrained CVT for points constrained to lie in a box, with some points "pushed" towards the boundary;
  58. cell_detection_tasks, a program which creates modified versions of a sequence of gray-scale TIF files containing images of cells; the process of each file is carried out independently, using the "task" feature of MATLAB's parallel computing toolbox.
  59. cg_distributed, a program which implements a version of the NAS CG conjugate gradient benchmark, using distributed memory.
  60. cg_lab_triangles, a collection of programs associated with a computer lab assignment on computational geometry and triangles;
  61. chebyshev1_rule, a program which computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
  62. chebyshev2_rule, a program which computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
  63. chrpak, a library which manipulates characters and strings;
  64. circle_grid, a library which computes grid points inside a circle.
  65. cities, a library which works with city-to-city distance matrices;
  66. clenshaw_curtis_rule, a program which implements a Clenshaw Curtis quadrature rule;
  67. collatz, a library which computes and analyzes the Collatz sequence (or "hailstone" sequence or "3n+1 sequence");
  68. collatz_parfor is a program which seeks the maximum Collatz sequence between 1 and N; it runs in parallel using MATLAB's "parfor" facility.
  69. color_remote, 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.
  70. colored_noise, a library which generates samples of noise obeying a 1/f^alpha power law.
  71. combo, a library which handles combinatorial problems, by Kreher and Stinson;
  72. complex_numbers, a program which demonstrates some simple features involved in the use of complex numbers in C programming.
  73. contour_sequence4, a program which creates images suitable for animation from one XY file and a sequence of U(X,Y) data files;
  74. contrast_spmd, a program which demonstrates the SPMD parallel programming feature for image operations; the client reads an image, the workers heighten contrast over portions of it, and the client assembles and displays the results.
  75. contrast2_spmd, a program which demonstrates the SPMD parallel programming feature 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.
  76. coordinate_search, a program which implements the coordinate search algorithm for the minimization of a scalar function of several variables.
  77. cordic, a library which computes a few special functions using the CORDIC algorithm.
  78. cvt, a library which computes an N-point Centroidal Voronoi Tessellation in M dimensions;
  79. cvt_1d_lloyd a program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using exact techniques to determine the Voronoi regions.
  80. cvt_1d_nonuniform, a program which computes an N-point Centroidal Voronoi Tessellation in 1 dimension, under a nonuniform density, and plots the evolution of the locations of the generators during the iteration;
  81. cvt_1d_sampling 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.
  82. cvt_dataset a program which creates a CVT dataset;
  83. cvt_demo, a program which interactively, graphically demonstrates a CVT calculation;
  84. cvt_metric, a program which computes a CVT under a spatially varying metric;
  85. cvt_movie, a program which creates an animation of the evolution of a CVT;
  86. cvt_movie2, a program which creates a CVT movie;
  87. cvt_movie3, a program which creates a CVT movie in a region of unusual shape;
  88. cvt_movie4, a program which creates a CVT movie in a square, with a density function that drives points to the corners;
  89. cvt_movie5, a program which repeats cvt_movie3, but with hexagonal grid initialization, fixed points, and boundary projection;
  90. cyclic_reduction, a library which solves a tridiagonal linear system using cyclic reduction;
  91. dice_simulation a program which simulates N tosses of M dice, making a histogram of the results.
  92. dijkstra a program which runs a simple example of Dijkstra's minimum distance algorithm for graphs.
  93. dijkstra_spmd a program which uses the SPMD feature to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.
  94. direction_arrows, a program which reads coordinate data from one file, velocity data from another file, and makes an arrow plot of the direction field.
  95. direction_arrows_grid, a program which reads velocity data at "scattered" points, and makes a direction vector plot on a uniform grid of user-specified density.
  96. direction_arrows_sequence, a program which reads a fixed coordinate file, and a sequence of velocity data files and makes a sequence of velocity direction arrow plots.
  97. discrete_pdf_sample a program 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.
  98. dist_plot, a program which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh code;
  99. distance_to_position a program which estimates the positions of cities based on a city-to-city distance table.
  100. distance_to_position_sphere a program which estimates the positions of cities on a sphere (such as the earth) based on a city-to-city distance table.
  101. distmesh, a library which carries out Persson and Strang's method of mesh generation;
  102. distmesh_3d, a library which constitutes the 3D subset of Persson and Strang's distmesh code;
  103. divdif, a library which constructs, evaluates and manipulates divided difference tables;
  104. duel_simulation a program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  105. dunavant, a library which defines Dunavant quadrature rules in a triangle;
  106. ellipse_grid, a library which computes grid points inside an ellipse.
  107. ellipsoid_grid, a library which computes grid points inside a 3D ellipsoid.
  108. entrust, a library which uses trust-region methods to solve problems in scalar optimization or nonlinear least squares, by Borggaard and Cliff.
  109. face_spmd, 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.
  110. faure, a library which computes the Faure M-dimensional quasirandom sequence;
  111. faure_dataset, a program which creates a multivariate Faure quasirandom dataset;
  112. fd_predator_prey, a program which solves a time-dependent predator prey system using a finite difference approximation.
  113. fd_to_tec is a program which converts FD (finite difference) models into TECPLOT ASCII files.
  114. fd1d_burgers_lax, a program which applies the finite difference method and the Lax Wendroff method to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  115. fd1d_burgers_leap, a program which applies the finite difference method and the leapfrog approach to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  116. fd1d_bvp, a program which applies the finite difference method to a two point boundary value problem in one spatial dimension.
  117. fd1d_display, a program which reads a pair of files defining a 1D finite difference model, and plots the data.
  118. fd1d_heat_explicit, a program which implements a finite difference solution, explicit in time, of the time dependent 1D heat equation;
  119. fd1d_heat_implicit, a program which implements a finite difference solution, implicit in time, of the time dependent 1D heat equation;
  120. fd1d_heat_steady, a program which implements a finite difference solution for the steady (time independent) 1D heat equation;
  121. fd1d_predator_prey, a program which implements a finite difference algorithm for a time and 1D space dependent predator-prey system;
  122. fd1d_predator_prey_plot, a program which plots solutions from the FD1D_PREDATOR_PREY program.
  123. fd1d_wave, a program which applies the finite difference method to solve the time-dependent wave equation in one spatial dimension.
  124. fd2d_heat_explicit_spmd is a MATLAB program which uses the finite difference method 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.
  125. fd2d_predator_prey, a program which implements a finite difference algorithm for a time and 2D space dependent predator-prey system.
  126. fekete, a library which sets up one of seven Fekete rules for interpolation or quadrature in a triangle;
  127. felippa, a library which defines quadrature rules for lines, triangles, quadrilaterals, pyramids, wedges, tetrahedrons and hexahedrons.
  128. fem_50, a program which implements a Finite Element Method solver using about 50 lines of MATLAB code;
  129. fem_50_heat, a program which is a version of fem_50 for the time-dependent heat equation;
  130. fem_basis, a library which can define and evaluate basis functions for any degree in an M-dimensional simplex (1D interval, 2D triangle, 3D tetrahedron, and higher dimensional generalizations.)
  131. fem_basis_q4_display, a program which displays any single basis function associated with an arbitrary linear quadrilateral ("Q4") mesh;
  132. fem_basis_t3_display, a program which displays any single basis function associated with an arbitrary 3-node triangle "T3" mesh;
  133. fem_basis_t4_display, a program which displays any single basis function associated with an arbitrary 4-node triangle "T4" mesh;
  134. fem_basis_t6_display, a program which displays any single basis function associated with an arbitrary 6-node triangle "T6" mesh;
  135. fem_io, a library which reads or writes FEM files, (three text files describing a finite element model);
  136. fem_to_mesh is a program which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding MESH file.
  137. fem_to_tec, a program which reads a set of FEM files, (three text files describing a finite element model), and writes a TECPLOT ASCII file.
  138. fem1d, a program which applies the finite element method, using piecewise linear basis functions, to a linear two point boundary value problem in 1D;
  139. fem1d_adaptive, a program which uses an adaptive mesh when applying the finite element method, with piecewise linear basis functions, to a linear two point boundary value problem in 1D;
  140. fem1d_bvp_linear, a program which applies the finite element method, with piecewise linear elements, to a two point boundary value problem in one spatial dimension.
  141. fem1d_function_10_display is a program which reads a prefix defining three finite element data files, reads the data, samples the finite element function, and displays a plot.
  142. fem1d_nonlinear, a program which applies the finite element method, with piecewise linear basis functions, to a nonlinear two point boundary value problem in 1D;
  143. fem1d_pmethod, a program which applies the p-method version of the finite element method to a linear two point boundary value problem in 1D;
  144. fem1d_project is 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.
  145. fem1d_sample, 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.
  146. fem2d_heat, a program which applies the finite element method to the time dependent heat equation on an arbitrary triangulated region in 2D;
  147. fem2d_heat_rectangle, a program which applies the finite element method for the time-dependent heat equation on a triangulated square in 2D;
  148. fem2d_heat_rectangle_steady_spmd, a program which uses the MATLAB Parallel Computing Toolbox in SPMD mode to set up and solve a distributed linear system for the steady 2d heat equation.
  149. fem2d_heat_sparse, a program which applies the finite element method to the heat equation on an arbitrary triangulated region in 2D, using MATLAB's sparse matrix features;
  150. fem2d_heat_sparse_square, 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.
  151. fem2d_heat_square is 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.
  152. fem2d_navier_stokes, a program which applies the finite element method to the steady incompressible Navier Stokes equations on an arbitrary triangulated region in 2D;
  153. fem2d_navier_stokes_cavity is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "cavity" problem.
  154. fem2d_navier_stokes_channel is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "channel" problem.
  155. fem2d_navier_stokes_sparse, a program which applies the finite element method to the steady incompressible Navier Stokes equations on an arbitrary triangulated region in 2D, using MATLAB's sparse matrix features;
  156. fem2d_navier_stokes_sparse_big_cavity is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "big cavity" problem.
  157. fem2d_navier_stokes_sparse_cavity is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "cavity" problem.
  158. fem2d_navier_stokes_sparse_channel is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "channel" problem.
  159. fem2d_navier_stokes_sparse_inout is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "inout" problem.
  160. fem2d_pack, a library which performs simple 2D finite element computations;
  161. fem2d_poisson, a program which applies the finite element method to Poisson's equation on an arbitrary triangulated region in 2D;
  162. fem2d_poisson_ell is 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 as part of a solution procedure.
  163. fem2d_poisson_lake is 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 as part of a solution procedure.
  164. fem2d_poisson_rectangle, a program which solves the 2D Poissone equation on a rectangle, using the finite element method, and piecewise quadratic triangular elements.
  165. fem2d_poisson_rectangle_linear is a program which solves the 2D Poisson equation on a rectangle, using the finite element method, and piecewise linear triangular elements.
  166. fem2d_poisson_sparse, 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 and an iterative solver.)
  167. fem2d_poisson_sparse_ell is 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.
  168. fem2d_poisson_sparse_lake is 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.
  169. fem2d_project is a program which projects a function F(X,Y), given as data, into a given finite element space of piecewise linear triangular elements.
  170. fem2d_project_function is a program which projects a function F(X,Y), given as a formula, into a given finite element space of piecewise linear triangular elements.
  171. fem2d_sample, a program which samples a finite element function, defined by FEM files, (three text files describing the nodes, triangles, and coefficients); at arbitrary points.
  172. fem2d_stokes, a program which applies the finite element method for the steady incompressible Stokes equations on an arbitrary triangulated region in 2D;
  173. fem2d_stokes_cavity is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "cavity" problem.
  174. fem2d_stokes_channel is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "channel" problem.
  175. fem2d_stokes_inout is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "inout" problem.
  176. fem2d_stokes_sparse, a program which is a finite element code for the steady incompressible Stokes equations on an arbitrary triangulated region in 2D, using MATLAB's sparse matrix features;
  177. fem2d_stokes_sparse_big_cavity is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "big cavity" problem.
  178. fem2d_stokes_sparse_cavity is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "cavity" problem.
  179. fem2d_stokes_sparse_channel is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "channel" problem.
  180. fem2d_stokes_sparse_inout is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "inout" problem.
  181. fem2d_stokes_sparse_spiral is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "spiral" problem.
  182. fem2d_stokes_spiral is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "spiral" problem.
  183. fem3d_pack is a library which contains utilities for 3D finite element calculations.
  184. fem3d_project is a program which projects a function F(X,Y,Z), given as a data, into a given finite element space of piecewise linear tetrahedral elements.
  185. fem3d_sample is a program library which evaluates a finite element function defined on a 3D tetrahedral mesh.
  186. feynman_kac, a program which demonstrates the use of the Feynman-Kac algorithm for solving certain partial differential equations.
  187. fft_serial is a program which computes a Fast Fourier Transform, and is intended as a starting point for implementing a parallel version.
  188. file_increment, a program which makes a copy of a file containing an integer array, after incrementing each entry by a given value.
  189. file_name_sequence a program which demonstrates four ways to generate a sequence of filenames.
  190. filum, a library which handles files and filenames;
  191. floyd is a library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  192. fmincon is a function included in MATLAB's Optimization Toolbox which seeks the minimizer of a scalar function of multiple variables, within a region specified by linear constraints and bounds; this directory contains some examples of the use of FMINCON.
  193. fmincon_parallel, a program which demonstrates the use of MATLAB's FMINCON constrained minimization function, taking advantage of MATLAB's Parallel Computing Toolbox for faster execution.
  194. gamblers_ruin_simulation, a program which simulates the game of gambler's ruin.
  195. gegenbauer_rule, a program which computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
  196. gen_hermite_rule, a program which computes and writes out a generalized Gauss-Hermite quadrature rule of given order and parameter value ALPHA.
  197. gen_laguerre_rule, a program which computes and writes out a generalized Gauss-Laguerre quadrature rule of given order and parameter value ALPHA.
  198. geometry, a library which performs 2D/3D geometric calculations;
  199. geompack, a library which computes the Delaunay triangulation for a set of points in 2D;
  200. gl_display, a program which displays the points used in a 2D Gauss-Legendre quadrature rule;
  201. gm_rules, a library which defines Grundmann-Moeller quadratures rules for a triangle, tetrahedron, or M-dimensional simplex.
  202. graph_representation, a library which can express the representation of an abstract mathematical graph in several ways.
  203. grf_display, a program which reads a GRF file defining a mathematical graph and displays it in the MATLAB graphics window.
  204. grf_io, a library which reads or writes a GRF file;
  205. grid, a library which computes N random points on a uniform M-dimensional grid;
  206. grid_dataset, a program which creates a grid dataset;
  207. gridlines is a library which gives the user more control over drawing gridlines on a graph than the built in "grid on" command.
  208. halton, a library which calculates the Halton M-dimensional quasirandom sequence;
  209. halton_dataset, a program which creates N elements of an M-dimensional Halton sequence and writes them to a file.
  210. hammersley, a library which computes the Hammersley M-dimensional quasirandom sequence;
  211. hammersley_dataset, a program which creates N elements of an M-dimensional Hammersley sequence and writes them to a file.
  212. hb_io, a library which reads and writes files in the Harwell Boeing sparse matrix format;
  213. hb_to_mm, a program which converts a sparse matrix stored in a Harwell Boeing file to Matrix Market format;
  214. hb_to_msm, a program which converts a sparse matrix stored in a Harwell Boeing file to MATLAB sparse matrix format;
  215. hb_to_st a program which reads a sparse matrix in a Harwell-Boeing file and writes an equivalent Sparse Triplet file.
  216. hcell_flow_display, a program which plots the physical data, pressures or velocities, from a run of the HCELL program;
  217. heated_plate is 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.
  218. hello, a program which prints out "Hello, world!".
  219. hermite_cubic, is 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.
  220. hermite_phys_product, a library which writes out a table of the integrals of products of pairs of Hermite (physicist) polynomials with a linear or exponential weight.
  221. hermite_prob_product, a library which writes out a table of the integrals of products of pairs of Hermite (probabilist) polynomials with a linear or exponential weight.
  222. hermite_rule, a program which computes and writes out a Gauss-Hermite quadrature rule of given order.
  223. hex_grid, a library which generates a hexagonal grid of points in the unit square or an arbitrary rectangle;
  224. hex_grid_angle, a library which defines a hexagonal grid of points in the unit square, with an arbitrary center, angle, and spacing.
  225. hex_grid_dataset, a program which creates a hexagonal grid of points in a rectangle, and write them to a file, using the hex_grid library.
  226. histogram_display, 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;
  227. hot_pipe, a program which demonstrates fem_50_heat to solve a particular heat equation problem;
  228. hot_point, a program which demonstrates fem_50_heat to solve a particular heat equation problem;
  229. i4lib, a library which contains many utility routines, using "I4" or "single precision integer" arithmetic.
  230. ice_io a library which reads or writes ICE grid files stored in NETCDF format.
  231. ice_to_mesh is a program which reads a NETCDF file containing an ICE dataset and rewrites the information as a MESH file.
  232. ihs, a library which generates the Improved Distributed Hypercube Sampling M-dimensional quasirandom sequence;
  233. ihs_dataset, a program which creates an IHS dataset and writes it to a file;
  234. image_contrast, programs which applies image processing techniques to increase the contrast in an image.
  235. image_denoise, programs which apply filtering operations to a noisy image.
  236. image_denoise_spmd, scripts which demonstrates the SPMD parallel programming feature for image operations; the client reads an image, the workers process portions of it, and the client assembles and displays the results.
  237. image_edge a library which demonstrates a simple procedure for edge detection in images.
  238. image_quantization, a MATLAB library which demonstrates how the KMEANS algorithm can be used to reduce the number of colors or shades of gray in an image.
  239. inout_flow_display, a library which displays a single velocity field solution for the INOUT flow;
  240. inout_flow_movie, a library which creates an animation of the velocity solutions for the INOUT cell;
  241. int_exactness, a program which tests the polynomial exactness of quadrature rules for a finite interval;
  242. int_exactness_chebyshev1, a program which tests the polynomial exactness of Gauss-Chebyshev type 1 quadrature rules.
  243. int_exactness_chebyshev2, a program which tests the polynomial exactness of Gauss-Chebyshev type 2 quadrature rules.
  244. int_exactness_gegenbauer, a program which tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
  245. int_exactness_gen_hermite, a program which tests the polynomial exactness of generalized Gauss-Hermite quadrature rules.
  246. int_exactness_gen_laguerre, a program which tests the polynomial exactness of generalized Gauss-Laguerre quadrature rules.
  247. int_exactness_hermite, a program which tests the polynomial exactness of Gauss-Hermite quadrature rules.
  248. int_exactness_jacobi, a program which tests the polynomial exactness of Gauss-Jacobi quadrature rules.
  249. int_exactness_laguerre, a program which tests the polynomial exactness of Gauss-Laguerre quadrature rules.
  250. int_exactness_legendre, a program which tests the polynomial exactness of Gauss-Legendre quadrature rules.
  251. jacobi_rule, a program which computes and writes out a Gauss-Jacobi quadrature rule of given order.
  252. keast, a library which defines Keast quadrature rules in a tetrahedron;
  253. kelley, a library which implements iterative methods for linear and nonlinear equations, by Tim Kelley;
  254. kmeans, a library which handles the K-Means problem;
  255. knapsack_tasks, a program which solves a knapsack problem by subdividing it into tasks, each of which is carried out as a separate program.
  256. kronrod, is a library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  257. laguerre_product, a library which writes out a table of the integrals of products of pairs of Laguerre polynomials with a linear or exponential weight.
  258. laguerre_rule, a program which computes and writes out a Gauss-Laguerre quadrature rule of given order.
  259. latin_center, a library which computes N points in an M-dimensional Latin Center square;
  260. latin_center_dataset, a program which creates a Latin Center Hypercube dataset;
  261. latin_edge, a library which returns N points in an M-dimensional Latin Edge square;
  262. latin_edge_dataset, a program which creates an N-point M-dimensional Latin Edge square dataset;
  263. latin_random, a library which returns N points in an M-dimensional Latin Random square;
  264. latin_random_dataset, a program which creates a Latin Random Hypercube dataset;
  265. latinize, a program which adjusts N points in M dimensions to form a Latin hypercube;
  266. lattice_rule, a library which returns lattice rules for M-dimensional integration;
  267. lcvt, a library which makes a sort of Latinized CVT (centroidal Voronoi tessellation);
  268. lcvt_dataset, a program which creates a Latinized CVT dataset;
  269. legendre_product, a library which writes out a table of the integrals of products of pairs of Legendre polynomials with a linear or exponential weight.
  270. legendre_rule, a program which writes out a Gauss-Legendre quadrature rule of given order.
  271. legendre_rule_fast, a program which uses a fast (order N) algorithm to compute a Gauss-Legendre quadrature rule of given order.
  272. lemke, a library which implements Lemke's algorithm for the linear complementarity problem, by Paul Fackler and Mario Miranda.
  273. levels, a library which makes a contour plot, choosing the contour levels using random sampling.
  274. linear_solve_distributed is a program which solves a linear system A*x=b using MATLAB's spmd facility, so that the matrix A is "distributed" across multiple MATLAB workers.
  275. linpack_bench, a program which is the LINPACK benchmark;
  276. linpack_bench_backslash, a program which is the LINPACK benchmark, using MATLAB's builtin "backslash" operator;
  277. linpack_c, a library which constitutes a linear algebra library for single precision complex arithmetic;
  278. linpack_d, a library which constitutes a linear algebra library for double precision real arithmetic;
  279. linpack_s, a library which constitutes a linear algebra library; for single precision real arithmetic;
  280. linpack_z, a library which constitutes a linear algebra library for double precision complex arithmetic;
  281. linplus, a library which factors/solves/multiplies matrices in a variety of formats;
  282. lorenz_simulation, a program which computes and displays solutions of the Lorenz equations for various initial conditions.
  283. lyness_rule, a library which returns Lyness-Jespersen quadrature rules for the triangle.
  284. lyrics_remote, a program which runs in parallel, using three workers which cooperate "systolically", that is, as through they were on an assembly line. The output from worker 1 is passed to worker 2 for further processing, and so on. 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.
  285. machar, a library which dynamically computes the value of various machine characteristic constants;
  286. machine, a library which returns tabulated values of the constants associated with computer arithmetic
  287. mandelbrot, a program which generates an image of the Mandelbrot set;
  288. matlab, examples which illustrate the use of MATLAB scripts and M-files;
  289. matlab_commandline, examples which illustrate how MATLAB can be run from the UNIX command line, that is, not with the usual MATLAB command window.
  290. matlab_calls_c, examples which illustrate how C functions can be written, compiled, and called from MATLAB using the MEX facility;
  291. matlab_calls_f77, examples which illustrate how FORTRAN77 functions can be written, compiled, and called from MATLAB using MATLAB's mex facility;
  292. matlab_distcomp, a MATLAB program which remotely runs a set of 5 jobs on the Ithaca cluster. These jobs are equivalent to the BIRTHDAY_REMOTE, COLOR_REMOTE, KNAPSACK_TASKS, LYRICS_REMOTE and MD_PARALLEL jobs.
  293. matlab_movies, examples which illustrate making movies using MATLAB;
  294. matlab_os, examples which illustrate how the system command can be used to allow MATLAB to issue commands to the computer operating system (UNIX or DOS);
  295. matlab_parallel, examples which illustrate "local" parallel programming on a single computer with MATLAB's Parallel Computing Toolbox.
  296. matlab_remote, examples which illustrate the use of remote job execution, in which a desktop copy of MATLAB sends programs and data to a remote machine for execution. Included is information needed to properly configure the local machine.
  297. md is a program which carries out a molecular dynamics simulation, and is intended as a starting point for implementing a parallel version.
  298. md_parfor is a program which carries out a molecular dynamics simulation; it runs in parallel using MATLAB's "parfor" facility.
  299. memory_test, a program which tests the memory available on the computer by declaring and using big vectors.
  300. mesh_bandwidth, a program which returns the geometric bandwidth associated with a mesh of elements of any order and in a space of M dimensions.
  301. mesh_display, a program which reads a 2D mesh of elements of any uniform order and displays a plot of the elements and nodes, with optional numbering.
  302. mesh_io is a library which can read or write MESH files, which can be used to define the geometry of a finite element mesh in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.
  303. mesh_to_ice is a program which reads the ICE dataset information from a MESH files and rewrites it to a NETCDF file.
  304. mex, a directory of programs which call lower-level functions written in traditional languages such as C, C++, FORTRAN77 or FORTRAN90, compiled with MATLAB's mex compiler.
  305. mgmres, a library which applies the restarted GMRES algorithm to a sparse linear system, by Lili Ju;
  306. mm_io, a library which reads and writes a Matrix Market Sparse Matrix File;
  307. mm_to_hb, a program which reads a Matrix Market sparse matrix file and creates a corresponding HB Harwell Boeing sparse matrix file.
  308. mm_to_msm, a program which reads a Matrix Market sparse matrix file and creates a corresponding MATLAB sparse matrix data structure.
  309. mm_to_st, a program which reads a Matrix Market sparse matrix file and writes a corresponding ST Sparse Triplet file.
  310. moc_display, a program which estimates and displays the modulus of continuity function for a given function F(X) over a finite interval [A,B], using N sample values.
  311. mpas_grid_display, programs which can read an MPAS NETCDF grid file and display the primary polygonal mesh or the dual triangular mesh.
  312. msm_to_hb, a program which writes a MATLAB sparse matrix to a Harwell Boeing file;
  313. msm_to_mm, a program which writes a MATLAB sparse matrix to a Matrix Market file;
  314. msm_to_st, a program which writes a MATLAB sparse matrix to a ST Sparse Triplet file;
  315. mxm a program 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.
  316. mxv, a program which compares the performance of (DO I, DO J) loops and (DO J, DO I ) loops for computing the product of an MxN matrix A and an N vector X.
  317. nas a program which runs the NASA kernel benchmark.
  318. ncc_tetrahedron, a library which defines Newton-Cotes closed quadrature rules in a tetrahedron;
  319. ncc_triangle, a library which defines Newton-Cotes closed quadrature rules in a triangle;
  320. nco_tetrahedron, a library which defines Newton-Cotes open quadrature rules in a tetrahedron;
  321. nco_triangle, a library which defines Newton-Cotes open quadrature rules in a triangle;
  322. neighbors_to_metis_graph, a program which reads a file describing the neighbor structure of a triangulation or tet mesh, and writes a METIS GRAPH file suitable for input to one of the family of programs based onMETIS.
  323. nelder_mead, a program which implements the Nelder-Mead algorithm for the minimization of a scalar function of several variables.
  324. nested_sequence_display, a program which displays a set of nested sequences.
  325. netcdf a directory of example programs which read and write NETCDF files.
  326. netcdf_glimmer programs which read and write GLIMMER grid and solution data stored as a NETCDF file.
  327. netcdf_mpas a library which reads MPAS grid data stored as a NETCDF file.
  328. niederreiter2, a library which computes the Niederreiter M-dimensional quasirandom sequence, base 2;
  329. niederreiter2_dataset, a program which creates a Niederreiter quasirandom dataset with base 2;
  330. nint_exactness, a program which demonstrates how to test the polynomial exactness of an M-dimensional quadrature rule defined over a finite rectangular product region.
  331. nint_exactness_mixed a program which measures the polynomial exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.
  332. nint_exactness_pyramid is a program which investigates the polynomial exactness of a quadrature rule for the pyramid.
  333. nintlib, a library which carries out approximate integration (quadrature) in M dimensions;
  334. normal, a library which generates uniform pseudorandom numbers;
  335. normal_dataset, a program which creates a multivariate normal random dataset;
  336. ns3d_fem a program which sets up and solves a finite element formulation of the steady incompressible 3D Navier Stokes equations on a user-defined geometry.
  337. obj_display, a program which displays an OBJ 3D graphics file;
  338. obj_io, a library which reads and writes the data in an in an OBJ 3D graphics file;
  339. obj_to_tri_surface, a program which reads an OBJ file, and extracts the surface mesh data as a TRI_SURFACE dataset.
  340. ode_predator_prey, a program which solves a time-dependent predator-prey system using MATLAB's ODE23 solver.
  341. ode_sweep_parfor, a program which demonstrates how the PARFOR command can be used to parallelize the computation of a grid of solutions to a parameterized system of ODE's.
  342. oned, a library which contains functions useful for 1D finite element calculations.
  343. optimal_control_1d, a program which seeks the optimal control function for a one dimensional system which is represented using the finite element formulation;
  344. owens a library which evaluates Owen's T function;
  345. patterson_rule, a program which looks up and writes out a Gauss-Patterson quadrature rule of given order.
  346. pbma_io, a library which reads or writes an ASCII PBM; (Portable Bit Map) image file;
  347. pce_legendre, a program which assembles the system matrix associated with a polynomal chaos expansion of a 2D stochastic PDE, using Legendre polynomials;
  348. peak_movie a program which creates the pieces of an animation, one frame at a time. Each frame is independently created and saved as a JPEG file.
  349. pgma_io, a library which reads or writes an ASCII PGM; (Portable Gray Map) image file;
  350. piecewise_linear_product_integral is a library which calculates the exact value of the integral of the product of two piecewise linear functions F(X) and G(X).
  351. pink_noise, a library which computes a "pink noise" signal obeying a 1/f power law.
  352. plinth, a library which carries out tasks associated with the interpolation of data or a function by a hierarchical set of piecewise linear functions.
  353. plot_spmd, a library which demonstrates the SPMD parallel programming feature, by having a number of labs compute parts of a sine plot, which is then displayed by the client process.
  354. ply_io, a library which reads or writes a PLY file.
  355. ply_to_tri_surface, a program which reads a PLY file, and extracts the surface mesh data as a TRI_SURFACE dataset.
  356. points_01_plot, a program which reads an ASCII file containing points in the unit square, and makes an Encapsulated PostScript image;
  357. point_merge, a library which considers N points in M-dimensional space, and counts or indexes the unique or "tolerably unique" items.
  358. polking programs, DFIELD5 and PPLANE5, for direction fields and phase planes of ordinary differential equations (ODE's);
  359. polpak a library which evaluates recursively defined polynomials and other special functions;
  360. polygonal_surface_display a program which displays a surface in 3D described as a set of polygons;
  361. power_method a library which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  362. ppma_io a library which reads or writes an ASCII PPM; (Portable Pixel Map) image file;
  363. prime is a program which counts the number of primes between 1 and N.
  364. prime_parfor is a program which counts the number of primes between 1 and N; it runs in parallel using MATLAB's "parfor" facility.
  365. prime_spmd is a program which counts the number of primes between 1 and N; running in parallel using MATLAB's "SPMD" feature.
  366. prob a library which evaluates and samples various probability density functions;
  367. product_factor, a program which creates an M-dimensional quadrature rule from a product of distinct 1d quadrature rules;
  368. product_rule a program which creates an M-dimensional quadrature rule from a product of identical 1d quadrature rules;
  369. profile a directory of programs which illustrate the use of the MATLAB profile utlity, which monitors the execution of a series of MATLAB commands, and then produces a performance profile report afterwards.
  370. puzzles, executable programs which solve simple puzzles;
  371. pyramid_rule, is a program which computes a quadrature rule for a pyramid.
  372. quad, a program which applies a quadrature rule to estimate an integral, intended as a starting point for parallelization exercises.
  373. quad_mesh, a library which handles meshes of quadrilaterals over a 2D region;
  374. quad_mesh_rcm, a program which computes the reverse Cuthill-McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
  375. quad_parfor is a program which estimates an integral using quadrature; running in parallel using MATLAB's "PARFOR" feature.
  376. quad_spmd is a program which estimates an integral using quadrature; running in parallel using MATLAB's "SPMD" feature.
  377. quad_surface_display, a program which plots piecewise bilinear data associated with a QUAD_SURFACE, that is, a 3D surface defined by a quadrilateral mesh;
  378. quad_tasks is a program which estimates an integral using quadrature; running in parallel using MATLAB's "TASK" feature.
  379. quadrature_test a program which reads the definition of an M-dimensional quadrature rule from three files, applies the rule to a number of test integrals, and prints the results.
  380. quadrature_test_2d a program which reads the definition of a 2D quadrature rule from three files, applies the rule to a number of test integrals, and prints the results.
  381. quadrule a library which defines quadrature rules for approximating an integral;
  382. quadrule_fast a library which rapidly defines certain quadrature rules for approximating an integral;
  383. quality a library which measures the dispersion of pointsets in M dimensions;
  384. r8lib, a library which contains many utility routines, using "R8" or "double precision real" arithmetic.
  385. randlc, a library which generates a sequence of pseudorandom numbers, used by the NAS Benchmark programs.
  386. random_data, a library which generates sample points for various probability density functions, geometries, and dimensions;
  387. random_walk_1d_simulation, a program which simulates a random walk in a 1-dimensional region.
  388. random_walk_2d_avoid_simulation, a program which simulates a self-avoiding random walk in a 2-dimensional region.
  389. random_walk_2d_avoid_tasks, a program which computes many self avoiding random walks in 2D by creating a job which defines each walk as a task, and then computes these independently using MATLAB's Parallel Computing Toolbox task computing capability.
  390. random_walk_2d_simulation, a program which simulates a random walk in a 2-dimensional region.
  391. random_walk_3d_simulation, a program which simulates a random walk in a 3-dimensional region.
  392. rcm, a library which applies the reverse Cuthill McKee algorithm for reordering the nodes of a graph, and reducing the bandwidth of a corresponding sparse matrix;
  393. region_sample, a program which returns sample points from a region;
  394. rkf45, a library which applies a Runge-Kutta-Fehlberg solver to a system of ODE's;
  395. sammon_data is a program which generates six examples of M-dimensional datasets for cluster analysis.
  396. sandia_cubature, a library which implements quadrature rules for certain M-dimensional regions and weight functions.
  397. sandia_rules, a library which produces a standard 1D Gauss quadrature rule of Chebyshev, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, and Legendre types.
  398. sandia_sparse, a library which can produce 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.
  399. satisfy is a program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.
  400. satisfy_parfor is a program which carries out a circuit satisfiability search; it runs in parallel using MATLAB's "parfor" facility.
  401. sde, a library which illustrates the properties of stochastic differential equations, and common algorithms for their analysis, by Desmond Higham;
  402. sequence_streak_display, a program which displays a "streak plot" of a numeric sequence;
  403. sftpack a library which implements the "slow" Fourier transform, intended as a teaching tool and comparison with the fast Fourier transform.
  404. sgmga, a library which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.
  405. shallow_water_1d is a program which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.
  406. shallow_water_2d is a program which simulates the evolution of a 2D fluid governed by the time-dependent shallow water equations, by Cleve Moler.
  407. simplex_coordinates, a library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  408. sir_simulation is a program which simulates the spread of a disease through a hospital room of M by N beds, using the SIR (Susceptible/Infected/Recovered) model.
  409. sobol, a library which generates elements of the Sobol M-dimensional quasirandom sequence;
  410. sobol_dataset, a program which creates a Sobol quasirandom dataset;
  411. sparse, a directory of example programs which illustrate the use of MATLAB's SPARSE matrix utilities;
  412. sparse_grid_cc, a library which creates sparse grids based on Clenshaw-Curtis rules.
  413. sparse_grid_cc_dataset, a program which creates sparse grids based on Clenshaw-Curtis rules.
  414. sparse_grid_closed, a library which creates sparse grids based on closed rules (Clenshaw-Curtis, Newton-Cotes-Closed).
  415. sparse_grid_closed_dataset, a program which creates of a sparse grid dataset based on closed rules (Clenshaw-Curtis, Newton-Cotes-Closed).
  416. sparse_grid_composite, a library which creates sparse grids based on 1D composite rules (currently only of order 1).
  417. sparse_grid_display, a program which reads a file of points on a sparse grid, displays the grid and save the image in a PNG file;
  418. sparse_grid_gl, a library which creates sparse grids based on Gauss-Legendre rules.
  419. sparse_grid_gl_dataset, a program which creates a sparse grid dataset based on Gauss-Legendre rules.
  420. sparse_grid_hermite, a library which creates sparse grids based on Gauss-Hermite rules.
  421. sparse_grid_hermite_dataset, a program which creates a sparse grid dataset based on Gauss-Hermite rules.
  422. sparse_grid_hw, a library 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.
  423. sparse_grid_laguerre, a library which creates sparse grids based on Gauss-Laguerre rules.
  424. sparse_grid_laguerre_dataset, a program which creates a sparse grid dataset based on Gauss-Laguerrre rules.
  425. sparse_grid_mixed, a library which creates sparse grids based a mixture of 1D factor rules.
  426. sparse_grid_mixed_dataset, a program which creates a sparse grid dataset based on a mixture of 1D rules.
  427. sparse_grid_open, a library which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
  428. sparse_grid_open_dataset, a program which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
  429. sparse_grid_pure, a library which for the analysis and creation of sparse grids in which a single family of 1D quadrature rules is used for all spatial dimensions.
  430. sparse_grids_display, a program which reads two files of sparse grids, displaying the first with hollow blue dots, the second with solid red dots.
  431. sphere_cvt, a program which carries out the Centroidal Voronoi Tessellation iteration on the unit sphere.
  432. sphere_delaunay, a program which computes the Delaunay triangulation of points on the unit sphere.
  433. sphere_exactness, a program which tests the polynomial exactness of a quadrature rule for the unit sphere;
  434. sphere_grid, a library which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, over the unit sphere.
  435. sphere_lebedev_rule, a library which computes Lebedev quadrature rules for the unit sphere;
  436. sphere_lebedev_rule_display, a program which reads a file defining a Lebedev quadrature rule for the sphere and displays the point locations.
  437. sphere_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function over the surface of the unit sphere in 3D;
  438. sphere_quad, a library which approximates an integral over the surface of the unit sphere by applying a triangulation to the surface;
  439. sphere_stereograph is a library which computes the stereographic mapping between points on the unit sphere and points on the plane Z = 1; a generalized mapping is also available.
  440. sphere_stereograph_display is a library which computes and displays the results of several stereographic projections between a sphere and a plane.
  441. sphere_voronoi, a program which computes the Voronoi diagram of points on the unit sphere.
  442. sphere_xyz_display is a program which reads XYZ information defining points in 3D, and displays a unit sphere and the points in the MATLAB 3D graphics window.
  443. sphere_xyzf_display is a program which reads XYZ information defining points coordinates, and XYZF information defining point indices forming faces, and displays a unit sphere, the points, and the faces, in the MATLAB 3D graphics window.
  444. spherical_harmonics, a library which evaluates spherical harmonic functions.
  445. spinterp, a library 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.
  446. spline, a library which interpolates and approximates via splines;
  447. st_io a library which reads and writes sparse linear systems stored in the ST "sparse triplet" Sparse Matrix format.
  448. st_to_hb, a program which converts a sparse matrix file from ST format to HB format (Harwell Boeing format);
  449. st_to_mm, a program which converts a sparse matrix file from ST format to MM format (Matrix Market format);
  450. st_to_msm, a program which reads an ST sparse triplet file and creates a corresponding MATLAB Sparse Matrix.
  451. stla_display, a program which displays an STLA file (ASCII stereolithography 3D graphics file);
  452. stla_io, a library which reads and writes an STLA file (ASCII stereolithography 3D graphics file);
  453. stla_to_tri_surface, a program which reads a STLA file, and extracts the surface mesh data as a TRI_SURFACE dataset.
  454. stla_to_tri_surface_fast, a program which is a faster version of stla_to_tri_surface.
  455. stochastic_diffusion, functions which implement several versions of a stochastic diffusivity coefficient.
  456. stochastic_gradient_nd_noise, a program which solves an optimization problem involving a functional over a system with stochastic noise.
  457. stochastic_rk, a library which applies a Runge-Kutta scheme to a stochastic differential equation.
  458. stroud, a library which implements numerical integration over M-dimensional regions, including spheres, toruses and other shapes;
  459. subpak, a library which includes many utility routines;
  460. subset, a library which ranks, unranks, and generates random subsets, combinations, permutations, and so on;
  461. subset_sum is a program which seeks solutions of the subset sum problem.
  462. sudoku, a library which handles Sudoku puzzles;
  463. sum_million, a program which sums the integers from 1 to 1,000,000, as a demonstration of how to rate a computer's speed;
  464. svd_basis, a program which applies the singular value decomposition to a collection of data vectors, extracting dominant modes;
  465. svd_demo, a program which demonstrates the calculation of the singular value decomposition and some of its properties;
  466. table_delaunay, a program which reads a TABLE file of N points in 2 dimensions and writes out the Delaunay triangulation;
  467. table_io, a library which reads and writes a simple TABLE file;
  468. table_latinize, a program which reads a TABLE file of N points in M dimensions, adjusts to form a Latin hypercube;
  469. table_merge, a program which reads a TABLE file of N points in M dimensions, removes duplicates or points that are closer than some tolerance, and writes the reduced set of points to a file.
  470. table_quality, a program which reads a TABLE file of N points in M dimensions, in the unit hypercube, and returns estimates of the quality of the point dispersion;
  471. table_read, a program which reads a TABLE file containing comment lines beginning with '#', and a matrix of data, one row per line;
  472. table_voronoi, a program which reads a TABLE file of N points in 2 dimensions, calls GEOMPACK to get Delaunay triangulation information, and then determines and prints the Voronoi diagram information;
  473. tanh_quad, a library which sets up the tanh quadrature rule;
  474. tanh_sinh_rule, a program which computes and writes out a tanh-sinh quadrature rule of given order.
  475. tcell_flow_display, a library which displays a single velocity field solution for the T cell;
  476. tcell_flow_movie, a library which creates an animation of the velocity solutions for the T cell;
  477. tcell_rom, a program which solves a reduced order model of a finite element solution of the Navier Stokes equations in a "T-Cell" flow region;
  478. tec_io, a library which reads or writes a TECPLOT ASCII file containing finite element information;
  479. tec_to_fem, a program which reads a TECPLOT ASCII file, extracts the information, and writes a corresponding set of FEM files, three text files describing the finite element model;
  480. tec_to_vtk, a program which reads a particular TECPLOT ASCII file containing 80 frames of the movement of a red blood cell, and creates 80 separate VTK unstructured grid files, which can then be read by PARAVIEW and animated.
  481. templates, a library which carries out the iterative solution of linear systems;
  482. test_con, a library which implements test problems for numerical continuation.
  483. test_int, a library which implements test problems for approximate integration (quadrature) in one dimension.
  484. test_int_2d, a library which implements test problems for approximate integration (quadrature) in two dimensions.
  485. test_int_hermite, a library which implements test problems for approximate integration over an infinite interval.
  486. test_int_laguerre, a library which implements test problems for approximate integration over a semi-infinite interval.
  487. test_mat a library which defines a set of test matrices.
  488. test_matrix, a library which defines a set of test matrices and utilities, by Nick Higham;
  489. test_min, a library which implements test problems for minimization of a scalar function of a scalar variable.
  490. test_nint, a library which implements test problems for approximate integration (quadrature) in M dimensions.
  491. test_ode, a library which defines some sample ODE's for testing initial value problem solvers;
  492. test_tri_int, a library which implements test functions for integration over a triangle in 2 dimensions.
  493. test_triangulation, a library which defines test problems for triangulation;
  494. test_values, a library which returns selected values of some special functions;
  495. test_zero, a library which defines some functions f(x) suitable for testing software that solves f(x)=0;
  496. testpack a library which defines a set of test integrand functions, by Alan Genz.
  497. tet_mesh a library which works with tetrahedral meshes in 3D;
  498. tet_mesh_boundary, a program 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.
  499. tet_mesh_display, a program which reads data defining a (small) tet mesh, displays a wireframe image of the nodes and edges;
  500. tet_mesh_l2q, a program which reads information about a 4-node (linear) tet mesh and creates data defining a corresponding 10-node (quadratic) tet mesh;
  501. tet_mesh_q2l, a program which reads information about a 10-node (quadratic) tet mesh and creates data defining a corresponding 4-node (linear) tet mesh;
  502. tet_mesh_quality, a program which computes various quality measures for a tet mesh of a set of nodes in 3D;
  503. tet_mesh_rcm, a program which computes the reverse Cuthill-McKee reordering for the nodes of a tet mesh that uses 4-node or 10-node tetrahedrons;
  504. tet_mesh_refine, a program which refines a tet mesh;
  505. tet_mesh_tet_neighbors, a program which reads information about a tet mesh and writes out a list of the tetrahedrons that are adjacent to a given tetrahedron;
  506. tet_mesh_volumes is a program which computes the volume of each tetrahedron in a tet mesh;
  507. tetrahedron_exactness, a program which tests the polynomial exactness of a quadrature rule for the tetrahedron;
  508. tetrahedron_grid, a library which computes a tetrahedral grid of points.
  509. tetrahedron_monte_carlo, a program which uses the Monte Carlo method to estimate an integral over a tetrahedron.
  510. tetrahedron_properties, a program which prints out the properties of a tetrahedron whose vertex coordinates are read from a file;
  511. tetrahedron_slice_animate, a program which is given a tetrahedron and a vector, and displays an evenly spaced sequence of planes that intersect the tetrahedron and are normal to the vector.
  512. tetrahedron_slice_display, a program which determines the intersection between a tetrahedron and a plane and displays the result.
  513. threed, a library which contains functions useful for 3D finite element calculations.
  514. threed_to_tecplot, a program which accepts computational data from a 3D finite element fluid flow program and writes it to a TECPLOT ASCII graphics file.
  515. threed_to_vtk, a program which accepts computational data from a 3D finite element fluid flow program and writes it to a VTK "legacy" file for postprocessing by PARAVIEW.
  516. threed_to_vtu, a program which accepts computational data from a 3D finite element fluid flow program and writes it to a VTK unstructured grid file for postprocessing by PARAVIEW.
  517. threed_to_vu, a program which accepts computational data from a 3D finite element fluid flow program and writes it to a file for postprocessing by VU.
  518. timer, examples which illustrate how to time a piece of code;
  519. timestamp, a library which prints the current YMDHMS date as a timestamp;
  520. toms178 a library which seeks the minimizer of a scalar function of several variables using the Hooke-Jeeves method;
    this is a MATLAB version of ACM TOMS algorithm 178.
  521. toms179 a library which calculates the incomplete Beta ratio;
    this is a MATLAB version of ACM TOMS algorithm 179.
  522. toms291 a library which approximates the logarithm of the Gamma function;
    this is a MATLAB version of ACM TOMS algorithm 291.
  523. toms655 a library which computes computes the weights for interpolatory quadrature rule;
    this library is commonly called IQPACK;
    this is a MATLAB version of ACM TOMS algorithm 655.
  524. toms847, a library which carries out piecewise multilinear hierarchical sparse grid interpolation, commonly known as SPINTERP, by Andreas Klimke;
    this is ACM TOMS Algorithm 847.
  525. toms866 a library which contains the Incompressible Flow Iterative Solution Software (IFISS);
    this is ACM TOMS algorithm 866.
  526. traffic_simulation, a program which simulates the cars waiting to get through a traffic light.
  527. tri_surface_display, a program which displays a triangulated surface;
  528. tri_surface_io, a library which reads and writes the 3D graphics information in a TRI_SURFACE file;
  529. tri_surface_to_obj, a program which reads a TRI_SURFACE dataset and extracts the surface mesh data as an OBJ file.
  530. tri_surface_to_ply, a program which converts a TRI_SURFACE dataset to a dataset suitable for storage as a PLY file.
  531. tri_surface_to_stla, a program which reads a TRI_SURFACE dataset and extracts the surface mesh data as an ASCII STL file.
  532. triangle_display is a program which displays the nodes and elements of a triangulation on the MATLAB graphics screen, assuming the data has been stored in NODE and ELE files by the triangle program.
  533. triangle_exactness, a program which tests the polynomial exactness of a quadrature rule for triangles;
  534. triangle_grid, a library which computes a triangular grid of points.
  535. triangle_histogram, a program which computes histograms of data on the unit triangle.
  536. triangle_monte_carlo, a program which uses the Monte Carlo method to estimate an integral over a triangle.
  537. triangle_properties, a program which computes properties of a triangle whose vertex coordinates are read from a file.
  538. triangulation, a library which computes the triangulation of a set of points in the plane, and to perform various operations using a triangulation;
  539. triangulation_boundary_nodes, a program which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file;
  540. triangulation_corner, a program which modifies triangulations in which one or more triangles have more than one boundary edge.
  541. triangulation_delaunay_discrepancy is a program which measures the amount by which a triangulation fails the local Delaunay test;
  542. triangulation_display, a program which displays the nodes and elements of a triangulation on the MATLAB graphics screen;
  543. triangulation_histogram, a program which computes histograms of data over a triangulation.
  544. triangulation_l2q, a program which reads information about a 3-node (linear) triangulation and creates data defining a corresponding 6-node (quadratic) triangulation;
  545. triangulation_mask, a program which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;
  546. triangulation_order1_display, a program which plots piecewise constant data associated with a triangulation;
  547. triangulation_order3_contour, a program which plots color contours of a scalar quantity evaluated at the nodes of a 3-node triangle triangulation.
  548. triangulation_order6_contour, a program which plots color contours of a scalar quantity evaluated at the nodes of a 6-node triangle triangulation.
  549. triangulation_orient, a program which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;
  550. triangulation_plot, a program which plots the nodes and elements of a triangulation as a PostScript file;
  551. triangulation_q2l, a program which reads information about a 6-node triangulation and creates data defining a corresponding 3-node triangulation;
  552. triangulation_quad, a program 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.
  553. triangulation_quality, a program which reads information about a triangulation and computes various quality measures;
  554. triangulation_rcm, a program which computes the reverse Cuthill-McKee reordering for the nodes of a triangulation that uses 3-node or 6-node triangles;
  555. triangulation_refine, a program which refines a triangulation;
  556. triangulation_t3_to_t4, a program which reads information about a 3-node T3 triangulation and creates data defining a corresponding 4-node T4 triangulation;
  557. triangulation_triangle_neighbors, a program which reads data defining a triangulation, finds the three neighbor triangles for each triangle, and writes them to a file;
  558. truel_simulation a program which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
  559. tumor, a program which demonstrates a model of tumor growth;
  560. twod, a library which contains functions useful for 2D finite element calculations.
  561. twod_plotc, a program which makes a color contour plot of scalar data defined on a 2D finite element mesh.
  562. twod_to_vtk, a program which accepts computational data from a 2D finite element fluid flow program and writes it to a VTK "legacy" file for postprocessing by PARAVIEW.
  563. twod_to_vtu, a program which accepts computational data from a 2D finite element fluid flow program and writes it to a VTK unstructured grid file for postprocessing by PARAVIEW.
  564. uniform, a library which computes N elements of a uniform pseudorandom sequence;
  565. uniform_dataset, a program which creates N elements of an M-dimensional uniform pseudorandom sequence and writes them to a file.
  566. van_der_corput, a library which computes elements of the van der Corput 1-dimensional quasirandom sequence;
  567. van_der_corput_dataset, a program which creates N elements of a van der Corput sequence and writes them to a file.
  568. vector_magnitude_grid, a program which reads vector data at "scattered" points, computes an interpolatory function, evaluates it on a uniform grid of user-specified density, and produces a contour plot of the vector magnitude.
  569. vector_stream_grid, a program which reads vector data at "scattered" points, computes an interpolatory function, evaluates it on a uniform grid of user-specified density, and produces a streamline plot.
  570. velocity_arrows, a program which reads coordinate data and velocity data from two files and makes an arrow plot of the velocity field.
  571. velocity_arrows_grid, a program which reads node and velocity data, stored in two files, at "scattered" points, and makes a velocity vector plot on a uniform grid of user-specified density.
  572. velocity_arrows_grid_sequence2, a program which reads a single XYUV file of nodes and velocities, interpolates the data onto a smooth grid, plots the data and writes it to a PNG file, and then repeats the process for the next file.
  573. velocity_arrows_sequence, a program which reads a fixed coordinate data file, and a sequence of velocity data files, and makes a sequence of velocity arrow plots.
  574. velocity_arrows_sequence2, a program which reads a single XYUV file of nodes and velocities, plots the data and writes it to a PNG file, and then repeats the process for the next file.
  575. voronoi_mountains, a program 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.
  576. wandzura, a library which returns one of 6 Wandzura rules for quadrature in a triangle;
  577. weekday is a library which determines the day of the week for a given day.
  578. wtime is a library which returns a reading of the wall clock time in seconds.
  579. xy_display a program which reads a XY file containing the coordinates of points in 2D, and displays an image in the MATLAB graphics window;
  580. xy_io, a library which reads and writes XY files.
  581. xyf_display is a program which reads XYF information defining points and faces in 2D, and displays an image in the MATLAB graphics window.
  582. xyl_display is a program which reads XYL information defining points and lines in 2D, and displays an image in the MATLAB graphics window.
  583. xyz_display is a program which reads XYZ information defining points in 3D, and displays an image in the MATLAB 3D graphics window.
  584. xyz_io, a library which reads and writes XYZ files.
  585. xyzf_display is a program which reads XYZF information defining points and faces in 3D, and displays an image in the MATLAB 3D graphics window.
  586. xyzl_display is a program which reads XYZL information defining points and lines in 3D, and displays an image in the MATLAB 3D graphics window.
  587. ziggurat, a library which samples the uniform, normal or exponential distributions, using the ziggurat method.
Click on below links to download

o cab.m............Echelon factorization A = c a b.
o cofactor.m........Matrix of cofactors.
o colbasis.m........Basis for the column space.
o cramer.m............Solve the system Ax=b.
o determ.m........Matrix determinant from plu.
o eigen2.m............Characteristic polynomial, eigenvalues, eigenvectors.
o eigshow.m............Graphical demonstration of eigenvalues and singular values.
o eigval.m............Eigenvalues and their algebraic multiplicity.
o eigvec.m............Eigenvectors and their geometric multiplicity.
o elim.m............EA=R factorization.
o findpiv.m............Used by plu to find a pivot for Gaussian elimination.
o fourbase.m............Bases for all 4 fundamental subspaces.
o grams.m............Gram-Schmidt orthogonalization of the columns of A.
o house.m............Stores the "house" data set in X.
o inverse.m............Matrix inverse by Gauss-Jordan elimination.
o leftnull.m............Basis for the left nullspace.
o linefit.m............Plot the least squares fit by a line.
o lsq.m............Least squares solution of Ax=b.
o normal.m............Eigenvalues and eigenvectors of a normal matrix A.
o nulbasis.m............Basis for the nullspace.
o orthcomp.m............Orthogonal complement of a subspace.
o partic.m............Particular solution of Ax=b.
o plot2d.m............Two dimensional plot.
o plu.m............Rectangular PA=LU factorization *with row exchanges*.
o poly2str.m............Convert a polynomial coefficient vector to a string.
o project.m............Project a vector b onto the column space of A.
o projmat.m............Projection matrix for the column space of A.
o randperm.m............Random permutation.
o rowbasis.m............Basis for the row space.
o samespan.m............Test if two matrices have the same column space.
o signperm.m......Determinant of the permutation matrix with rows ordered by p.
o slu.m............LU factorization of a square matrix using *no row exchanges*.
o splu.m............Square PA=LU factorization *with row exchanges*.
o splv.m............Solution to a square, invertible system.
o symmeig.m............Eigenvalues and eigenvectors of a symmetric matrix.
o tridiag.m............Tridiagonal matrix.



This blog Does not claim any credits for this matlab sources codes list, these are taken from  1.people.sc.fsu.edu/~jburkardt/m_src/m_src.html and 2.mit.edu/18.06/www/Course-Info/Tcodes.html

No comments:

Post a Comment