http://people.scs.fsu.edu/~burkardt/m_src/m_src.html
------------
- tri_mesh_display, a program which displays a surface in 3D described as a mesh of triangles;
- tri_mesh_to_ply, a program which converts a TRI_MESH dataset to a dataset suitable for storage as a PLY file.
------------
MATLAB Source Codes
This is a collection of routines for use with MATLAB.
Available software includes:
- args, a program which shows how to count and report command line arguments;
- arpack, a library which computes eigenvalues and eigenvectors of large sparse matrices, accessible via the built-in EIGS command;
- asa005 a library which evaluates the lower tail of the noncentral Student's T distribution; this is Applied Statistics Algorithm 5;
- asa006 a library which computes the Cholesky factor of a positive definite symmetric matrix; this is Applied Statistics Algorithm 6;
- asa007 a library which computes the inverse of a positive definite symmetric matrix; this is Applied Statistics Algorithm 7;
- asa032 a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 32;
- asa047 a library which minimizes a scalar function of several variables using the Nelder-Mead algorithm; this is Applied Statistics Algorithm 47;
- asa058 a library which carries out clustering of data; this is Applied Statistics Algorithm 58;
- asa063 a library which evaluates the incomplete Beta function; this is Applied Statistics Algorithm 63;
- asa066 a library which computes the cumulative density function of the standard normal distribution; this is Applied Statistics Algorithm 66;
- asa076 a library which evaluates Owen's T function; this is Applied Statistics Algorithm 76;
- asa091, a library which computes the percentage points of the Chi-square distribution; this is Applied Statistics Algorithm 91;
- asa103, a library which evaluates the digamma or psi function; this is Applied Statistics Algorithm 103;
- asa109 a library which inverts the incomplete Beta function; this is Applied Statistics Algorithm 109;
- asa111 a library which evaluates the percentage points of the normal distribution; this is Applied Statistics Algorithm 111;
- asa113 a library which clusters data using the Banfield and Bassill transfer and swap algorithm; this is Applied Statistics Algorithm 113;
- asa121, a library which evaluates the trigamma function; this is Applied Statistics Algorithm 121;
- asa136 a library which clusters data using the Hartigan and Wong algorithm; this is Applied Statistics Algorithm 136;
- asa144 a library which randomly generates tables with given row and column sums; this is Applied Statistics Algorithm 144;
- asa147 a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 147;
- asa152, a library which evaluates point and cumulative probabilities associated with the hypergeometric distribution; this is Applied Statistics Algorithm 152;
- asa183, a library which implements the Wichman-Hill pseudorandom number generator; this is Applied Statistics Algorithm 183;
- asa226 a library which evaluates the noncentral incomplete Beta function; this is Applied Statistics Algorithm 226;
- asa239 a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 239;
- asa241, a library which computes the inverse of the normal CDF; this is Applied Statistics Algorithm 241;
- asa243 a library which evaluates the lower tail of the noncentral Student's T distribution; this is Applied Statistics Algorithm 243;
- asa245 a library which evaluates the logarithm of the Gamma function; this is Applied Statistics Algorithm 245;
- asa299, a library which computes the lattice points (integer coordinates) in an M-dimensional simplex; this is Applied Statistics Algorithm 299;
- asa310 a library which evaluates the noncentral incomplete Beta function; this is Applied Statistics Algorithm 310;
- beta_nc, a library which evaluates the CDF of the noncentral Beta distribution;
- bezier_surface, a library which reads, writes, prints and manipulates the data that defines a Bezier surface;
- bezier_surface_display, a program which displays a Bezier surface;
- black_scholes, a library which implements some simple approaches to the Black-Scholes option valuation theory;
- blas1, a library which implements the Basic Linear Algebra Subprograms, level 1;
- blas1_c, a library which implements the Level 1 Basic Linear Algebra Subprograms, using single precision complex arithmetic;
- blas1_d, a library which implements the Level 1 Basic Linear Algebra Subprograms, using double precision real arithmetic;
- blas1_s, a library which implements the Level 1 Basic Linear Algebra Subprograms, using single precision real arithmetic;
- blas1_z, a library which implements the Level 1 Basic Linear Algebra Subprograms, using double precision complex arithmetic;
- box_plot, a program which displays a box plot of data that consists of pairs of integers;
- brent a library which contains Richard Brent's routines for finding zeroes or minima of functions, without the use of derivative information.
- cavity_flow_display, a library which displays a single velocity field solution for the driven cavity;
- cavity_flow_movie, a library which animates the velocity solutions for the driven cavity;
- cc_display, a program which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
- ccvt_box, a program which calculates a constrained CVT for points constrained to lie in a box, with some points moved to the boundary;
- ccvt_reflect, a program which calculates a constrained CVT for points constrained to lie in a box, with some points "pushed" towards the boundary;
- cg_lab_triangles, a collection of programs associated with a computer lab assignment on computational geometry and triangles;
- chebyshev1_rule, a program which computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
- chebyshev2_rule, a program which computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
- chrpak, a library which manipulates characters and strings;
- claw_pix, a library which visualizes the output of of the 1D version of CLAWPACK;
- clawpack_plot, a library which visualizes the output of of CLAWPACK;
- clenshaw_curtis, a library which implements Clenshaw Curtis and Fejer quadrature;
- collatz, a library which computes and analyzes the Collatz sequence (or "hailstone" sequence or "3n+1 sequence");
- contour_sequence, a program which creates images suitable for animation from a sequence of (X,Y,U(X,Y)) data files;
- contour_sequence3, a program which creates images suitable for animation from one pair of X, Y files, and a sequence of U(X,Y) data files;
- contour_sequence4, a program which creates images suitable for animation from one XY file and a sequence of U(X,Y) data files;
- coordinate_search, a program which implements the coordinate search algorithm for the minimization of a scalar function of several variables.
- cordic, a library which computes a few special functions using the CORDIC algorithm.
- cvt, a library which computes an N-point Centroidal Voronoi Tesselation in M dimensions;
- cvt_1d_nonuniform, a program which computes an N-point Centroidal Voronoi Tesselation in 1 dimension, under a nonuniform density, and plots the evolution of the locations of the generators during the iteration;
- cvt_dataset a program which creates a CVT dataset;
- cvt_demo, a program which interactively, graphically demonstrates a CVT calculation;
- cvt_metric, a program which computes a CVT under a spatially varying metric;
- cvt_movie, a program which creates an animation of the evolution of a CVT;
- cvt_movie2, a program which creates a CVT movie;
- cvt_movie3, a program which creates a CVT movie in a region of unusual shape;
- cvt_movie4, a program which creates a CVT movie in a square, with a density function that drives points to the corners;
- cvt_movie5, a program which repeats cvt_movie3, but with hexagonal grid initialization, fixed points, and boundary projection;
- 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.
- 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.
- 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.
- direction_arrows_sequence2, a program which reads a sequence of coordinate and velocity data and makes a sequence of velocity direction arrow plots.
- direction_arrows2, a program which reads coordinate and velocity data from a single file and makes an arrow plot of the direction field.
- dist_plot, a program which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh code;
- distmesh, a library which carries out Persson and Strang's method of mesh generation;
- distmesh_3d, a library which constitutes the 3D subset of Persson and Strang's distmesh code;
- divdif, a library which constructs, evaluates and manipulates divided difference tables;
- dunavant, a library which defines Dunavant quadrature rules in a triangle;
- entrust, a library which uses trust-region methods to solve problems in scalar optimization or nonlinear least squares, by Borggaard and Cliff.
- faure, a library which computes the Faure M-dimensional quasirandom sequence;
- fd1d, a program which implements a finite difference algorithm for a 1D predator-prey system;
- fd1d_heat, a program which implements a finite difference solution of the 1D heat equation;
- fd1d_plot, a program which plots solutions from the FD1D program.
- fekete, a library which sets up one of seven Fekete rules for interpolation or quadrature in a triangle;
- fem_50, a program which implements a Finite Element Method solver using about 50 lines of MATLAB code;
- fem_50_heat, a program which is a version of fem_50 for the time-dependent heat equation;
- fem_basis_t3_display, a program which displays any single basis function associated with an arbitrary linear triangle ("T3") mesh;
- fem_basis_t6_display, a program which displays any single basis function associated with an arbitrary quadratic triangle ("T6") mesh;
- fem_io, a library which reads or writes FEM files, (three text files describing a finite element model);
- fem_sample, a library which samples a finite element function, defined by FEM files, (three text files describing the nodes, triangles, and coefficients); at arbitrary points.
- fem_to_tec, a program which reads a set of FEM files, (three text files describing a finite element model), and writes a TEC filesuitable for display by TECPLOT;
- fem1d, a program which applies the finite element method, using piecewise linear basis functions, to a linear two point boundary value problem in 1D;
- 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;
- 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;
- 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;
- fem2d_heat, a program which applies the finite element method for the time-dependent heat equation on a triangulated square in 2D;
- fem2d_poisson, a program which applies the finite element method for Poisson's equation on a triangulated square in 2D;
- fempack, a library which performs simple finite element computations;
- ffh_sparse, a program which applies the finite element method to the heat equations on an arbitrary triangulated region in 2D. This is a special version of FREE_FEM_HEAT that uses MATLAB's sparse matrix features;
- ffns_sparse, a program which applies the finite element method to the steady incompressible Navier Stokes equations on an arbitrary triangulated region in 2D. This is a special version of FREE_FEM_NAVIER_STOKES that uses MATLAB's sparse matrix features;
- ffp_sparse, a program which applies the finite element method to the Poisson equations on an arbitrary triangulated region in 2D. This is a special version of FREE_FEM_POISSON that uses MATLAB's sparse matrix features;
- ffs_sparse, a program which is a finite element code for the steady incompressible Stokes equations on an arbitrary triangulated region in 2D. This is a special version of FREE_FEM_STOKES that uses MATLAB's sparse matrix features;
- filum, a library which handles files and filenames;
- free_fem_heat, a program which applies the finite element method to the time dependent heat equation on an arbitrary triangulated region in 2D;
- free_fem_navier_stokes, a program which applies the finite element method to the steady incompressible Navier Stokes equations on an arbitrary triangulated region in 2D;
- free_fem_poisson, a program which applies the finite element method to Poisson's equation on an arbitrary triangulated region in 2D;
- free_fem_stokes, a program which applies the finite element method for the steady incompressible Stokes equations on an arbitrary triangulated region in 2D;
- gegenbauer_rule, a program which computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
- gen_hermite_rule, a program which computes and writes out a generalized Gauss-Hermite quadrature rule of given order and parameter value ALPHA.
- gen_laguerre_rule, a program which computes and writes out a generalized Gauss-Laguerre quadrature rule of given order and parameter value ALPHA.
- geometry, a library which performs 2D/3D geometric calculations;
- geompack, a library which computes the Delaunay triangulation for a set of points in 2D;
- gl_display, a program which displays the points used in a 2D Gauss-Legendre quadrature rule;
- gm_rules, a library which defines Grundmann-Moeller quadratures rules for an M-dimensional simplex.
- grid, a library which computes N random points on a uniform M dimensional grid;
- grid_dataset, a program which creates a grid dataset;
- halton, a library which calculates the Halton M-dimensional quasirandom sequence;
- halton_dataset, a program which creates N elements of an M dimensional Halton sequence and write them to a file.
- hammersley, a library which computes the Hammersley M-dimensional quasirandom sequence;
- hammersley_dataset, a program which creates N elements of an M dimensional Hammersley sequence and write them to a file.
- hb_io, a library which reads and writes files in the Harwell Boeing sparse matrix format;
- hb_to_msm, a program which converts a sparse matrix stored in a Harwell Boeing file to MATLAB sparse matrix format;
- hcell_flow_display, a program which plots the physical data, pressures or velocities, from a run of the HCELL program;
- 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.
- 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.
- hermite_rule, a program which computes and writes out a Gauss-Hermite quadrature rule of given order.
- hex_grid, a library which generates a hexagonal grid of points in the unit square or an arbitrary rectangle;
- hex_grid_angle, a library which defines a hexagonal grid of points in the unit square, with an arbitrary center, angle, and spacing.
- 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.
- 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;
- hot_pipe, a program which demonstrates fem_50_heat to solve a particular heat equation problem;
- hot_point, a program which demonstrates fem_50_heat to solve a particular heat equation problem;
- ihs, a library which generates the Improved Distributed Hypercube Sampling M-dimensional quasirandom sequence;
- ihs_dataset, a program which creates an IHS dataset and writes it to a file;
- inout_flow_display, a library which displays a single velocity field solution for the INOUT flow;
- inout_flow_movie, a library which creates an animation of the velocity solutions for the INOUT cell;
- int_exactness, a program which tests the polynomial exactness of quadrature rules for a finite interval;
- int_exactness_chebyshev1, a program which tests the polynomial exactness of Gauss-Chebyshev type 1 quadrature rules.
- int_exactness_chebyshev2, a program which tests the polynomial exactness of Gauss-Chebyshev type 2 quadrature rules.
- int_exactness_gegenbauer, a program which tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
- int_exactness_gen_hermite, a program which tests the polynomial exactness of generalized Gauss-Hermite quadrature rules.
- int_exactness_gen_laguerre, a program which tests the polynomial exactness of generalized Gauss-Laguerre quadrature rules.
- int_exactness_hermite, a program which tests the polynomial exactness of Gauss-Hermite quadrature rules.
- int_exactness_jacobi, a program which tests the polynomial exactness of Gauss-Jacobi quadrature rules.
- int_exactness_laguerre, a program which tests the polynomial exactness of Gauss-Laguerre quadrature rules.
- int_exactness_legendre, a program which tests the polynomial exactness of Gauss-Legendre quadrature rules.
- jacobi_rule, a program which computes and writes out a Gauss-Jacobi quadrature rule of given order.
- keast, a library which defines Keast quadrature rules in a tetrahedron;
- kelley, a library which implements iterative methods for linear and nonlinear equations, by Tim Kelley;
- 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.
- laguerre_rule, a program which computes and writes out a Gauss-Laguerre quadrature rule of given order.
- latin_center, a library which computes N points in an M-dimensional Latin Center square;
- latin_edge, a library which returns N points in an M-dimensional Latin Edge square;
- latin_random, a library which returns N points in an M-dimensional Latin Random square;
- latinize, a program which adjusts N points in M dimensions to form a Latin hypercube;
- lcvt, a library which makes a sort of Latinized CVT (centroidal Voronoi tesselation);
- lcvt_dataset, a program which creates a Latinized CVT dataset;
- 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.
- legendre_rule, a program which writes out a Gauss-Legendre quadrature rule of given order.
- lemke, a library which implements Lemke's algorithm for the linear complementarity problem, by Paul Fackler and Mario Miranda.
- levels, a library which makes a contour plot, choosing the contour levels using random sampling.
- linpack, a library which constitutes a linear algebra library;
- linpack_bench, a program which is the LINPACK benchmark;
- linpack_bench_backslash, a program which is the LINPACK benchmark, using MATLAB's buildin "backslash" operator;
- linpack_c, a library which constitutes a linear algebra library for single precision complex arithmetic;
- linpack_d, a library which constitutes a linear algebra library for double precision real arithmetic;
- linpack_s, a library which constitutes a linear algebra library; for single precision real arithmetic;
- linpack_z, a library which constitutes a linear algebra library; for double precision complex arithmetic (NOTHING HERE)
- linplus, a library which factors/solves/multiplies matrices in a variety of formats;
- lorenz_demo, a program which computes and displays solutions of the Lorenz equations;
- machar, a library which dynamically computes the value of various machine characteristic constants;
- machine, a library which returns tabulated values of the constants associated with computer arithmetic
- matlab, examples which illustrate the use of MATLAB scripts and M-files;
- matlab_batch, examples which illustrate how MATLAB can be run in "batch" mode, that is, non-interactively, on a UNIX system;
- matlab_c, examples which illustrate how C functions can be written, compiled, and called from MATLAB using the MEX facility;
- matlab_f77, examples which illustrate how FORTRAN77 functions can be written, compiled, and called from MATLAB using MATLAB's mex facility;
- matlab_movies, examples which illustrate making movies using MATLAB;
- 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);
- md is a program which carries out a molecular dynamics simulation, and is intended as a starting point for implementing an OpenMP parallel version.
- memory_test, a program which tests the memory available on the computer by declaring and using big vectors.
- mesh_bandwidth, a program which returns the geometric bandwidth associated with a mesh of elements of any order and in a space of arbitrary dimension.
- mgmres, a library which applies the restarted GMRES algorithm to a sparse linear system;
- mm_io, a library which reads and writes a Matrix Market Sparse Matrix File;
- msm_to_hb, a program which writes a MATLAB sparse matrix to a Harwell Boeing file;
- 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.
- nast2d_contour, a program which reads a data file from NAST2D_F90 and creates a contour plot;
- nast2d_streak_display, a program which reads a streakline data file from NAST2D_F90 and displays an image of one time frame;
- nast2d_streak_movie, a program which reads a streakline data file from NAST2D_F90 and creates a movie;
- ncc_tetrahedron, a library which defines Newton-Cotes closed quadrature rules in a tetrahedron;
- ncc_triangle, a library which defines Newton-Cotes closed quadrature rules in a triangle;
- nco_tetrahedron, a library which defines Newton-Cotes open quadrature rules in a tetrahedron;
- nco_triangle, a library which defines Newton-Cotes open quadrature rules in a triangle;
- nelder_mead, a program which implements the Nelder-Mead algorithm for the minimization of a scalar function of several variables.
- nested_sequence_display, a program which displays a set of nested sequences.
- niederreiter2, a library which computes the Niederreiter M-dimensional quasirandom sequence, base 2;
- nint_exactness, a program which demonstrates how to test the polynomial exactness of a multidimensional quadrature rule;
- nint_exactness_tet, a program which tests the polynomial exactness of a quadrature rule for the tetrahedron;
- nint_exactness_tri, a program which tests the polynomial exactness of a quadrature rule for the triangle;
- nintlib, a library which carries out approximate integration (quadrature) in multiple dimensions;
- normal, a library which generates uniform pseudorandom numbers;
- optimal_control_1d, a program which seeks the optimal control function for a one dimensional system which is represented using the finite element formulation;
- owens a library which evaluates Owen's T function;
- pbma_io, a library which reads or writes an ASCII PBM; (Portable Bit Map) image file;
- pce_legendre, a program which assembles the system matrix associated with a polynomal chaos expansion of a 2D stochastic PDE, using Legendre polynomials;
- pgma_io, a library which reads or writes an ASCII PGM; (Portable Gray Map) image file;
- ply_io, a library which reads or writes a PLY file.
- ply_to_tri_mesh, a program which reads a PLY file, and extracts the surface mesh data as a TRI_MESH dataset.
- points_01_plot, a program which reads an ASCII file containing points in the unit square, and makes an Encapsulated PostScript image;
- points_display a program which reads a TABLE file containing the coordinates of points in 2D or 3D, and displays a plot of the points in a MATLAB graphics window;
- polking programs, DFIELD5 and PPLANE5, for direction fields and phase planes of differential equations;
- polpak a library which evaluates recursively defined polynomials and other special functions;
- polygonal_surface_display a program which displays a surface in 3D described as a set of polygons;
- power_method a library which carries out the power method for finding a dominant eigenvalue and its eigenvector.
- ppma_io a library which reads or writes an ASCII PPM; (Portable Pixel Map) image file;
- prob a library which evaluates and samples various probability density functions;
- product_factor, a program which creates a multidimensional quadrature rule from a product of distinct 1d quadrature rules;
- product_rule a program which creates a multidimensional quadrature rule from a product of identical 1d quadrature rules;
- 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.
- puzzles, executable programs which solve simple puzzles;
- quad_mesh_display, a program which plots piecewise bilinear data associated with a quadrilateral mesh;
- quadrature_test a program which reads the definition of a multidimensional quadrature rule from three files, applies the rule to a number of test integrals, and prints the results.
- quadrule a library which defines quadrature rules for approximating an integral;
- quadrule_fast a library which rapidly defines certain quadrature rules for approximating an integral;
- quality a library which measures the dispersion of pointsets in M dimensions;
- random_data, a library which generates sample points for various probability density functions, geometries, and dimensions;
- 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;
- region_sample, a program which returns sample points from a region;
- 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.
- sandia_sparse, a library which can produce a multidimensional 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.
- satisfiability is a program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.
- sde, a library which illustrates the properties of stochastic differential equations, and common algorithms for their analysis, by Desmond Higham;
- sequence_streak_display, a program which displays a "streak plot" of a numeric sequence;
- sobol, a library which generates elements of the Sobol M-dimensional quasirandom sequence;
- sp_level_closed, a program which creates a sparse grid dataset based on closed rules (Clenshaw-Curtis, Newton-Cotes-Closed).
- sp_level_open, a program which creates a sparse grid dataset based on open rules (Fejer 1, Fejer 2, Gauss-Patterson, Newton-Cotes-Open, Newton-Cotes-Open-Half).
- sparse, a directory of example programs which illustrate the use of MATLAB's SPARSE matrix utilities;
- sparse_grid_cc, a library which creates sparse grids based on Clenshaw-Curtis rules.
- sparse_grid_cc_dataset, a program which creates sparse grids based on Clenshaw-Curtis rules.
- sparse_grid_closed, a library which creates sparse grids based on closed rules (Clenshaw-Curtis, Newton-Cotes-Closed).
- 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;
- sparse_grid_gl, a library which creates sparse grids based on Gauss-Legendre rules.
- sparse_grid_gl_dataset, a program which creates a sparse grid dataset based on Gauss-Legendre rules.
- sparse_grid_hermite, a library which creates sparse grids based on Gauss-Hermite rules.
- sparse_grid_hermite_dataset, a program which creates a sparse grid dataset based on Gauss-Hermite rules.
- sparse_grid_laguerre, a library which creates sparse grids based on Gauss-Laguerre rules.
- sparse_grid_laguerre_dataset, a program which creates a sparse grid dataset based on Gauss-Laguerrre rules.
- sparse_grid_open, a library which creates sparse grids based on open rules (Fejer 1, Fejer 2, Gauss-Patterson, Newton-Cotes-Open, Newton-Cotes-Open-Half).
- 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.
- spinterp, a library which carries out piecewise multilinear hierarchical sparse grid interpolation, by Andreas Klimke; ACM TOMS Algorithm 847.
- spline, a library which interpolates and approximates via splines;
- stla_display, a program which displays an STLA file (ASCII stereolithography 3D graphics file);
- stla_io, a library which reads and writes an STLA file (ASCII stereolithography 3D graphics file);
- stroud, a library which implements numerical integration over M-dimensional regions, including spheres, toruses and other shapes;
- subpak, a library which includes many utility routines;
- subset, a library which ranks, unranks, and generates random subsets, combinations, permutations, and so on;
- sudoku, a library which handles Sudoku puzzles;
- 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;
- svd_basis, a program which applies the singular value decomposition to a collection of data vectors, extracting dominant modes;
- svd_demo, a program which demonstrates the calculation of the singular value decomposition and some of its properties;
- table_io, a library which reads and writes a simple TABLE file;
- table_latinize, a program which reads a TABLE file of N points in M dimensions, adjusts to form a Latin hypercube;
- 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.
- 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;
- table_read, a program which reads a TABLE file containing comment lines beginning with '#', and a matrix of data, one row per line;
- tcell_flow_display, a library which displays a single velocity field solution for the T cell;
- tcell_flow_movie, a library which creates an animation of the velocity solutions for the T cell;
- 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;
- tec_io, a library which reads or writes a TEC file containing finite element information;
- tec_to_fem, a program which reads a TEC file suitable for display by TECPLOT, extracts the information, and writes a corresponding set of FEM files, three text files describing the finite element model;
- templates, a library which carries out the iterative solution of linear systems;
- test_int_hermite, a library which implements test problems for approximate integration over an infinite interval.
- test_int_laguerre, a library which implements test problems for approximate integration over a semi-infinite interval.
- test_mat a library which defines a set of test matrices.
- test_matrix, a library which defines a set of test matrices and utilities, by Nick Higham;
- test_nint, a library which implements test problems for approximate integration (quadrature) in multiple dimensions.
- test_ode, a library which defines some sample ODE's for testing initial value problem solvers;
- test_tri_int, a library which implements test functions for integration over a triangle in 2 dimensions.
- test_triangulation, a library which defines test problems for triangulation;
- test_values, a library which returns selected values of some special functions;
- test_zero, a library which defines some functions f(x) suitable for testing software that solves f(x)=0;
- testpack a library which defines a set of test integrand functions by Alan Genz.
- tet_mesh a library which works with tetrahedral meshes in 3D;
- tet_mesh_display, a program which reads data defining a (small) tet mesh, displays a wireframe image of the nodes and edges;
- 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;
- 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;
- tet_mesh_quality, a program which computes various quality measures for a tet mesh of a set of nodes in 3D;
- 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;
- tet_mesh_refine, a program which refines a tet mesh;
- 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;
- timer, examples which illustrate how to time a piece of code;
- timestamp, a library which prints the current YMDHMS date as a timestamp;
- 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. - toms179 a library which calculates the incomplete Beta ratio;
this is a MATLAB version of ACM TOMS algorithm 179. - toms291 a library which approximates the logarithm of the Gamma function;
this is a MATLAB version of ACM TOMS algorithm 291. - tri_mesh_display, a program which displays a surface in 3D described as a mesh of triangles;
- tri_mesh_to_ply, a program which converts a TRI_MESH dataset to a dataset suitable for storage as a PLY file.
- triangulation, a library which computes the triangulation of a set of points in the plane, and to perform various operations using a triangulation;
- 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;
- triangulation_corner, a program which modifies triangulations in which one or more triangles have more than one boundary edge.
- triangulation_l2q, a program which reads information about a 3-node (linear) triangulation and creates data defining a corresponding 6-node (quadratic) triangulation;
- triangulation_mask, a program which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;
- triangulation_order1_display, a program which plots piecewise constant data associated with a triangulation;
- triangulation_order3_contour, a program which plots color contours of a scalar quantity evaluated at the nodes of a 3-node triangle triangulation.
- triangulation_order6_contour, a program which plots color contours of a scalar quantity evaluated at the nodes of a 6-node triangle triangulation.
- triangulation_orient, a program which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;
- triangulation_plot, a program which plots the nodes and elements of a triangulation;
- triangulation_q2l, a program which reads information about a 6-node triangulation and creates data defining a corresponding 3-node triangulation;
- triangulation_quality, a program which reads information about a triangulation and computes various quality measures;
- 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;
- triangulation_refine, a program which refines a triangulation;
- 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;
- tumor, a program which demonstrates a model of tumor growth;
- uniform, a library which computes N elements of a uniform pseudorandom sequence;
- uniform_dataset, a program which creates N elements of an M dimensional uniform pseudorandom sequence and writes them to a file.
- van_der_corput, a library which computes elements of the van der Corput 1-dimensional quasirandom sequence;
- van_der_corput_dataset, a program which creates N elements of a van der Corput sequence and writes them to a file.
- 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.
- 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.
- velocity_arrows, a program which reads coordinate data and velocity data from two files and makes an arrow plot of the velocity field.
- 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.
- 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.
- velocity_arrows_grid2, a program which reads node and velocity data, stored in one file, at "scattered" points, and makes a velocity vector plot on a uniform grid of user-specified density.
- 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.
- 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.
- velocity_arrows2, a program which reads coordinate and velocity data from a single file and makes an arrow plot of the velocity field.
- 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.
- voronoi_new, a program which is a revised version of MATLAB's voronoi command, and does a better job with the boundaries of the infinite regions;
- wandzura, a library which returns one of 6 Wandzura rules for quadrature in a triangle;
- xy_io, a library which reads and writes XY files.
- ziggurat, a library which samples the uniform, normal or exponential distributions, using the ziggurat method.
Last revised on 15 July 2008.
Great collection on matlab code, here is another share site on matlab code, especially on finance, http://www.mathfinance.cn/category/matlab/, have fun.
ReplyDelete