MATLAB Source Codes
Click on below links
- 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;
- asa159, a library which computes a random table with given row and column sums; this is Applied Statistics Algorithm 159;
- asa172 a library which simulates the generation of a set of multi-indices by nested DO-Loops; this is Applied Statistics Algorithm 172;
- 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;
- asa266, a library which evaluates various properties of the Dirichlet probability density function; this is Applied Statistics Algorithm 266;
- 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;
- ball_and_stick_display, a program which demonstrates the creation of a 3D "ball and stick" image;
- ball_grid, a library which computes grid points inside a ball.
- ball_volume_monte_carlo, a program which applies a Monte Carlo procedure to estimate the volume of the M-dimensional unit ball;
- 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;
- 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.
- black_scholes, a library which implements some simple approaches to the Black-Scholes option valuation theory;
- 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;
- blend, a library which carries out 1D/2D/3D blending interpolation;
- 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;
- box_plot, a program which displays a box plot of data that consists of pairs of integers;
- 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.
- 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.
- buckling_spring a program which plots solutions of the buckling spring equations.
- c8lib, a library which implements certain elementary functions for double precision complex variables;
- calendar_nyt, a library which shows the correspondence between dates and the New York Times volume and issue number;
- 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;
- 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.
- cg_distributed, a program which implements a version of the NAS CG conjugate gradient benchmark, using distributed memory.
- 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;
- circle_grid, a library which computes grid points inside a circle.
- cities, a library which works with city-to-city distance matrices;
- clenshaw_curtis_rule, a program which implements a Clenshaw Curtis quadrature rule;
- collatz, a library which computes and analyzes the Collatz sequence (or "hailstone" sequence or "3n+1 sequence");
- collatz_parfor is a program which seeks the maximum Collatz sequence between 1 and N; it runs in parallel using MATLAB's "parfor" facility.
- 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.
- colored_noise, a library which generates samples of noise obeying a 1/f^alpha power law.
- combo, a library which handles combinatorial problems, by Kreher and Stinson;
- complex_numbers, a program which demonstrates some simple features involved in the use of complex numbers in C programming.
- contour_sequence4, a program which creates images suitable for animation from one XY file and a sequence of U(X,Y) data files;
- 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.
- 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.
- 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 Tessellation in M dimensions;
- 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.
- 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;
- 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.
- 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;
- cyclic_reduction, a library which solves a tridiagonal linear system using cyclic reduction;
- dice_simulation a program which simulates N tosses of M dice, making a histogram of the results.
- dijkstra a program which runs a simple example of Dijkstra's minimum distance algorithm for graphs.
- dijkstra_spmd a program which uses the SPMD feature to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.
- 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.
- 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.
- dist_plot, a program which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh code;
- distance_to_position a program which estimates the positions of cities based on a city-to-city distance table.
- 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.
- 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;
- duel_simulation a program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
- dunavant, a library which defines Dunavant quadrature rules in a triangle;
- ellipse_grid, a library which computes grid points inside an ellipse.
- ellipsoid_grid, a library which computes grid points inside a 3D ellipsoid.
- entrust, a library which uses trust-region methods to solve problems in scalar optimization or nonlinear least squares, by Borggaard and Cliff.
- 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.
- faure, a library which computes the Faure M-dimensional quasirandom sequence;
- faure_dataset, a program which creates a multivariate Faure quasirandom dataset;
- fd_predator_prey, a program which solves a time-dependent predator prey system using a finite difference approximation.
- fd_to_tec is a program which converts FD (finite difference) models into TECPLOT ASCII files.
- 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.
- 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.
- fd1d_bvp, a program which applies the finite difference method to a two point boundary value problem in one spatial dimension.
- fd1d_display, a program which reads a pair of files defining a 1D finite difference model, and plots the data.
- fd1d_heat_explicit, a program which implements a finite difference solution, explicit in time, of the time dependent 1D heat equation;
- fd1d_heat_implicit, a program which implements a finite difference solution, implicit in time, of the time dependent 1D heat equation;
- fd1d_heat_steady, a program which implements a finite difference solution for the steady (time independent) 1D heat equation;
- fd1d_predator_prey, a program which implements a finite difference algorithm for a time and 1D space dependent predator-prey system;
- fd1d_predator_prey_plot, a program which plots solutions from the FD1D_PREDATOR_PREY program.
- fd1d_wave, a program which applies the finite difference method to solve the time-dependent wave equation in one spatial dimension.
- 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.
- fd2d_predator_prey, a program which implements a finite difference algorithm for a time and 2D space dependent predator-prey system.
- fekete, a library which sets up one of seven Fekete rules for interpolation or quadrature in a triangle;
- felippa, a library which defines quadrature rules for lines, triangles, quadrilaterals, pyramids, wedges, tetrahedrons and hexahedrons.
- 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, 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.)
- fem_basis_q4_display, a program which displays any single basis function associated with an arbitrary linear quadrilateral ("Q4") mesh;
- fem_basis_t3_display, a program which displays any single basis function associated with an arbitrary 3-node triangle "T3" mesh;
- fem_basis_t4_display, a program which displays any single basis function associated with an arbitrary 4-node triangle "T4" mesh;
- fem_basis_t6_display, a program which displays any single basis function associated with an arbitrary 6-node triangle "T6" mesh;
- fem_io, a library which reads or writes FEM files, (three text files describing a finite element model);
- fem_to_mesh is a program which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding MESH file.
- 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.
- 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_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.
- 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.
- 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;
- 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.
- 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.
- fem2d_heat, a program which applies the finite element method to the time dependent heat equation on an arbitrary triangulated region in 2D;
- fem2d_heat_rectangle, a program which applies the finite element method for the time-dependent heat equation on a triangulated square in 2D;
- 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.
- 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;
- 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.
- 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.
- 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;
- fem2d_navier_stokes_cavity is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "cavity" problem.
- fem2d_navier_stokes_channel is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "channel" problem.
- 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;
- 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.
- fem2d_navier_stokes_sparse_cavity is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "cavity" problem.
- fem2d_navier_stokes_sparse_channel is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "channel" problem.
- fem2d_navier_stokes_sparse_inout is a library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the "inout" problem.
- fem2d_pack, a library which performs simple 2D finite element computations;
- fem2d_poisson, a program which applies the finite element method to Poisson's equation on an arbitrary triangulated region in 2D;
- 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.
- 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.
- fem2d_poisson_rectangle, a program which solves the 2D Poissone equation on a rectangle, using the finite element method, and piecewise quadratic triangular elements.
- 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.
- 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.)
- 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.
- 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.
- 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.
- 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.
- 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.
- fem2d_stokes, a program which applies the finite element method for the steady incompressible Stokes equations on an arbitrary triangulated region in 2D;
- fem2d_stokes_cavity is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "cavity" problem.
- fem2d_stokes_channel is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "channel" problem.
- fem2d_stokes_inout is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "inout" problem.
- 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;
- 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.
- fem2d_stokes_sparse_cavity is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "cavity" problem.
- fem2d_stokes_sparse_channel is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "channel" problem.
- fem2d_stokes_sparse_inout is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "inout" problem.
- fem2d_stokes_sparse_spiral is a library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the "spiral" problem.
- fem2d_stokes_spiral is a library which contains the user-supplied routines necessary to run fem2d_stokes on the "spiral" problem.
- fem3d_pack is a library which contains utilities for 3D finite element calculations.
- 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.
- fem3d_sample is a program library which evaluates a finite element function defined on a 3D tetrahedral mesh.
- feynman_kac, a program which demonstrates the use of the Feynman-Kac algorithm for solving certain partial differential equations.
- fft_serial is a program which computes a Fast Fourier Transform, and is intended as a starting point for implementing a parallel version.
- file_increment, a program which makes a copy of a file containing an integer array, after incrementing each entry by a given value.
- file_name_sequence a program which demonstrates four ways to generate a sequence of filenames.
- filum, a library which handles files and filenames;
- floyd is a library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.
- 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.
- 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.
- gamblers_ruin_simulation, a program which simulates the game of gambler's ruin.
- 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 a triangle, tetrahedron, or M-dimensional simplex.
- graph_representation, a library which can express the representation of an abstract mathematical graph in several ways.
- grf_display, a program which reads a GRF file defining a mathematical graph and displays it in the MATLAB graphics window.
- grf_io, a library which reads or writes a GRF file;
- grid, a library which computes N random points on a uniform M-dimensional grid;
- grid_dataset, a program which creates a grid dataset;
- gridlines is a library which gives the user more control over drawing gridlines on a graph than the built in "grid on" command.
- 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 writes 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 writes them to a file.
- hb_io, a library which reads and writes files in the Harwell Boeing sparse matrix format;
- hb_to_mm, a program which converts a sparse matrix stored in a Harwell Boeing file to Matrix Market format;
- hb_to_msm, a program which converts a sparse matrix stored in a Harwell Boeing file to MATLAB sparse matrix format;
- hb_to_st a program which reads a sparse matrix in a Harwell-Boeing file and writes an equivalent Sparse Triplet file.
- hcell_flow_display, a program which plots the physical data, pressures or velocities, from a run of the HCELL program;
- 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.
- hello, a program which prints out "Hello, world!".
- 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.
- 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;
- i4lib, a library which contains many utility routines, using "I4" or "single precision integer" arithmetic.
- ice_io a library which reads or writes ICE grid files stored in NETCDF format.
- ice_to_mesh is a program which reads a NETCDF file containing an ICE dataset and rewrites the information as a MESH file.
- 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;
- image_contrast, programs which applies image processing techniques to increase the contrast in an image.
- image_denoise, programs which apply filtering operations to a noisy image.
- 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.
- image_edge a library which demonstrates a simple procedure for edge detection in images.
- 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.
- 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;
- kmeans, a library which handles the K-Means problem;
- knapsack_tasks, a program which solves a knapsack problem by subdividing it into tasks, each of which is carried out as a separate program.
- kronrod, is a library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
- 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_center_dataset, a program which creates a Latin Center Hypercube dataset;
- latin_edge, a library which returns N points in an M-dimensional Latin Edge square;
- latin_edge_dataset, a program which creates an N-point M-dimensional Latin Edge square dataset;
- latin_random, a library which returns N points in an M-dimensional Latin Random square;
- latin_random_dataset, a program which creates a Latin Random Hypercube dataset;
- latinize, a program which adjusts N points in M dimensions to form a Latin hypercube;
- lattice_rule, a library which returns lattice rules for M-dimensional integration;
- lcvt, a library which makes a sort of Latinized CVT (centroidal Voronoi tessellation);
- 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.
- legendre_rule_fast, a program which uses a fast (order N) algorithm to compute 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.
- 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.
- linpack_bench, a program which is the LINPACK benchmark;
- linpack_bench_backslash, a program which is the LINPACK benchmark, using MATLAB's builtin "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;
- linplus, a library which factors/solves/multiplies matrices in a variety of formats;
- lorenz_simulation, a program which computes and displays solutions of the Lorenz equations for various initial conditions.
- lyness_rule, a library which returns Lyness-Jespersen quadrature rules for the triangle.
- 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.
- 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
- mandelbrot, a program which generates an image of the Mandelbrot set;
- matlab, examples which illustrate the use of MATLAB scripts and M-files;
- matlab_commandline, examples which illustrate how MATLAB can be run from the UNIX command line, that is, not with the usual MATLAB command window.
- matlab_calls_c, examples which illustrate how C functions can be written, compiled, and called from MATLAB using the MEX facility;
- matlab_calls_f77, examples which illustrate how FORTRAN77 functions can be written, compiled, and called from MATLAB using MATLAB's mex facility;
- 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.
- 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);
- matlab_parallel, examples which illustrate "local" parallel programming on a single computer with MATLAB's Parallel Computing Toolbox.
- 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.
- md is a program which carries out a molecular dynamics simulation, and is intended as a starting point for implementing a parallel version.
- md_parfor is a program which carries out a molecular dynamics simulation; it runs in parallel using MATLAB's "parfor" facility.
- 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 M dimensions.
- 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.
- 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.
- mesh_to_ice is a program which reads the ICE dataset information from a MESH files and rewrites it to a NETCDF file.
- 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.
- mgmres, a library which applies the restarted GMRES algorithm to a sparse linear system, by Lili Ju;
- mm_io, a library which reads and writes a Matrix Market Sparse Matrix File;
- mm_to_hb, a program which reads a Matrix Market sparse matrix file and creates a corresponding HB Harwell Boeing sparse matrix file.
- mm_to_msm, a program which reads a Matrix Market sparse matrix file and creates a corresponding MATLAB sparse matrix data structure.
- mm_to_st, a program which reads a Matrix Market sparse matrix file and writes a corresponding ST Sparse Triplet file.
- 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.
- mpas_grid_display, programs which can read an MPAS NETCDF grid file and display the primary polygonal mesh or the dual triangular mesh.
- msm_to_hb, a program which writes a MATLAB sparse matrix to a Harwell Boeing file;
- msm_to_mm, a program which writes a MATLAB sparse matrix to a Matrix Market file;
- msm_to_st, a program which writes a MATLAB sparse matrix to a ST Sparse Triplet file;
- 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.
- 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.
- nas a program which runs the NASA kernel benchmark.
- 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;
- 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.
- 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.
- netcdf a directory of example programs which read and write NETCDF files.
- netcdf_glimmer programs which read and write GLIMMER grid and solution data stored as a NETCDF file.
- netcdf_mpas a library which reads MPAS grid data stored as a NETCDF file.
- niederreiter2, a library which computes the Niederreiter M-dimensional quasirandom sequence, base 2;
- niederreiter2_dataset, a program which creates a Niederreiter quasirandom dataset with base 2;
- 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.
- 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.
- nint_exactness_pyramid is a program which investigates the polynomial exactness of a quadrature rule for the pyramid.
- nintlib, a library which carries out approximate integration (quadrature) in M dimensions;
- normal, a library which generates uniform pseudorandom numbers;
- normal_dataset, a program which creates a multivariate normal random dataset;
- 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.
- obj_display, a program which displays an OBJ 3D graphics file;
- obj_io, a library which reads and writes the data in an in an OBJ 3D graphics file;
- obj_to_tri_surface, a program which reads an OBJ file, and extracts the surface mesh data as a TRI_SURFACE dataset.
- ode_predator_prey, a program which solves a time-dependent predator-prey system using MATLAB's ODE23 solver.
- 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.
- oned, a library which contains functions useful for 1D finite element calculations.
- 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;
- patterson_rule, a program which looks up and writes out a Gauss-Patterson quadrature rule of given order.
- 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;
- 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.
- pgma_io, a library which reads or writes an ASCII PGM; (Portable Gray Map) image file;
- 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).
- pink_noise, a library which computes a "pink noise" signal obeying a 1/f power law.
- plinth, a library which carries out tasks associated with the interpolation of data or a function by a hierarchical set of piecewise linear functions.
- 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.
- ply_io, a library which reads or writes a PLY file.
- ply_to_tri_surface, a program which reads a PLY file, and extracts the surface mesh data as a TRI_SURFACE dataset.
- points_01_plot, a program which reads an ASCII file containing points in the unit square, and makes an Encapsulated PostScript image;
- point_merge, a library which considers N points in M-dimensional space, and counts or indexes the unique or "tolerably unique" items.
- polking programs, DFIELD5 and PPLANE5, for direction fields and phase planes of ordinary differential equations (ODE's);
- 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;
- prime is a program which counts the number of primes between 1 and N.
- prime_parfor is a program which counts the number of primes between 1 and N; it runs in parallel using MATLAB's "parfor" facility.
- prime_spmd is a program which counts the number of primes between 1 and N; running in parallel using MATLAB's "SPMD" feature.
- prob a library which evaluates and samples various probability density functions;
- product_factor, a program which creates an M-dimensional quadrature rule from a product of distinct 1d quadrature rules;
- product_rule a program which creates an M-dimensional 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;
- pyramid_rule, is a program which computes a quadrature rule for a pyramid.
- quad, a program which applies a quadrature rule to estimate an integral, intended as a starting point for parallelization exercises.
- quad_mesh, a library which handles meshes of quadrilaterals over a 2D region;
- quad_mesh_rcm, a program which computes the reverse Cuthill-McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
- quad_parfor is a program which estimates an integral using quadrature; running in parallel using MATLAB's "PARFOR" feature.
- quad_spmd is a program which estimates an integral using quadrature; running in parallel using MATLAB's "SPMD" feature.
- 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;
- quad_tasks is a program which estimates an integral using quadrature; running in parallel using MATLAB's "TASK" feature.
- 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.
- 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.
- 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;
- r8lib, a library which contains many utility routines, using "R8" or "double precision real" arithmetic.
- randlc, a library which generates a sequence of pseudorandom numbers, used by the NAS Benchmark programs.
- random_data, a library which generates sample points for various probability density functions, geometries, and dimensions;
- random_walk_1d_simulation, a program which simulates a random walk in a 1-dimensional region.
- random_walk_2d_avoid_simulation, a program which simulates a self-avoiding random walk in a 2-dimensional region.
- 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.
- random_walk_2d_simulation, a program which simulates a random walk in a 2-dimensional region.
- random_walk_3d_simulation, a program which simulates a random walk in a 3-dimensional region.
- 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;
- rkf45, a library which applies a Runge-Kutta-Fehlberg solver to a system of ODE's;
- sammon_data is a program which generates six examples of M-dimensional datasets for cluster analysis.
- sandia_cubature, a library which implements quadrature rules for certain M-dimensional regions and weight functions.
- 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 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.
- satisfy is a program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.
- satisfy_parfor is a program which carries out a circuit satisfiability search; it runs in parallel using MATLAB's "parfor" facility.
- 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;
- sftpack a library which implements the "slow" Fourier transform, intended as a teaching tool and comparison with the fast Fourier transform.
- sgmga, a library which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.
- shallow_water_1d is a program which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.
- 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.
- simplex_coordinates, a library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
- 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.
- sobol, a library which generates elements of the Sobol M-dimensional quasirandom sequence;
- sobol_dataset, a program which creates a Sobol quasirandom dataset;
- 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_closed_dataset, a program which creates of a sparse grid dataset based on closed rules (Clenshaw-Curtis, Newton-Cotes-Closed).
- sparse_grid_composite, a library which creates sparse grids based on 1D composite rules (currently only of order 1).
- 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_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.
- 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_mixed, a library which creates sparse grids based a mixture of 1D factor rules.
- sparse_grid_mixed_dataset, a program which creates a sparse grid dataset based on a mixture of 1D rules.
- sparse_grid_open, a library which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
- sparse_grid_open_dataset, a program which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
- 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.
- 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.
- sphere_cvt, a program which carries out the Centroidal Voronoi Tessellation iteration on the unit sphere.
- sphere_delaunay, a program which computes the Delaunay triangulation of points on the unit sphere.
- sphere_exactness, a program which tests the polynomial exactness of a quadrature rule for the unit sphere;
- 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.
- sphere_lebedev_rule, a library which computes Lebedev quadrature rules for the unit sphere;
- sphere_lebedev_rule_display, a program which reads a file defining a Lebedev quadrature rule for the sphere and displays the point locations.
- 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;
- sphere_quad, a library which approximates an integral over the surface of the unit sphere by applying a triangulation to the surface;
- 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.
- sphere_stereograph_display is a library which computes and displays the results of several stereographic projections between a sphere and a plane.
- sphere_voronoi, a program which computes the Voronoi diagram of points on the unit sphere.
- 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.
- 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.
- spherical_harmonics, a library which evaluates spherical harmonic functions.
- 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.
- spline, a library which interpolates and approximates via splines;
- st_io a library which reads and writes sparse linear systems stored in the ST "sparse triplet" Sparse Matrix format.
- st_to_hb, a program which converts a sparse matrix file from ST format to HB format (Harwell Boeing format);
- st_to_mm, a program which converts a sparse matrix file from ST format to MM format (Matrix Market format);
- st_to_msm, a program which reads an ST sparse triplet file and creates a corresponding MATLAB Sparse Matrix.
- 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);
- stla_to_tri_surface, a program which reads a STLA file, and extracts the surface mesh data as a TRI_SURFACE dataset.
- stla_to_tri_surface_fast, a program which is a faster version of stla_to_tri_surface.
- stochastic_diffusion, functions which implement several versions of a stochastic diffusivity coefficient.
- stochastic_gradient_nd_noise, a program which solves an optimization problem involving a functional over a system with stochastic noise.
- stochastic_rk, a library which applies a Runge-Kutta scheme to a stochastic differential equation.
- 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;
- subset_sum is a program which seeks solutions of the subset sum problem.
- 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_delaunay, a program which reads a TABLE file of N points in 2 dimensions and writes out the Delaunay triangulation;
- 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;
- 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;
- tanh_quad, a library which sets up the tanh quadrature rule;
- tanh_sinh_rule, a program which computes and writes out a tanh-sinh quadrature rule of given order.
- 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 TECPLOT ASCII file containing finite element information;
- 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;
- 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.
- templates, a library which carries out the iterative solution of linear systems;
- test_con, a library which implements test problems for numerical continuation.
- test_int, a library which implements test problems for approximate integration (quadrature) in one dimension.
- test_int_2d, a library which implements test problems for approximate integration (quadrature) in two dimensions.
- 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_min, a library which implements test problems for minimization of a scalar function of a scalar variable.
- test_nint, a library which implements test problems for approximate integration (quadrature) in M 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_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.
- 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;
- tet_mesh_volumes is a program which computes the volume of each tetrahedron in a tet mesh;
- tetrahedron_exactness, a program which tests the polynomial exactness of a quadrature rule for the tetrahedron;
- tetrahedron_grid, a library which computes a tetrahedral grid of points.
- tetrahedron_monte_carlo, a program which uses the Monte Carlo method to estimate an integral over a tetrahedron.
- tetrahedron_properties, a program which prints out the properties of a tetrahedron whose vertex coordinates are read from a file;
- 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.
- tetrahedron_slice_display, a program which determines the intersection between a tetrahedron and a plane and displays the result.
- threed, a library which contains functions useful for 3D finite element calculations.
- 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.
- 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.
- 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.
- 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.
- 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.
- 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.
- 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.
- toms866 a library which contains the Incompressible Flow Iterative Solution Software (IFISS);this is ACM TOMS algorithm 866.
- traffic_simulation, a program which simulates the cars waiting to get through a traffic light.
- tri_surface_display, a program which displays a triangulated surface;
- tri_surface_io, a library which reads and writes the 3D graphics information in a TRI_SURFACE file;
- tri_surface_to_obj, a program which reads a TRI_SURFACE dataset and extracts the surface mesh data as an OBJ file.
- tri_surface_to_ply, a program which converts a TRI_SURFACE dataset to a dataset suitable for storage as a PLY file.
- tri_surface_to_stla, a program which reads a TRI_SURFACE dataset and extracts the surface mesh data as an ASCII STL file.
- 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.
- triangle_exactness, a program which tests the polynomial exactness of a quadrature rule for triangles;
- triangle_grid, a library which computes a triangular grid of points.
- triangle_histogram, a program which computes histograms of data on the unit triangle.
- triangle_monte_carlo, a program which uses the Monte Carlo method to estimate an integral over a triangle.
- triangle_properties, a program which computes properties of a triangle whose vertex coordinates are read from a 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_delaunay_discrepancy is a program which measures the amount by which a triangulation fails the local Delaunay test;
- triangulation_display, a program which displays the nodes and elements of a triangulation on the MATLAB graphics screen;
- triangulation_histogram, a program which computes histograms of data over a triangulation.
- 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 as a PostScript file;
- triangulation_q2l, a program which reads information about a 6-node triangulation and creates data defining a corresponding 3-node triangulation;
- 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.
- 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_t3_to_t4, a program which reads information about a 3-node T3 triangulation and creates data defining a corresponding 4-node T4 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;
- truel_simulation a program which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
- tumor, a program which demonstrates a model of tumor growth;
- twod, a library which contains functions useful for 2D finite element calculations.
- twod_plotc, a program which makes a color contour plot of scalar data defined on a 2D finite element mesh.
- 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.
- 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.
- 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_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.
- 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.
- wandzura, a library which returns one of 6 Wandzura rules for quadrature in a triangle;
- weekday is a library which determines the day of the week for a given day.
- wtime is a library which returns a reading of the wall clock time in seconds.
- 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;
- xy_io, a library which reads and writes XY files.
- xyf_display is a program which reads XYF information defining points and faces in 2D, and displays an image in the MATLAB graphics window.
- xyl_display is a program which reads XYL information defining points and lines in 2D, and displays an image in the MATLAB graphics window.
- xyz_display is a program which reads XYZ information defining points in 3D, and displays an image in the MATLAB 3D graphics window.
- xyz_io, a library which reads and writes XYZ files.
- 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.
- 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.
- ziggurat, a library which samples the uniform, normal or exponential distributions, using the ziggurat method.
Click on below links to download
 cab.m............Echelon factorization A = c a b.
 cab.m............Echelon factorization A = c a b.
 cofactor.m........Matrix of cofactors.
 cofactor.m........Matrix of cofactors.
 colbasis.m........Basis for the column space.
 colbasis.m........Basis for the column space.
 cramer.m............Solve the system Ax=b.
 cramer.m............Solve the system Ax=b.
 determ.m........Matrix determinant from plu.
 determ.m........Matrix determinant from plu.
 eigen2.m............Characteristic polynomial, eigenvalues, eigenvectors.
 eigen2.m............Characteristic polynomial, eigenvalues, eigenvectors.
 eigshow.m............Graphical demonstration of eigenvalues and singular values.
 eigshow.m............Graphical demonstration of eigenvalues and singular values.
 eigval.m............Eigenvalues and their algebraic multiplicity.
 eigval.m............Eigenvalues and their algebraic multiplicity.
 eigvec.m............Eigenvectors and their geometric multiplicity.
 eigvec.m............Eigenvectors and their geometric multiplicity.
 elim.m............EA=R factorization.
 elim.m............EA=R factorization.
 findpiv.m............Used by plu to find a pivot for Gaussian elimination.
 findpiv.m............Used by plu to find a pivot for Gaussian elimination.
 fourbase.m............Bases for all 4 fundamental subspaces.
 fourbase.m............Bases for all 4 fundamental subspaces.
 grams.m............Gram-Schmidt orthogonalization of the columns of A.
 grams.m............Gram-Schmidt orthogonalization of the columns of A.
 house.m............Stores the "house" data set in X.
 house.m............Stores the "house" data set in X.
 inverse.m............Matrix inverse by Gauss-Jordan elimination.
 inverse.m............Matrix inverse by Gauss-Jordan elimination.
 leftnull.m............Basis for the left nullspace.
 leftnull.m............Basis for the left nullspace.
 linefit.m............Plot the least squares fit by a line.
 linefit.m............Plot the least squares fit by a line.
 lsq.m............Least squares solution of Ax=b.
 lsq.m............Least squares solution of Ax=b.
 normal.m............Eigenvalues and eigenvectors of a normal matrix A.
 normal.m............Eigenvalues and eigenvectors of a normal matrix A.
 nulbasis.m............Basis for the nullspace.
 nulbasis.m............Basis for the nullspace.
 orthcomp.m............Orthogonal complement of a subspace.
 orthcomp.m............Orthogonal complement of a subspace.
 partic.m............Particular solution of Ax=b.
 partic.m............Particular solution of Ax=b.
 plot2d.m............Two dimensional plot.
 plot2d.m............Two dimensional plot.
 plu.m............Rectangular PA=LU factorization *with row exchanges*.
 plu.m............Rectangular PA=LU factorization *with row exchanges*.
 poly2str.m............Convert a polynomial coefficient vector to a string.
 poly2str.m............Convert a polynomial coefficient vector to a string.
 project.m............Project a vector b onto the column space of A.
 project.m............Project a vector b onto the column space of A.
 projmat.m............Projection matrix for the column space of A.
 projmat.m............Projection matrix for the column space of A.
 randperm.m............Random permutation.
 randperm.m............Random permutation.
 rowbasis.m............Basis for the row space.
 rowbasis.m............Basis for the row space.
 samespan.m............Test if two matrices have the same column space.
 samespan.m............Test if two matrices have the same column space.
 signperm.m......Determinant of the permutation matrix with rows ordered by p.
 signperm.m......Determinant of the permutation matrix with rows ordered by p.
 slu.m............LU factorization of a square matrix using *no row exchanges*.
 slu.m............LU factorization of a square matrix using *no row exchanges*.
 splu.m............Square PA=LU factorization *with row exchanges*.
 splu.m............Square PA=LU factorization *with row exchanges*.
 splv.m............Solution to a square, invertible system.
 splv.m............Solution to a square, invertible system.
 symmeig.m............Eigenvalues and eigenvectors of a symmetric matrix.
 symmeig.m............Eigenvalues and eigenvectors of a symmetric matrix.
 tridiag.m............Tridiagonal matrix.
 tridiag.m............Tridiagonal matrix.
 cab.m............Echelon factorization A = c a b.
 cab.m............Echelon factorization A = c a b. cofactor.m........Matrix of cofactors.
 cofactor.m........Matrix of cofactors. colbasis.m........Basis for the column space.
 colbasis.m........Basis for the column space. cramer.m............Solve the system Ax=b.
 cramer.m............Solve the system Ax=b. determ.m........Matrix determinant from plu.
 determ.m........Matrix determinant from plu. eigen2.m............Characteristic polynomial, eigenvalues, eigenvectors.
 eigen2.m............Characteristic polynomial, eigenvalues, eigenvectors. eigshow.m............Graphical demonstration of eigenvalues and singular values.
 eigshow.m............Graphical demonstration of eigenvalues and singular values. eigval.m............Eigenvalues and their algebraic multiplicity.
 eigval.m............Eigenvalues and their algebraic multiplicity. eigvec.m............Eigenvectors and their geometric multiplicity.
 eigvec.m............Eigenvectors and their geometric multiplicity. elim.m............EA=R factorization.
 elim.m............EA=R factorization. findpiv.m............Used by plu to find a pivot for Gaussian elimination.
 findpiv.m............Used by plu to find a pivot for Gaussian elimination. fourbase.m............Bases for all 4 fundamental subspaces.
 fourbase.m............Bases for all 4 fundamental subspaces. grams.m............Gram-Schmidt orthogonalization of the columns of A.
 grams.m............Gram-Schmidt orthogonalization of the columns of A. house.m............Stores the "house" data set in X.
 house.m............Stores the "house" data set in X. inverse.m............Matrix inverse by Gauss-Jordan elimination.
 inverse.m............Matrix inverse by Gauss-Jordan elimination. leftnull.m............Basis for the left nullspace.
 leftnull.m............Basis for the left nullspace. linefit.m............Plot the least squares fit by a line.
 linefit.m............Plot the least squares fit by a line. lsq.m............Least squares solution of Ax=b.
 lsq.m............Least squares solution of Ax=b. normal.m............Eigenvalues and eigenvectors of a normal matrix A.
 normal.m............Eigenvalues and eigenvectors of a normal matrix A. nulbasis.m............Basis for the nullspace.
 nulbasis.m............Basis for the nullspace. orthcomp.m............Orthogonal complement of a subspace.
 orthcomp.m............Orthogonal complement of a subspace. partic.m............Particular solution of Ax=b.
 partic.m............Particular solution of Ax=b. plot2d.m............Two dimensional plot.
 plot2d.m............Two dimensional plot. plu.m............Rectangular PA=LU factorization *with row exchanges*.
 plu.m............Rectangular PA=LU factorization *with row exchanges*. poly2str.m............Convert a polynomial coefficient vector to a string.
 poly2str.m............Convert a polynomial coefficient vector to a string. project.m............Project a vector b onto the column space of A.
 project.m............Project a vector b onto the column space of A. projmat.m............Projection matrix for the column space of A.
 projmat.m............Projection matrix for the column space of A. randperm.m............Random permutation.
 randperm.m............Random permutation. rowbasis.m............Basis for the row space.
 rowbasis.m............Basis for the row space. samespan.m............Test if two matrices have the same column space.
 samespan.m............Test if two matrices have the same column space. signperm.m......Determinant of the permutation matrix with rows ordered by p.
 signperm.m......Determinant of the permutation matrix with rows ordered by p. slu.m............LU factorization of a square matrix using *no row exchanges*.
 slu.m............LU factorization of a square matrix using *no row exchanges*. splu.m............Square PA=LU factorization *with row exchanges*.
 splu.m............Square PA=LU factorization *with row exchanges*. splv.m............Solution to a square, invertible system.
 splv.m............Solution to a square, invertible system. symmeig.m............Eigenvalues and eigenvectors of a symmetric matrix.
 symmeig.m............Eigenvalues and eigenvectors of a symmetric matrix. tridiag.m............Tridiagonal matrix.
 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