Skip to content

imgeorgelin/jburkardt-m

 
 

Folders and files

NameName
Last commit message
Last commit date

Latest commit

 

History

1 Commit
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 
 

Repository files navigation

<title> MATLAB Source Codes </title>
<h1 align = "center">
  MATLAB Source Codes
</h1>

<hr>

<p>
  <ol>
    <li>
      <a href = "args/args.html">
      args</a>,
      a program which
      shows how to count and report command line arguments;
    </li>
    <li>
      <a href = "arpack/arpack.html">
      arpack</a>,
      a library which
      computes eigenvalues and eigenvectors
      of large sparse matrices, accessible via the built-in
      EIGS() command;
    </li>
    <li>
      <a href = "asa005/asa005.html">
      asa005</a>,
      a library which
      evaluates the lower tail of the noncentral Student's T distribution,
      by BE Cooper.
      This is a Matlab version of Applied Statistics Algorithm 5;
    </li>
    <li>
      <a href = "asa006/asa006.html">
      asa006</a>,
      a library which
      computes the Cholesky factor of a positive definite symmetric matrix,
      by Michael Healy;
      This is a Matlab version of Applied Statistics Algorithm 6;
    </li>
    <li>
      <a href = "asa007/asa007.html">
      asa007</a>,
      a library which
      computes the inverse of a positive definite symmetric matrix,
      by Michael Healy;
      This is a Matlab version of Applied Statistics Algorithm 7.
    </li>
    <li>
      <a href = "asa032/asa032.html">
      asa032</a>,
      a library which
      evaluates the incomplete Gamma function,
      by G Bhattacharjee.
      This is a Matlab version of Applied Statistics Algorithm 32;
    </li>
    <li>
      <a href = "asa047/asa047.html">
      asa047</a>,
      a library which
      minimizes a scalar function of several variables using the Nelder-Mead algorithm,
      by R ONeill.
      This is a Matlab version of Applied Statistics Algorithm 47;
    </li>
    <li>
      <a href = "asa058/asa058.html">
      asa058</a>,
      a library which
      carries out clustering of data,
      by David Sparks.
      This is a Matlab version of Applied Statistics Algorithm 58;
    </li>
    <li>
      <a href = "asa063/asa063.html">
      asa063</a>,
      a library which
      evaluates the incomplete Beta function,
      by KL Majumder and G Bhattacharjee.
      This is a Matlab version of Applied Statistics Algorithm 63;
    </li>
    <li>
      <a href = "asa066/asa066.html">
      asa066</a>,
      a library which
      computes the cumulative density function (CDF) of the standard normal distribution,
      by David Hill.
      This is a Matlab version of Applied Statistics Algorithm 66;
    </li>
    <li>
      <a href = "asa076/asa076.html">
      asa076</a>,
      a library which
      evaluates Owen's T function,
      by Young and Minder.
      This is a Matlab version of Applied Statistics Algorithm 76;
    </li>
    <li>
      <a href = "asa091/asa091.html">
      asa091</a>,
      a library which
      computes the percentage points of the Chi-square distribution,
      by Best and Roberts.
      This is a Matlab version of Applied Statistics Algorithm 91;
    </li>
    <li>
      <a href = "asa103/asa103.html">
      asa103</a>,
      a library which
      evaluates the digamma or psi function,
      by Jose Bernardo.
      This is a Matlab version of Applied Statistics Algorithm 103;
    </li>
    <li>
      <a href = "asa109/asa109.html">
      asa109</a>
      a library which
      inverts the incomplete Beta function,
      by Cran, Martin and Thomas.
      This is a Matlab version of Applied Statistics Algorithm 109;
    </li>
    <li>
      <a href = "asa111/asa111.html">
      asa111</a>
      a library which
      evaluates the percentage points of the normal distribution,
      by Beasley and Springer.
      This is a Matlab version of Applied Statistics Algorithm 111;
    </li>
    <li>
      <a href = "asa113/asa113.html">
      asa113</a>
      a library which
      clusters data using a transfer and swap algorithm,
      by Banfield and Bassill;
      This is a Matlab version of Applied Statistics Algorithm 113;
    </li>
    <li>
      <a href = "asa121/asa121.html">
      asa121</a>,
      a library which
      evaluates the trigamma function,
      by BE Schneider.
      This is a Matlab version of Applied Statistics Algorithm 121;
    </li>
    <li>
      <a href = "asa136/asa136.html">
      asa136</a>,
      a library which
      implements a clustering algorithm,
      by Hartigan and Wong.
      This is a Matlab version of Applied Statistics Algorithm 136;
    </li>
    <li>
      <a href = "asa144/asa144.html">
      asa144</a>,
      a library which
      randomly generates tables with given row and column sums,
      by James Boyett.
      This is a Matlab version of Applied Statistics Algorithm 144;
    </li>
    <li>
      <a href = "asa147/asa147.html">
      asa147</a>,
      a library which
      evaluates the incomplete Gamma function,
      by Chi Leung Lau.
      This is a Matlab version of Applied Statistics Algorithm 147;
    </li>
    <li>
      <a href = "asa152/asa152.html">
      asa152</a>,
      a library which
      evaluates the probability density function (PDF) and 
      cumulative density function (CDF) associated with the
      hypergeometric distribution,
      by Richard Lund;
      This is a Matlab version of Applied Statistics Algorithm 152;
    </li>
    <li>
      <a href = "asa159/asa159.html">
      asa159</a>,
      a library which
      computes a random table with given row
      and column sums,
      by Michael Patefield;
      This is a Matlab version of Applied Statistics Algorithm 159;
    </li>
    <li>
      <a href = "asa172/asa172.html">
      asa172</a>,
      a library which
      generates all multidimensional indices in a given range,
      simulating the behavior of an arbitrary number of nested loops,
      by OFlaherty and MacKenzie;
      this is a Matlab version of Applied Statistics Algorithm 172;
    </li>
    <li>
      <a href = "asa183/asa183.html">
      asa183</a>,
      a library which
      implements a pseudorandom number generator,
      by Wichman and Hill;
      this is a Matlab version of Applied Statistics Algorithm 183;
    </li>
    <li>
      <a href = "asa226/asa226.html">
      asa226</a>,
      a library which
      evaluates the noncentral incomplete Beta function,
      by Russell Lenth;
      this is a Matlab version of Applied Statistics Algorithm 226;
    </li>
    <li>
      <a href = "asa239/asa239.html">
      asa239</a>,
      a library which
      evaluates the incomplete Gamma function,
      by Shea;
      this is a Matlab version of Applied Statistics Algorithm 239;
    </li>
    <li>
      <a href = "asa241/asa241.html">
      asa241</a>,
      a library which
      computes the inverse of the normal cumulative density function (CDF),
      by Michael Wichura;
      this is a Matlab version of Applied Statistics Algorithm 241;
    </li>
    <li>
      <a href = "asa243/asa243.html">
      asa243</a>,
      a library which
      evaluates the lower tail of the noncentral Student's T distribution,
      by Russell Lenth;
      this is a Matlab version of Applied Statistics Algorithm 243;
    </li>
    <li>
      <a href = "asa245/asa245.html">
      asa245</a>,
      a library which
      evaluates the logarithm of the Gamma function,
      by Allan Mcleod;
      this is a Matlab version of Applied Statistics Algorithm 245;
    </li>
    <li>
      <a href = "asa266/asa266.html">
      asa266</a>,
      a library which
      evaluates various properties of the Dirichlet probability density function (PDF);
      this is a Matlab version of Applied Statistics Algorithm 266;
    </li>
    <li>
      <a href = "asa299/asa299.html">
      asa299</a>,
      a library which
      computes the lattice points (integer coordinates) in an M-dimensional simplex,
      by Chasalow and Brand;
      this is a Matlab version of Applied Statistics Algorithm 299;
    </li>
    <li>
      <a href = "asa310/asa310.html">
      asa310</a>,
      a library which
      evaluates the noncentral incomplete Beta function,
      by Chattamvelli and Shanmugam;
      this is a Matlab version of Applied Statistics Algorithm 310;
    </li>
    <li>
      <a href = "ball_and_stick_display/ball_and_stick_display.html">
      ball_and_stick_display</a>,
      a program which
      demonstrates the creation of a 3D "ball and stick" image;
    </li>
    <li>
      <a href = "ball_grid/ball_grid.html">
      ball_grid</a>,
      a library which
      computes grid points inside a 3D ball.
    </li>
    <li>
      <a href = "ball_volume_monte_carlo/ball_volume_monte_carlo.html">
      ball_volume_monte_carlo</a>,
      a program which
      applies a Monte Carlo procedure to estimate the volume of the
      M-dimensional unit ball;
    </li>
    <li>
      <a href = "barycentric_interp_1d/barycentric_interp_1d.html">
      barycentric_interp_1d</a>,
      a library which
      defines and evaluates the barycentric Lagrange polynomial p(x) 
      which interpolates a set of data, so that p(x(i)) = y(i).
      The barycentric approach means that very high degree polynomials can
      safely be used.
    </li>
    <li>
      <a href = "bernstein/bernstein.html">
      bernstein</a>,
      a library which
      evaluates the Bernstein polynomials;
    </li>
    <li>
      <a href = "beta_nc/beta_nc.html">
      beta_nc</a>,
      a library which
      evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
    </li>
    <li>
      <a href = "bezier_surface/bezier_surface.html">
      bezier_surface</a>,
      a library which
      reads, writes, prints and manipulates
      the data that defines a Bezier surface;
    </li>
    <li>
      <a href = "bezier_surface_display/bezier_surface_display.html">
      bezier_surface_display</a>,
      a program which
      displays a Bezier surface;
    </li>
    <li>
      <a href = "birthday_remote/birthday_remote.html">
      birthday_remote</a>,
      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.
    </li>
    <li>
      <a href = "bisection_integer/bisection_integer.html">
      bisection_integer</a>,
      a library which
      seeks an integer solution to the equation F(X)=0,
      using bisection within a user-supplied change of sign interval [A,B].
    </li>
    <li>
      <a href = "black_scholes/black_scholes.html">
      black_scholes</a>,
      a library which
      implements some simple approaches to
      the Black-Scholes option valuation theory,
      by Desmond Higham.
    </li>
    <li>
      <a href = "blas1/blas1.html">
      blas1</a>,
      a library which
      contains the Basic Linear Algebra Subprograms (BLAS)
      for level 1 (vector-vector operations), for single and double precision,
      and for real and complex arithmetic.
    </li>
    <li>
      <a href = "blas1_c/blas1_c.html">
      blas1_c</a>,
      a library which
      implements the Level 1 Basic Linear Algebra Subprograms (BLAS),
      using single precision complex arithmetic;
    </li>
    <li>
      <a href = "blas1_d/blas1_d.html">
      blas1_d</a>,
      a library which
      implements the Level 1 Basic Linear Algebra Subprograms (BLAS),
      using double precision real arithmetic;
    </li>
    <li>
      <a href = "blas1_s/blas1_s.html">
      blas1_s</a>,
      a library which
      implements the Level 1 Basic Linear Algebra Subprograms (BLAS),
      using single precision real arithmetic;
    </li>
    <li>
      <a href = "blas1_z/blas1_z.html">
      blas1_z</a>,
      a library which
      implements the Level 1 Basic Linear Algebra Subprograms (BLAS),
      using double precision complex arithmetic;
    </li>
    <li>
      <a href = "blend/blend.html">
      blend</a>,
      a library which
      carries out 1D/2D/3D blending interpolation;
    </li>
    <li>
      <a href = "box_behnken/box_behnken.html">
      box_behnken</a>,
      a library which
      computes a Box-Behnken design,
      that is, a set of arguments to sample the behavior
      of a function of multiple parameters;
    </li>
    <li>
      <a href = "box_display/box_display.html">
      box_display</a>,
      a program which
      displays a box plot, over integer pairs of data, of a function
      defined by two formulas.
    </li>
    <li>
      <a href = "box_plot/box_plot.html">
      box_plot</a>,
      a program which
      displays a box plot of data that consists of pairs of integers;
    </li>
    <li>
      <a href = "brain_sensor_pod/brain_sensor_pod.html">
      brain_sensor_pod</a>,
      a program which
      applies the method of Proper Orthogonal Decomposition (POD)
      to seek underlying patterns in sets of 40 sensor readings of
      brain activity.
    </li>
    <li>
      <a href = "brent/brent.html">
      brent</a>,
      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.
    </li>
    <li>
      <a href = "brownian_motion_simulation/brownian_motion_simulation.html">
      brownian_motion_simulation</a>,
      a library which
      simulates Brownian motion in an M-dimensional region.
    </li>
    <li>
      <a href = "buckling_spring/buckling_spring.html">
      buckling_spring</a>,
      a program which
      plots solutions of the buckling spring equations.
    </li>
    <li>
      <a href = "burgers_solution/burgers_solution.html">
      burgers_solution</a>,
      a library which
      evaluates an exact solution of the time-dependent 1D viscous Burgers equation.
    </li>
    <li>
      <a href = "burgers_steady_viscous/burgers_steady_viscous.html">
      burgers_steady_viscous</a>,
      a library which
      solves the steady (time-independent) viscous Burgers equation
      using a finite difference discretization of the conservative form 
      of the equation, and then applying Newton's method to solve the
      resulting nonlinear system.
    </li>
    <li>
      <a href = "burgers_time_inviscid/burgers_time_inviscid.html">
      burgers_time_inviscid</a>,
      a library which
      solves the time-dependent inviscid Burgers equation
      using a finite difference discretization, and one of six solution
      methods selected by the user.
    </li>
    <li>
      <a href = "burgers_time_viscous/burgers_time_viscous.html">
      burgers_time_viscous</a>,
      a library which
      solves the time-dependent viscous Burgers equation
      using a finite difference discretization of the conservative form 
      of the equation.
    </li>
    <li>
      <a href = "c8lib/c8lib.html">
      c8lib</a>,
      a library which
      implements certain elementary functions for double precision complex ("C8") variables;
    </li>
    <li>
      <a href = "calendar_nyt/calendar_nyt.html">
      calendar_nyt</a>,
      a library which
      shows the correspondence between dates and the New York Times volume and
      issue number;
    </li>
    <li>
      <a href = "calpak/calpak.html">
      calpak</a>,
      a library which
      makes various calendar calculations;
    </li>
    <li>
      <a href = "cavity_flow_display/cavity_flow_display.html">
      cavity_flow_display</a>,
      a library which
      displays a single velocity field solution for the driven cavity;
    </li>
    <li>
      <a href = "cavity_flow_movie/cavity_flow_movie.html">
      cavity_flow_movie</a>,
      a library which
      animates the velocity solutions for the driven cavity;
    </li>
    <li>
      <a href = "cc_display/cc_display.html">
      cc_display</a>,
      a program which
      displays the points used in a 2D Clenshaw-Curtis quadrature rule;
    </li>
    <li>
      <a href = "ccn_rule/ccn_rule.html">
      ccn_rule</a>,
      a program which
      defines a nested Clenshaw Curtis quadrature rule.
    </li>
    <li>
      <a href = "ccvt_box/ccvt_box.html">
      ccvt_box</a>,
      a program which
      calculates a constrained Centroidal Voronoi Tessellation (CVT) for points constrained to
      lie in a box, with some points moved to the boundary;
    </li>
    <li>
      <a href = "ccvt_reflect/ccvt_reflect.html">
      ccvt_reflect</a>,
      a program which
      calculates a constrained Centroidal Voronoi Tessellation (CVT) for points constrained to
      lie in a box, with some points pushed towards the boundary;
    </li>
    <li>
      <a href = "cell/cell.html">
      cell</a>,
      a library which
      defines a cell array, a generalization of an array which
      can compactly store and retrieve vector or matrix data of 
      varying size, such as the rows of a triangular matrix.
    </li>
    <li>
      <a href = "cell_detection_tasks/cell_detection_tasks.html">
      cell_detection_tasks</a>,
      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.
    </li>
    <li>
      <a href = "cg_distributed/cg_distributed.html">
      cg_distributed</a>,
      a program which
      implements a version of the NAS CG conjugate gradient benchmark,
      using distributed memory.
    </li>
    <li>
      <a href = "cg_lab_triangles/cg_lab_triangles.html">
      cg_lab_triangles</a>,
      a collection of programs associated with a computer lab
      assignment on computational geometry and triangles;
    </li>
    <li>
      <a href = "chebyshev/chebyshev.html">
      chebyshev</a>,
      a library which
      computes the Chebyshev interpolant/approximant to a given function
      over an interval.
    </li>
    <li>
      <a href = "chebyshev_interp_1d/chebyshev_interp_1d.html">
      chebyshev_interp_1d</a>,
      a library which
      determines the combination of Chebyshev polynomials which 
      interpolates a set of data, so that p(x(i)) = y(i).
    </li>
    <li>
      <a href = "chebyshev_polynomial/chebyshev_polynomial.html">
      chebyshev_polynomial</a>,
      a library which
      evaluates the Chebyshev polynomial and associated functions.
    </li>
    <li>
      <a href = "chebyshev1_rule/chebyshev1_rule.html">
      chebyshev1_rule</a>,
      a program which
      computes and writes out a Gauss-Chebyshev type 1 quadrature rule of given order.
    </li>
    <li>
      <a href = "chebyshev2_rule/chebyshev2_rule.html">
      chebyshev2_rule</a>,
      a program which
      computes and writes out a Gauss-Chebyshev type 2 quadrature rule of given order.
    </li>
    <li>
      <a href = "chrpak/chrpak.html">
      chrpak</a>,
      a library which
      manipulates characters and strings;
    </li>
    <li>
      <a href = "circle_arc_grid/circle_arc_grid.html">
      circle_arc_grid</a>,
      a program which
      computes grid points along a circular arc.
    </li>
    <li>
      <a href = "circle_grid/circle_grid.html">
      circle_grid</a>,
      a library which
      computes grid points inside a circle.
    </li>
    <li>
      <a href = "cities/cities.html">
      cities</a>,
      a library which
      works with city-to-city distance matrices;
    </li>
    <li>
      <a href = "clenshaw_curtis_rule/clenshaw_curtis_rule.html">
      clenshaw_curtis_rule</a>,
      a program which
      implements a Clenshaw Curtis quadrature rule;
    </li>
    <li>
      <a href = "cnoise/cnoise.html">
      cnoise</a>,
      a library which
      generates samples of noise obeying a 1/f^alpha power law,
      by Miroslav Stoyanov.
    </li>
    <li>
      <a href = "collatz/collatz.html">
      collatz</a>,
      a library which
      computes and analyzes the Collatz
      sequence, also known as the hailstone sequence or 3n+1 sequence;
    </li>
    <li>
      <a href = "collatz_parfor/collatz_parfor.html">
      collatz_parfor</a>,
      a program which
      seeks the maximum Collatz sequence between 1 and N; it runs in parallel
      using MATLAB's parfor facility.
    </li>
    <li>
      <a href = "collatz_recursive/collatz_recursive.html">
      collatz_recursive</a>,
      a library which
      demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
    </li>
    <li>
      <a href = "color_remote/color_remote.html">
      color_remote</a>,
      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.
    </li>
    <li>
      <a href = "colored_noise/colored_noise.html">
      colored_noise</a>,
      a library which
      generates samples of noise obeying a 1/f^alpha power law.
    </li>
    <li>
      <a href = "combination_lock/combination_lock.html">
      combination_lock</a>,
      a program which
      simulates the process of determining the secret combination of a lock.
    </li>
    <li>
      <a href = "combo/combo.html">
      combo</a>,
      a library which
      includes routines for ranking, unranking, enumerating and randomly selecting
      balanced sequences, cycles, graphs, Gray codes, subsets, partitions,
      permutations, restricted growth functions, Pruefer codes and trees.
    </li>
    <li>
      <a href = "compass_search/compass_search.html">
      compass_search</a>,
      a library which 
      seeks the minimizer of a scalar function of several variables
      using compass search, a direct search algorithm that does not use derivatives.
    </li>
    <li>
      <a href = "complex_numbers/complex_numbers.html">
      complex_numbers</a>,
      a program which
      demonstrates some simple features involved in the use of
      complex numbers in C programming.
    </li>
    <li>
      <a href = "condition/condition.html">
      condition</a>,
      a library which
      implements methods of computing or estimating the condition number of a matrix.
    </li>
    <li>
      <a href = "contour_gradient/contour_gradient.html">
      contour_gradient</a>,
      a program which
      displays contours and gradient vectors for a function f(x,y).
    </li>
    <li>
      <a href = "contour_sequence4/contour_sequence4.html">
      contour_sequence4</a>,
      a program which
      creates images suitable for animation
      from one XY file and a sequence of u(x,y) data files;
    </li>
    <li>
      <a href = "contrast_spmd/contrast_spmd.html">
      contrast_spmd</a>,
      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.
    </li>
    <li>
      <a href = "contrast2_spmd/contrast2_spmd.html">
      contrast2_spmd</a>,
      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.
    </li>
    <li>
      <a href = "convex_hull/convex_hull.html">
      convex_hull</a>,
      a program which
      demonstrates the computation of the convex hull of a set of 2D points.
    </li>
    <li>
      <a href = "cordic/cordic.html">
      cordic</a>,
      a library which
      computes a few special functions using the CORDIC algorithm.
    </li>
    <li>
      <a href = "correlation/correlation.html">
      correlation</a>,
      a library which
      contains examples of statistical correlation functions.
    </li>
    <li>
      <a href = "correlation_chebfun/correlation_chebfun.html">
      correlation_chebfun</a>,
      a library which
      uses the chebfun library to compute truncated Karhunen-Loeve expansions
      of stochastic processes with a given correlation function.
    </li>
    <li>
      <a href = "cvt/cvt.html">
      cvt</a>,
      a library which
      computes an N-point Centroidal Voronoi Tessellation in M dimensions;
    </li>
    <li>
      <a href = "cvt_1d_lloyd/cvt_1d_lloyd.html">
      cvt_1d_lloyd</a>,
      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.
    </li>
    <li>
      <a href = "cvt_1d_nonuniform/cvt_1d_nonuniform.html">
      cvt_1d_nonuniform</a>,
      a program which
      computes an N-point Centroidal Voronoi Tessellation (CVT) 
      in 1 dimension, under a nonuniform density,
      and plots the evolution of the locations of the generators
      during the iteration;
    </li>
    <li>
      <a href = "cvt_1d_sampling/cvt_1d_sampling.html">
      cvt_1d_sampling</a>,
      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.
    </li>
    <li>
      <a href = "cvt_2d_sampling/cvt_2d_sampling.html">
      cvt_2d_sampling</a>,
      a program which
      computes an N-point Centroidal Voronoi Tessellation (CVT)
      within the unit square [0,1]x[0,1], under a uniform density,
      using sampling to estimate the Voronoi regions.
    </li>
    <li>
      <a href = "cvt_3d_sampling/cvt_3d_sampling.html">
      cvt_3d_sampling</a>,
      a program which
      computes an N-point Centroidal Voronoi Tessellation (CVT)
      within the unit cube [0,1]x[0,1]x[0,1], under a uniform density,
      using sampling to estimate the Voronoi regions.
    </li>
    <li>
      <a href = "cvt_dataset/cvt_dataset.html">
      cvt_dataset</a>,
      a program which
      creates a Centroidal Voronoi Tessellation (CVT) dataset;
    </li>
    <li>
      <a href = "cvt_demo/cvt_demo.html">
      cvt_demo</a>,
      a program which
      interactively, graphically demonstrates a Centroidal Voronoi Tessellation (CVT) 
      calculation;
    </li>
    <li>
      <a href = "cvt_metric/cvt_metric.html">
      cvt_metric</a>,
      a program which
      computes a Centroidal Voronoi Tessellation (CVT) under a spatially varying metric;
    </li>
    <li>
      <a href = "cvt_movie/cvt_movie.html">
      cvt_movie</a>,
      a program which
      creates an animation of the evolution of a Centroidal Voronoi Tessellation (CVT);
    </li>
    <li>
      <a href = "cvt_movie2/cvt_movie2.html">
      cvt_movie2</a>,
      a program which
      creates a Centroidal Voronoi Tessellation (CVT) movie;
    </li>
    <li>
      <a href = "cvt_movie3/cvt_movie3.html">
      cvt_movie3</a>,
      a program which
      creates a Centroidal Voronoi Tessellation (CVT) movie in a region of unusual shape;
    </li>
    <li>
      <a href = "cvt_movie4/cvt_movie4.html">
      cvt_movie4</a>,
      a program which
      creates a Centroidal Voronoi Tessellation (CVT) movie in a square, 
      with a density function that drives points to the corners;
    </li>
    <li>
      <a href = "cvt_movie5/cvt_movie5.html">
      cvt_movie5</a>,
      a program which
      repeats cvt_movie3, but with hexagonal
      grid initialization, fixed points, and boundary projection;
    </li>
    <li>
      <a href = "cycle_brent/cycle_brent.html">
      cycle_brent</a>,
      a library which
      carries out an iterated function evaluation, and seeks to determine the
      nearest element of a cycle, and the cycle's length, using Brent's method.
    </li>
    <li>
      <a href = "cycle_floyd/cycle_floyd.html">
      cycle_floyd</a>,
      a library which
      carries out an iterated function evaluation, and seeks to determine the
      nearest element of a cycle, and the cycle's length, using Floyd's method.
    </li>
    <li>
      <a href = "cyclic_reduction/cyclic_reduction.html">
      cyclic_reduction</a>,
      a library which
      solves a tridiagonal linear system using cyclic reduction;
    </li>
    <li>
      <a href = "dfield8/dfield8.html">
      dfield8</a>,
      a program which
      interactively displays the direction field of a differential equation,
      by John Polking.
    </li>
    <li>
      <a href = "diaphony/diaphony.html">
      diaphony</a>,
      a program which
      reads a file of N points in M dimensions and computes its diaphony, a measure
      of point dispersion.
    </li>
    <li>
      <a href = "dice_simulation/dice_simulation.html">
      dice_simulation</a>,
      a program which
      simulates N tosses of M dice, making a histogram of the results.
    </lil>
    <li>
      <a href = "dijkstra/dijkstra.html">
      dijkstra</a>,
      a program which
      runs a simple example of Dijkstra's minimum distance algorithm for graphs.
    </li>
    <li>
      <a href = "dijkstra_spmd/dijkstra_spmd.html">
      dijkstra_spmd</a>,
      a program which
      uses the spmd feature to parallelize a simple example of Dijkstra's
      minimum distance algorithm for graphs.
    </li>
    <li>
      <a href = "direction_arrows/direction_arrows.html">
      direction_arrows</a>,
      a program which
      reads coordinate data from one file,
      velocity data from another file, and makes an arrow plot
      of the direction field.
    </li>
    <li>
      <a href = "direction_arrows_grid/direction_arrows_grid.html">
      direction_arrows_grid</a>,
      a program which
      reads velocity data at scattered
      points, and makes a direction vector plot on a uniform grid
      of user-specified density.
    </li>
    <li>
      <a href = "direction_arrows_sequence/direction_arrows_sequence.html">
      direction_arrows_sequence</a>,
      a program which
      reads a fixed coordinate file,
      and a sequence of velocity data files and makes a sequence
      of velocity direction arrow plots.
    </li>
    <li>
      <a href = "discrete_pdf_sample/discrete_pdf_sample.html">
      discrete_pdf_sample</a>,
      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.
    </li>
    <li>
      <a href = "dist_plot/dist_plot.html">
      dist_plot</a>,
      a program which
      makes contour plots of the distance function,
      as defined and used in Persson and Strang's
      distmesh() code;
    </li>
    <li>
      <a href = "distance_to_position/distance_to_position.html">
      distance_to_position</a>,
      a program which
      estimates the positions of cities based on a city-to-city distance table.
    </li>
    <li>
      <a href = "distance_to_position_sphere/distance_to_position_sphere.html">
      distance_to_position_sphere</a>,
      a program which
      estimates the positions of cities on a sphere (such as the earth)
      based on a city-to-city distance table.
    </li>
    <li>
      <a href = "distmesh/distmesh.html">
      distmesh</a>,
      a library which
      carries out a method of mesh generation;
      by Per-Olof Persson and Gilbert Strang.
    </li>
    <li>
      <a href = "distmesh_3d/distmesh_3d.html">
      distmesh_3d</a>,
      a library which
      carries out a method of mesh generation in 3D,
      by Per-Olof Persson and Gilbert Strang.
    </li>
    <li>
      <a href = "divdif/divdif.html">
      divdif</a>,
      a library which
      uses divided differences to compute the polynomial interpolant 
      to a given set of data.
    </li>
    <li>
      <a href = "doomsday/doomsday.html">
      doomsday</a>,
      a library which
      is given the year, month and day of a date, and uses
      John Conway's doomsday algorithm to determine the corresponding day of the week.
    </li>
    <li>
      <a href = "double_c_data/double_c_data.html">
      double_c_data</a>,
      programs which
      generate, plot or write out 2D data that forms two interlocking
      "C" shapes.
    </li>
    <li>
      <a href = "duel_simulation/duel_simulation.html">
      duel_simulation</a>,
      a program which
      simulates N repetitions of a duel between two players, each of
      whom has a known firing accuracy.
    </li>
    <li>
      <a href = "dunavant/dunavant.html">
      dunavant</a>,
      a library which
      defines Dunavant quadrature rules in a triangle;
    </li>
    <li>
      <a href = "ellipse_grid/ellipse_grid.html">
      ellipse_grid</a>,
      a library which
      computes grid points inside an ellipse.
    </li>
    <li>
      <a href = "ellipsoid_grid/ellipsoid_grid.html">
      ellipsoid_grid</a>,
      a library which
      computes grid points inside a 3D ellipsoid.
    </li>
    <li>
      <a href = "entrust/entrust.html">
      entrust</a>,
      a library which
      uses trust-region methods to solve problems in scalar optimization
      or nonlinear least squares, 
      by Jeff Borggaard and Gene Cliff.
    </li>
    <li>
      <a href = "face_spmd/face_spmd.html">
      face_spmd</a>,
      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.
    </li>
    <li>
      <a href = "fair_dice_simulation/fair_dice_simulation.html">
      fair_dice_simulation</a>,
      a program which
      simulates N tosses of 2 dice, making a histogram of the results.
    </li>
    <li>
      <a href = "faure/faure.html">
      faure</a>,
      a library which
      computes the Faure M-dimensional quasirandom sequence;
    </li>
    <li>
      <a href = "faure_dataset/faure_dataset.html">
      faure_dataset</a>,
      a program which
      creates a multivariate Faure quasirandom dataset;
    </li>
    <li>
      <a href = "fd_predator_prey/fd_predator_prey.html">
      fd_predator_prey</a>,
      a program which
      solves a time-dependent predator prey system using a
      finite difference approximation.
    </li>
    <li>
      <a href = "fd_to_tec/fd_to_tec.html">
      fd_to_tec</a>,
      a program which
      converts FD (finite difference) models into tecplot ASCII files.
    </li>
    <li>
      <a href = "fd1d_burgers_lax/fd1d_burgers_lax.html">
      fd1d_burgers_lax</a>,
      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.
    </li>
    <li>
      <a href = "fd1d_burgers_leap/fd1d_burgers_leap.html">
      fd1d_burgers_leap</a>,
      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.
    </li>
    <li>
      <a href = "fd1d_bvp/fd1d_bvp.html">
      fd1d_bvp</a>,
      a program which
      applies the finite difference method
      to a two point boundary value problem in one spatial dimension.
    </li>
    <li>
      <a href = "fd1d_display/fd1d_display.html">
      fd1d_display</a>,
      a program which
      reads a pair of files defining a 1D finite difference model, and plots the data.
    </li>
    <li>
      <a href = "fd1d_heat_explicit/fd1d_heat_explicit.html">
      fd1d_heat_explicit</a>,
      a library which
      implements a finite difference solution, explicit in time, of the
      time dependent 1D heat equation;
    </li>
    <li>
      <a href = "fd1d_heat_implicit/fd1d_heat_implicit.html">
      fd1d_heat_implicit</a>,
      a program which
      implements a finite difference solution, implicit in time, of the
      time dependent 1D heat equation;
    </li>
    <li>
      <a href = "fd1d_heat_steady/fd1d_heat_steady.html">
      fd1d_heat_steady</a>,
      a program which
      implements a finite difference solution for the steady
      (time independent) 1D heat equation;
    </li>
    <li>
      <a href = "fd1d_predator_prey/fd1d_predator_prey.html">
      fd1d_predator_prey</a>,
      a program which
      implements a finite difference algorithm for a time and 1D space dependent
      predator-prey system,
      by Marcus Garvey.
    </li>
    <li>
      <a href = "fd1d_predator_prey_plot/fd1d_predator_prey_plot.html">
      fd1d_predator_prey_plot</a>,
      a program which
      plots solutions from the fd1d_predator_prey program,
      by Marcus Garvey.
    </li>
    <li>
      <a href = "fd1d_wave/fd1d_wave.html">
      fd1d_wave</a>,
      a program which
      applies the finite difference method to solve the time-dependent
      wave equation utt = c * uxx in one spatial dimension.
    </li>
    <li>
      <a href = "fd2d_heat_explicit_spmd/fd2d_heat_explicit_spmd.html">
      fd2d_heat_explicit_spmd</a>,
      a 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.
    </li>
    <li>
      <a href = "fd2d_predator_prey/fd2d_predator_prey.html">
      fd2d_predator_prey</a>,
      a program which
      implements a finite difference algorithm for a time and 2D space dependent
      predator-prey system,
      by Marcus Garvey.
    </li>
    <li>
      <a href = "fekete/fekete.html">
      fekete</a>,
      a library which
      sets up one of seven Fekete rules
      for interpolation or quadrature in a triangle;
    </li>
    <li>
      <a href = "felippa/felippa.html">
      felippa</a>,
      a library which
      defines quadrature rules for lines, triangles, quadrilaterals,
      pyramids, wedges, tetrahedrons and hexahedrons.
    </li>
    <li>
      <a href = "fem_50/fem_50.html">
      fem_50</a>,
      a program which
      implements a Finite Element Method solver using
      about 50 lines of MATLAB code,
      by Jochen Alberty, Carsten Carstensen, Stefan Funken.
    </li>
    <li>
      <a href = "fem_50_heat/fem_50_heat.html">
      fem_50_heat</a>,
      a program which
      is a version of
      fem_50 for the time-dependent
      heat equation,
      by Jochen Alberty, Carsten Carstensen, Stefan Funken.
    </li>
    <li>
      <a href = "fem_basis/fem_basis.html">
      fem_basis</a>,
      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.)
    </li>
    <li>
      <a href = "fem_basis_q4_display/fem_basis_q4_display.html">
      fem_basis_q4_display</a>,
      a program which
      displays any single basis function
      associated with an arbitrary linear quadrilateral Q4 mesh;
    </li>
    <li>
      <a href = "fem_basis_t3_display/fem_basis_t3_display.html">
      fem_basis_t3_display</a>,
      a program which
      displays any single basis function
      associated with an arbitrary 3-node triangle T3 mesh;
    </li>
    <li>
      <a href = "fem_basis_t4_display/fem_basis_t4_display.html">
      fem_basis_t4_display</a>,
      a program which
      displays any single basis function
      associated with an arbitrary 4-node triangle T4 mesh;
    </li>
    <li>
      <a href = "fem_basis_t6_display/fem_basis_t6_display.html">
      fem_basis_t6_display</a>,
      a program which
      displays any single basis function
      associated with an arbitrary 6-node triangle T6 mesh;
    </li>
    <li>
      <a href = "fem_io/fem_io.html">
      fem_io</a>,
      a library which
      reads or writes FEM files,
      three text files describing a finite element model;
    </li>
    <li>
      <a href = "fem_meshing/fem_meshing.html">
      fem_meshing</a>,
      a library which
      looks at some simple issues in defining a geometric mesh for
      the finite element method in 2D.
    </li>
    <li>
      <a href = "fem_neumann/fem_neumann.html">
      fem_neumann</a>,
      a program which
      sets up a time-dependent reaction-diffusion equation in 1D,
      with Neumann boundary conditions, 
      discretized using the finite element method.
    </li>
    <li>
      <a href = "fem_to_mesh/fem_to_mesh.html">
      fem_to_mesh</a>,
      a program which
      reads a pair of FEM files defining node coordinates and elements,
      and creates a corresponding MESH file.
    </li>
    <li>
      <a href = "fem_to_tec/fem_to_tec.html">
      fem_to_tec</a>,
      a program which
      reads a set of FEM files, (three
      text files describing a finite element model), and writes a
      TECPLOT ASCII file.
    </li>
    <li>
      <a href = "fem1d/fem1d.html">
      fem1d</a>,
      a program which
      applies the finite element method,
      using piecewise linear basis functions, to a linear
      two point boundary value problem in 1D;
    </li>
    <li>
      <a href = "fem1d_adaptive/fem1d_adaptive.html">
      fem1d_adaptive</a>,
      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;
    </li>
    <li>
      <a href = "fem1d_bvp_linear/fem1d_bvp_linear.html">
      fem1d_bvp_linear</a>,
      a program which
      applies the finite element method, with piecewise linear elements,
      to a two point boundary value problem in one spatial dimension,
      and compares the computed and exact solutions 
      with the L2 and seminorm errors.
    </li>
    <li>
      <a href = "fem1d_display/fem1d_display.html">
      fem1d_display</a>,
      a program which
      reads three files defining a 1D arbitrary degree finite element function,
      and displays a plot.
    </li>
    <li>
      <a href = "fem1d_function_10_display/fem1d_function_10_display.html">
      fem1d_function_10_display</a>,
      a program which
      reads three files defining a 1D piecewise linear finite element function
      and displays a plot.
    </li>
    <li>
      <a href = "fem1d_heat_steady/fem1d_heat_steady.html">
      fem1d_heat_steady</a>,
      a program which
      implements the finite element method for the steady
      (time independent) 1D heat equation;
    </li>
    <li>
      <a href = "fem1d_nonlinear/fem1d_nonlinear.html">
      fem1d_nonlinear</a>,
      a program which
      applies the finite element method,
      with piecewise linear basis functions, to a nonlinear
      two point boundary value problem in 1D;
    </li>
    <li>
      <a href = "fem1d_pack/fem1d_pack.html">
      fem1d_pack</a>,
      a library which
      contains utilities for 1D finite element calculations.
    </li>
    <li>
      <a href = "fem1d_pmethod/fem1d_pmethod.html">
      fem1d_pmethod</a>,
      a program which
      applies the p-method version of
      the finite element method to a linear
      two point boundary value problem in 1D;
    </li>
    <li>
      <a href = "fem1d_project/fem1d_project.html">
      fem1d_project</a>,
      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.
    </li>
    <li>
      <a href = "fem1d_sample/fem1d_sample.html">
      fem1d_sample</a>,
      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.
    </li>
    <li>
      <a href = "fem1d_spectral_numeric/fem1d_spectral_numeric.html">
      fem1d_spectral_numeric</a>,
      a program which
      applies the spectral finite element method to solve the problem
      u'' = - pi^2 sin(x) over [-1,+1] with zero boundary conditions,
      using as basis elements the functions x^n*(x-1)*(x+1),
      and carrying out the integration numerically, using MATLAB's quad() function,
      by Miro Stoyanov.
    </li>
    <li>
      <a href = "fem1d_spectral_symbolic/fem1d_spectral_symbolic.html">
      fem1d_spectral_symbolic</a>,
      a program which
      applies the spectral finite element method to solve the problem
      u'' = - pi^2 sin(x) over [-1,+1] with zero boundary conditions,
      using as basis elements the functions x^n*(x-1)*(x+1),
      and carrying out the integration using MATLAB's symbolic toolbox,
      by Miro Stoyanov.
    </li>
    <li>
      <a href = "fem2d_heat/fem2d_heat.html">
      fem2d_heat</a>,
      a program which
      applies the finite element method to the time dependent
      heat equation on an arbitrary triangulated region in 2D;
    </li>
    <li>
      <a href = "fem2d_heat_rectangle/fem2d_heat_rectangle.html">
      fem2d_heat_rectangle</a>,
      a program which
      applies the finite element method for the time-dependent
      heat equation on a triangulated square in 2D;
    </li>
    <li>
      <a href = "fem2d_heat_rectangle_steady_spmd/fem2d_heat_rectangle_steady_spmd.html">
      fem2d_heat_rectangle_steady_spmd</a>,
      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.
    </li>
    <li>
      <a href = "fem2d_heat_sparse/fem2d_heat_sparse.html">
      fem2d_heat_sparse</a>,
      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;
    </li>
    <li>
      <a href = "fem2d_heat_sparse_square/fem2d_heat_sparse_square.html">
      fem2d_heat_sparse_square</a>,
      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.
    </li>
    <li>
      <a href = "fem2d_heat_square/fem2d_heat_square.html">
      fem2d_heat_square</a>,
      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.
    </li>
    <li>
      <a href = "fem2d_navier_stokes/fem2d_navier_stokes.html">
      fem2d_navier_stokes</a>,
      a program which
      applies the finite element method to the
      steady incompressible Navier Stokes equations
      on an arbitrary triangulated region in 2D;
    </li>
    <li>
      <a href = "fem2d_navier_stokes_cavity/fem2d_navier_stokes_cavity.html">
      fem2d_navier_stokes_cavity</a>,
      a library which
      contains the user-supplied routines necessary to run
      fem2d_navier_stokes on the cavity problem.
    </li>
    <li>
      <a href = "fem2d_navier_stokes_channel/fem2d_navier_stokes_channel.html">
      fem2d_navier_stokes_channel</a>,
      a library which
      contains the user-supplied routines necessary to run
      fem2d_navier_stokes on the channel problem.
    </li>
    <li>
      <a href = "fem2d_navier_stokes_sparse/fem2d_navier_stokes_sparse.html">
      fem2d_navier_stokes_sparse</a>,
      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;
    </li>
    <li>
      <a href = "fem2d_navier_stokes_sparse_big_cavity/fem2d_navier_stokes_sparse_big_cavity.html">
      fem2d_navier_stokes_sparse_big_cavity</a>,
      a library which
      contains the user-supplied routines necessary to run
      fem2d_navier_stokes on the big cavity problem.
    </li>
    <li>
      <a href = "fem2d_navier_stokes_sparse_cavity/fem2d_navier_stokes_sparse_cavity.html">
      fem2d_navier_stokes_sparse_cavity</a>,
      a library which
      contains the user-supplied routines necessary to run
      fem2d_navier_stokes on the cavity problem.
    </li>
    <li>
      <a href = "fem2d_navier_stokes_sparse_channel/fem2d_navier_stokes_sparse_channel.html">
      fem2d_navier_stokes_sparse_channel</a>,
      a library which
      contains the user-supplied routines necessary to run
      fem2d_navier_stokes on the channel problem.
    </li>
    <li>
      <a href = "fem2d_navier_stokes_sparse_inout/fem2d_navier_stokes_sparse_inout.html">
      fem2d_navier_stokes_sparse_inout</a>,
      a library which
      contains the user-supplied routines necessary to run
      fem2d_navier_stokes on the inout problem.
    </li>
    <li>
      <a href = "fem2d_pack/fem2d_pack.html">
      fem2d_pack</a>,
      a library which
      performs simple 2D finite element computations;
    </li>
    <li>
      <a href = "fem2d_poisson/fem2d_poisson.html">
      fem2d_poisson</a>,
      a program which
      applies the finite element method to Poisson's equation
      on an arbitrary triangulated region in 2D;
    </li>
    <li>
      <a href = "fem2d_poisson_ell/fem2d_poisson_ell.html">
      fem2d_poisson_ell</a>,
      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.
    </li>
    <li>
      <a href = "fem2d_poisson_lake/fem2d_poisson_lake.html">
      fem2d_poisson_lake</a>,
      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.
    </li>
    <li>
      <a href = "fem2d_poisson_rectangle/fem2d_poisson_rectangle.html">
      fem2d_poisson_rectangle</a>,
      a program which
      solves the 2D Poisson equation on a rectangle, using the finite element method,
      and piecewise quadratic triangular elements.
    </li>
    <li>
      <a href = "fem2d_poisson_rectangle_linear/fem2d_poisson_rectangle_linear.html">
      fem2d_poisson_rectangle_linear</a>,
      a program which
      solves the 2D Poisson equation on a rectangle, using the finite element method,
      and piecewise linear triangular elements.
    </li>
    <li>
      <a href = "fem2d_poisson_sparse/fem2d_poisson_sparse.html">
      fem2d_poisson_sparse</a>,
      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.)
    </li>
    <li>
      <a href = "fem2d_project/fem2d_project.html">
      fem2d_project</a>,
      a program which
      projects a function f(x,y), given as data, into a given finite element space
      of piecewise linear triangular elements.
    </li>
    <li>
      <a href = "fem2d_project_function/fem2d_project_function.html">
      fem2d_project_function</a>,
      a program which
      projects a function f(x,y), given as a formula, into a given finite element space
      of piecewise linear triangular elements.
    </li>
    <li>
      <a href = "fem2d_sample/fem2d_sample.html">
      fem2d_sample</a>,
      a program which
      samples a finite element
      function, defined by FEM files,
      (three text files describing the nodes, triangles, and coefficients);
      at arbitrary points.
    </li>
    <li>
      <a href = "fem2d_stokes/fem2d_stokes.html">
      fem2d_stokes</a>,
      a program which
      applies the finite element method for the
      steady incompressible Stokes equations
      on an arbitrary triangulated region in 2D;
    </li>
    <li>
      <a href = "fem2d_stokes_cavity/fem2d_stokes_cavity.html">
      fem2d_stokes_cavity</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes
      on the cavity problem.
    </li>
    <li>
      <a href = "fem2d_stokes_channel/fem2d_stokes_channel.html">
      fem2d_stokes_channel</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes
      on the channel problem.
    </li>
    <li>
      <a href = "fem2d_stokes_inout/fem2d_stokes_inout.html">
      fem2d_stokes_inout</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes
      on the inout problem.
    </li>
    <li>
      <a href = "fem2d_stokes_sparse/fem2d_stokes_sparse.html">
      fem2d_stokes_sparse</a>,
      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;
    </li>
    <li>
      <a href = "fem2d_stokes_sparse_big_cavity/fem2d_stokes_sparse_big_cavity.html">
      fem2d_stokes_sparse_big_cavity</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes_sparse
      on the big cavity problem.
    </li>
    <li>
      <a href = "fem2d_stokes_sparse_cavity/fem2d_stokes_sparse_cavity.html">
      fem2d_stokes_sparse_cavity</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes_sparse
      on the cavity problem.
    </li>
    <li>
      <a href = "fem2d_stokes_sparse_channel/fem2d_stokes_sparse_channel.html">
      fem2d_stokes_sparse_channel</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes_sparse
      on the channel problem.
    </li>
    <li>
      <a href = "fem2d_stokes_sparse_inout/fem2d_stokes_sparse_inout.html">
      fem2d_stokes_sparse_inout</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes_sparse
      on the inout problem.
    </li>
    <li>
      <a href = "fem2d_stokes_sparse_spiral/fem2d_stokes_sparse_spiral.html">
      fem2d_stokes_sparse_spiral</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes_sparse
      on the spiral problem.
    </li>
    <li>
      <a href = "fem2d_stokes_spiral/fem2d_stokes_spiral.html">
      fem2d_stokes_spiral</a>,
      a library which
      contains the user-supplied routines necessary to run fem2d_stokes
      on the spiral problem.
    </li>
    <li>
      <a href = "fem3d_pack/fem3d_pack.html">
      fem3d_pack</a>,
      a library which
      contains utilities for 3D finite element calculations.
    </li>
    <li>
      <a href = "fem3d_project/fem3d_project.html">
      fem3d_project</a>,
      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.
    </li>
    <li>
      <a href = "fem3d_sample/fem3d_sample.html">
      fem3d_sample</a>,
      a program library which
      evaluates a finite element function defined on a 3D tetrahedral mesh.
    </li>
    <li>
      <a href = "fern/fern.html">
      fern</a>,
      a program which
      uses MATLAB graphics to display the Barnsley fractal fern.
    </li>
    <li>
      <a href = "feynman_kac_1d/feynman_kac_1d.html">
      feynman_kac_1d</a>,
      a program which
      demonstrates the use of the Feynman-Kac algorithm 
      to solve Poisson's equation in a 1D interval by averaging
      stochastic paths to the boundary.
    </li>
    <li>
      <a href = "feynman_kac_2d/feynman_kac_2d.html">
      feynman_kac_2d</a>,
      a program which
      demonstrates the use of the Feynman-Kac algorithm 
      to solve Poisson's equation in a 2D ellipse by averaging
      stochastic paths to the boundary.
    </li>
    <li>
      <a href = "feynman_kac_3d/feynman_kac_3d.html">
      feynman_kac_3d</a>,
      a program which
      demonstrates the use of the Feynman-Kac algorithm 
      to solve Poisson's equation in a 3D ellipsoid by averaging
      stochastic paths to the boundary.
    </li>
    <li>
      <a href = "fft_serial/fft_serial.html">
      fft_serial</a>,
      a program which
      computes a Fast Fourier Transform (FFT), and is intended as
      a starting point for implementing a parallel version.
    </li>
    <li>
      <a href = "fibonacci_spiral/fibonacci_spiral.html">
      fibonacci_spiral</a>,
      a program which
      displays points on a Fibonacci spiral, suggesting the arrangement of seeds
      in a sunflower, for instance.
    </li>
    <li>
      <a href = "file_increment/file_increment.html">
      file_increment</a>,
      a program which
      makes a copy of a file containing an integer array, after incrementing
      each entry by a given value.
    </li>
    <li>
      <a href = "file_name_sequence/file_name_sequence.html">
      file_name_sequence</a>,
      a program which
      demonstrates ways to generate a sequence of filenames, which can
      be useful when generating a sequence of still snapshots to be animated later.
    </li>
    <li>
      <a href = "files_multiple/files_multiple.html">
      files_multiple</a>,
      a program which
      demonstrates how a program can open multiple output files at one time,
      and write data to any one specific file it chooses.
    </li>
    <li>
      <a href = "filum/filum.html">
      filum</a>,
      a library which
      handles files and filenames;
    </li>
    <li>
      <a href = "floyd/floyd.html">
      floyd</a>,
      a library which
      implements Floyd's algorithm for finding the shortest distance
      between pairs of nodes on a directed graph.
    </i>
    <li>
      <a href = "fmincon/fmincon.html">
      fmincon</a>,
      programs which 
      illustrate the use of the fmincon 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.
    </li>
    <li>
      <a href = "fmincon_parallel/fmincon_parallel.html">
      fmincon_parallel</a>,
      a program which
      demonstrates the use of MATLAB's fmincon() constrained minimization
      function, taking advantage of MATLAB's Parallel Computing Toolbox
      for faster execution.
    </li>
    <li>
      <a href = "fn/fn.html">
      fn</a>,
      a library which
      evaluates elementary and special functions,
      by Wayne Fullerton.
    </li>
    <li>
      <a href = "gamblers_ruin_simulation/gamblers_ruin_simulation.html">
      gamblers_ruin_simulation</a>,
      a program which
      simulates the game of gambler's ruin.
    </li>
    <li>
      <a href = "gauss_seidel/gauss_seidel.html">
      gauss_seidel</a>,
      a program which
      implements the Gauss-Seidel iteration for linear systems.
    </li>
    <li>
      <a href = "gauss_seidel_poisson_1d/gauss_seidel_poisson_1d.html">
      gauss_seidel_poisson_1d</a>,
      a program which
      demonstrates how the linear system for a discretized version of the
      steady 1D Poisson equation can be solved by the Gauss-Seidel iteration.
    </li>
    <li>
      <a href = "gegenbauer_rule/gegenbauer_rule.html">
      gegenbauer_rule</a>,
      a program which
      computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
    </li>
    <li>
      <a href = "gen_hermite_rule/gen_hermite_rule.html">
      gen_hermite_rule</a>,
      a program which
      computes and writes out a generalized Gauss-Hermite quadrature rule of
      given order and parameter value.
    </li>
    <li>
      <a href = "gen_laguerre_rule/gen_laguerre_rule.html">
      gen_laguerre_rule</a>,
      a program which
      computes and writes out a generalized Gauss-Laguerre quadrature rule of
      given order and parameter value.
    </li>
    <li>
      <a href = "geometry/geometry.html">
      geometry</a>,
      a library which
      performs 2D/3D geometric calculations;
    </li>
    <li>
      <a href = "geompack/geompack.html">
      geompack</a>,
      a library which
      computes the Delaunay triangulation for a set of points in 2D,
      by Barry Joe.
    </li>
    <li>
      <a href = "gl_display/gl_display.html">
      gl_display</a>,
      a program which
      displays the points used in a 2D Gauss-Legendre quadrature rule;
    </li>
    <li>
      <a href = "gm_rule/gm_rule.html">
      gm_rule</a>,
      a library which
      defines Grundmann-Moeller quadratures rules for a
      triangle, tetrahedron, or M-dimensional simplex.
    </li>
    <li>
      <a href = "graph_representation/graph_representation.html">
      graph_representation</a>,
      a library which
      can express the representation of an abstract mathematical graph
      in several ways.
    </li>
    <li>
      <a href = "graphics_examples/graphics_examples.html">
      graphics_examples</a>,
      programs which
      illustrate how various kinds of data can be displayed and analyzed graphically.
    </li>
    <li>
      <a href = "grf_display/grf_display.html">
      grf_display</a>,
      a program which
      reads a GRF file defining a mathematical graph and
      displays it in the MATLAB graphics window.
    </li>
    <li>
      <a href = "grf_io/grf_io.html">
      grf_io</a>,
      a library which
      reads or writes a GRF file;
    </li>
    <li>
      <a href = "grid/grid.html">
      grid</a>,
      a library which
      computes N random points on a uniform M-dimensional grid;
    </li>
    <li>
      <a href = "grid_dataset/grid_dataset.html">
      grid_dataset</a>,
      a program which
      creates a grid dataset;
    </li>
    <li>
      <a href = "grid_display/grid_display.html">
      grid_display</a>,
      a program which
      reads a file of points on a grid or sparse grid, displays the grid and
      saves the image in a png file;
    </li>
    <li>
      <a href = "gridlines/gridlines.html">
      gridlines</a>,
      a library which
      gives the user more control over drawing gridlines on a graph
      than the built in "grid on" command.
    </li>
    <li>
      <a href = "grids_display/grids_display.html">
      grids_display</a>,
      a program which
      reads two files of grids or sparse grids, displaying the
      first with hollow blue dots, the second with solid red dots.
    </li>
    <li>
      <a href = "haar/haar.html">
      haar</a>,
      a library which
      computes the Haar transform of data.
    </li>
    <li>
      <a href = "halton/halton.html">
      halton</a>,
      a library which
      calculates the Halton M-dimensional quasirandom sequence;
    </li>
    <li>
      <a href = "halton_dataset/halton_dataset.html">
      halton_dataset</a>,
      a program which
      creates N elements of an M-dimensional Halton sequence
      and writes them to a file.
    </li>
    <li>
      <a href = "hammersley/hammersley.html">
      hammersley</a>,
      a library which
      computes the Hammersley M-dimensional quasirandom sequence;
    </li>
    <li>
      <a href = "hammersley_dataset/hammersley_dataset.html">
      hammersley_dataset</a>,
      a program which
      creates N elements of an M-dimensional Hammersley sequence
      and writes them to a file.
    </li>
    <li>
      <a href = "hand_data/hand_data.html">
      hand_data</a>,
      a set of programs which
      carry out some numerical exercises based on data that came from
      tracing several points on a person's hand.
    </li>
    <li>
      <a href = "hb_io/hb_io.html">
      hb_io</a>,
      a library which
      reads and writes files in the Harwell Boeing (HB) sparse matrix format;
    </li>
    <li>
      <a href = "hb_to_mm/hb_to_mm.html">
      hb_to_mm</a>,
      a program which
      converts a sparse matrix stored in a Harwell Boeing (HB) file
      to Matrix Market (MM) format;
    </li>
    <li>
      <a href = "hb_to_msm/hb_to_msm.html">
      hb_to_msm</a>,
      a program which
      converts a sparse matrix stored in a Harwell Boeing (HB) file
      to MATLAB sparse matrix format;
    </li>
    <li>
      <a href = "hb_to_st/hb_to_st.html">
      hb_to_st</a>,
      a program which
      reads a sparse matrix in a Harwell Boeing (HB) file and
      writes an equivalent Sparse Triplet (ST) file.
    </li>
    <li>
      <a href = "hcell_flow_display/hcell_flow_display.html">
      hcell_flow_display</a>,
      a program which
      plots the physical data, pressures or velocities, from a run of the
      hcell program;
    </li>
    <li>
      <a href = "heated_plate/heated_plate.html">
      heated_plate</a>,
      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.
    </li>
    <li>
      <a href = "heated_plate_parfor/heated_plate_parfor.html">
      heated_plate_parfor</a>,
      a program which
      solves the steady state heat equation in a 2D
      rectangular region, using MATLAB's parfor command to execute in parallel.
    </li>
    <li>
      <a href = "hello/hello.html">
      hello</a>,
      a program which
      prints out "Hello, world!".
    </li>
    <li>
      <a href = "hello_parfor/hello_parfor.html">
      hello_parfor</a>,
      a program which
      prints out "Hello, world!" multiple times, using MATLAB's parfor command
      for parallel execution.
    </li>
    <li>
      <a href = "hermite/hermite.html">
      hermite</a>,
      a library which
      computes the Hermite interpolant, a polynomial that matches function values
      and derivatives.
    </li>
    <li>
      <a href = "hermite_cubic/hermite_cubic.html">
      hermite_cubic</a>,
      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.
    </li>
    <li>
      <a href = "hermite_polynomial/hermite_polynomial.html">
      hermite_polynomial</a>,
      a library which
      evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial,
      the Hermite function, and related functions.
    </li>
    <li>
      <a href = "hermite_product_display/hermite_product_display.html">
      hermite_product_display</a>,
      a program which
      displays an image of a function created by the Cartesian product of two Hermite polynomials,
      such as f(x,y) = h(3,x) * h(1,y).
    </li>
    <li>
      <a href = "hermite_rule/hermite_rule.html">
      hermite_rule</a>,
      a program which
      computes and writes out a Gauss-Hermite quadrature rule of given order.
    </li>
    <li>
      <a href = "hex_grid/hex_grid.html">
      hex_grid</a>,
      a library which
      generates a hexagonal grid
      of points in the unit square or an arbitrary rectangle;
    </li>
    <li>
      <a href = "hex_grid_angle/hex_grid_angle.html">
      hex_grid_angle</a>,
      a library which
      defines a hexagonal grid of points in
      the unit square, with an arbitrary center, angle, and spacing.
    </li>
    <li>
      <a href = "hex_grid_dataset/hex_grid_dataset.html">
      hex_grid_dataset</a>,
      a program which
      creates a hexagonal grid of points in a rectangle, and
      write them to a file, using the hex_grid library.
    </li>
    <li>
      <a href = "high_card_parfor/high_card_parfor.html">
      high_card_parfor</a>,
      a program which
      uses the parfor statement to compute in parallel the statistics for
      a card game in which you are required to guess the location of the
      highest card.
    </li>
    <li>
      <a href = "high_card_simulation/high_card_simulation.html">
      high_card_simulation</a>,
      a program which
      simulates a situation in which you see the cards in a deck one by one,
      and must select the one you think is the highest and stop. 
    </li>
    <li>
      <a href = "histogram_display/histogram_display.html">
      histogram_display</a>,
      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;
    </li>
    <li>
      <a href = "hot_pipe/hot_pipe.html">
      hot_pipe</a>,
      a program which
      demonstrates fem_50_heat
      to solve a particular heat equation problem,
      by Jochen Alberty, Carsten Carstensen, Stefan Funken.
    </li>
    <li>
      <a href = "hot_point/hot_point.html">
      hot_point</a>,
      a program which
      demonstrates fem_50_heat
      to solve a particular heat equation problem,
      by Jochen Alberty, Carsten Carstensen, Stefan Funken.
    </li>
    <li>
      <a href = "i4lib/i4lib.html">
      i4lib</a>,
      a library which
      contains many utility routines, using single precision integer (I4)
      arithmetic.
    </li>
    <li>
      <a href = "ice_io/ice_io.html">
      ice_io</a>,
      a library which
      reads or writes ICE grid files stored in netcdf format.
    </li>
    <li>
      <a href = "ice_to_mesh/ice_to_mesh.html">
      ice_to_mesh</a>,
      a program which
      reads a NETCDF file containing an ICE dataset and rewrites the
      information as a MESH file.
    </li>
    <li>
      <a href = "ihs/ihs.html">
      ihs</a>,
      a library which
      generates the Improved Hypercube Sampling (IHS) M-dimensional quasirandom sequence;
    </li>
    <li>
      <a href = "ihs_dataset/ihs_dataset.html">
      ihs_dataset</a>,
      a program which
      creates an Improved Hypercube Sampling (IHS) dataset and writes it to a file;
    </li>
    <li>
      <a href = "image_components/image_components.html">
      image_components</a>,
      a library which
      seeks the connected nonzero or nonblack components of an image or integer array.
    </li>
    <li>
      <a href = "image_contrast/image_contrast.html">
      image_contrast</a>,
      programs which
      applies image processing techniques to increase the contrast in an image.
    </li>
    <li>
      <a href = "image_denoise/image_denoise.html">
      image_denoise</a>,
      a library which 
      applies simple filtering operations to a noisy image.
    </li>
    <li>
      <a href = "image_denoise_spmd/image_denoise_spmd.html">
      image_denoise_spmd</a>,
      a library 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.
    </li>
    <li>
      <a href = "image_diffuse/image_diffuse.html">
      image_diffuse</a>,
      a library which
      uses diffusion to smooth out an image.
    </li>
    <li>
      <a href = "image_edge/image_edge.html">
      image_edge</a>,
      a library which
      demonstrates a simple procedure for edge detection in images.
    </li>
    <li>
      <a href = "image_noise/image_noise.html">
      image_noise</a>,
      programs which
      add noise to an image.
    </li>
    <li>
      <a href = "image_quantization/image_quantization.html">
      image_quantization</a>,
      a library which
      demonstrates how the KMEANS algorithm can be used to reduce the number
      of colors or shades of gray in an image.
    </li>
    <li>
      <a href = "image_rgb_to_gray/image_rgb_to_gray.html">
      image_rgb_to_gray</a>,
      programs which
      makes a grayscale version of an RGB image.
    </li>
    <li>
      <a href = "image_threshold/image_threshold.html">
      image_threshold</a>,
      programs which
      make a black and white version of a grayscale image by setting all pixels
      below or above a threshold value to black or white.
    </li>
    <li>
      <a href = "imshow_numeric/imshow_numeric.html">
      imshow_numeric</a>,
      a program which
      accepts a numeric 2D array and displays it as a grayscale image.
    </li>
    <li>
      <a href = "index/index.html">
      index</a>,
      a library which
      converts a multidimensional vector index to a one-dimensional vector index;
      it can handle zero and one based indexing schemes, as well as column major
      and row major conventions.
    </li>
    <li>
      <a href = "inout_flow_display/inout_flow_display.html">
      inout_flow_display</a>,
      a library which
      displays a single velocity field solution for the inout cell flow;
    </li>
    <li>
      <a href = "inout_flow_movie/inout_flow_movie.html">
      inout_flow_movie</a>,
      a library which
      creates an animation of the velocity solutions for the inout cell flow;
    </li>
    <li>
      <a href = "int_exactness/int_exactness.html">
      int_exactness</a>,
      a program which
      tests the polynomial exactness of quadrature rules for a finite interval;
    </li>
    <li>
      <a href = "int_exactness_chebyshev1/int_exactness_chebyshev1.html">
      int_exactness_chebyshev1</a>,
      a program which
      tests the polynomial exactness of Gauss-Chebyshev type 1 quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_chebyshev2/int_exactness_chebyshev2.html">
      int_exactness_chebyshev2</a>,
      a program which
      tests the polynomial exactness of Gauss-Chebyshev type 2 quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_gegenbauer/int_exactness_gegenbauer.html">
      int_exactness_gegenbauer</a>,
      a program which
      tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_gen_hermite/int_exactness_gen_hermite.html">
      int_exactness_gen_hermite</a>,
      a program which
      tests the polynomial
      exactness of generalized Gauss-Hermite quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_gen_laguerre/int_exactness_gen_laguerre.html">
      int_exactness_gen_laguerre</a>,
      a program which
      tests the polynomial exactness of generalized Gauss-Laguerre
      quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_hermite/int_exactness_hermite.html">
      int_exactness_hermite</a>,
      a program which
      tests the polynomial exactness of Gauss-Hermite quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_jacobi/int_exactness_jacobi.html">
      int_exactness_jacobi</a>,
      a program which
      tests the polynomial exactness of Gauss-Jacobi quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_laguerre/int_exactness_laguerre.html">
      int_exactness_laguerre</a>,
      a program which
      tests the polynomial exactness of Gauss-Laguerre quadrature rules.
    </li>
    <li>
      <a href = "int_exactness_legendre/int_exactness_legendre.html">
      int_exactness_legendre</a>,
      a program which
      tests the polynomial exactness of Gauss-Legendre quadrature rules.
    </li>
    <li>
      <a href = "interp/interp.html">
      interp</a>,
      a library which
      can be used for parameterizing and interpolating data;
    </li>
    <li>
      <a href = "ising_2d_simulation/ising_2d_simulation.html">
      ising_2d_simulation</a>,
      a program which
      simulates the evolution of a 2D array of positive and negative charges,
      each of which is likely to flip to be in agreement with neighbors.
    </li>
    <li>
      <a href = "jacobi/jacobi.html">
      jacobi</a>,
      a program which
      implements the Jacobi iteration for linear systems.
    </li>
    <li>
      <a href = "jacobi_poisson_1d/jacobi_poisson_1d.html">
      jacobi_poisson_1d</a>,
      a program which
      demonstrates how the linear system for a discretized version of the
      steady 1D Poisson equation can be solved by the Jacobi iteration.
    </li>
    <li>
      <a href = "jacobi_polynomial/jacobi_polynomial.html">
      jacobi_polynomial</a>,
      a library which
      evaluates the Jacobi polynomial and associated functions.
    </li>
    <li>
      <a href = "jacobi_rule/jacobi_rule.html">
      jacobi_rule</a>,
      a program which
      computes and writes out a Gauss-Jacobi quadrature rule of given order.
    </li>
    <li>
      <a href = "keast/keast.html">
      keast</a>,
      a library which
      defines Keast quadrature rules in a tetrahedron;
    </li>
    <li>
      <a href = "kelley/kelley.html">
      kelley</a>,
      a library which
      implements iterative methods for linear
      and nonlinear equations, by Tim Kelley;
    </li>
    <li>
      <a href = "kmeans/kmeans.html">
      kmeans</a>,
      a library which
      handles the K-Means problem,
      which organizes a set of N points in M dimensions into K clusters;
    </li>
    <li>
      <a href = "kronrod/kronrod.html">
      kronrod</a>,
      a library which
      can compute a Gauss and Gauss-Kronrod pair of quadrature rules
      of arbitrary order,
      by Robert Piessens, Maria Branders.
    </li>
    <li>
      <a href = "lagrange_approx_1d/lagrange_approx_1d.html">
      lagrange_approx_1d</a>,
      a library which
      defines and evaluates the Lagrange polynomial p(x) of degree m
      which approximates a set of nd data points (x(i),y(i)).
    </li>
    <li>
      <a href = "lagrange_basis_display/lagrange_basis_display.html">
      lagrange_basis_display</a>,
      a library which
      displays the basis functions associated with a given set of nodes used
      with the Lagrange interpolation scheme.
    </li>
    <li>
      <a href = "lagrange_interp_1d/lagrange_interp_1d.html">
      lagrange_interp_1d</a>,
      a library which
      defines and evaluates the Lagrange polynomial p(x) 
      which interpolates a set of data depending on a 1D argument,
      so that p(x(i)) = y(i).
    </li>
    <li>
      <a href = "lagrange_interp_2d/lagrange_interp_2d.html">
      lagrange_interp_2d</a>,
      a library which
      defines and evaluates the Lagrange polynomial p(x,y) 
      which interpolates a set of data depending on a 2D argument
      that was evaluated on a product grid,
      so that p(x(i),y(j)) = z(i,j).
    </li>
    <li>
      <a href = "lagrange_interp_nd/lagrange_interp_nd.html">
      lagrange_interp_nd</a>,
      a library which
      defines and evaluates the Lagrange polynomial p(x) 
      which interpolates a set of data depending on a multidimensional argument
      that was evaluated on a product grid,
      so that p(x(i)) = z(i).
    </li>
    <li>
     <a href = "laguerre_polynomial/laguerre_polynomial.html">
      laguerre_polynomial</a>,
      a library which
      evaluates the Laguerre polynomial, the generalized Laguerre polynomials,
      and the Laguerre function.
    </li>
    <li>
      <a href = "laguerre_rule/laguerre_rule.html">
      laguerre_rule</a>,
      a program which
      computes and writes out a Gauss-Laguerre quadrature rule of given order.
    </li>
    <li>
      <a href = "latin_center/latin_center.html">
      latin_center</a>,
      a library which
      computes N points in an M-dimensional Latin Center square;
    </li>
    <li>
      <a href = "latin_center_dataset/latin_center_dataset.html">
      latin_center_dataset</a>,
      a program which
      creates a Latin Center Hypercube dataset;
    </li>
    <li>
      <a href = "latin_cover/latin_cover.html">
      latin_cover</a>,
      a library which
      produces N Latin squares which cover an NxN square, or NxN Latin cubes
      which cover an NxNxN cube.
    </li>
    <li>
      <a href = "latin_edge/latin_edge.html">
      latin_edge</a>,
      a library which
      returns N points in an M-dimensional Latin Edge square;
    </li>
    <li>
      <a href = "latin_edge_dataset/latin_edge_dataset.html">
      latin_edge_dataset</a>,
      a program which
      creates an N-point M-dimensional Latin Edge square dataset;
    </li>
    <li>
      <a href = "latin_random/latin_random.html">
      latin_random</a>,
      a library which
      returns N points in an M-dimensional Latin Random square;
    </li>
    <li>
      <a href = "latin_random_dataset/latin_random_dataset.html">
      latin_random_dataset</a>,
      a program which
      creates a Latin Random Hypercube dataset;
    </li>
    <li>
      <a href = "latinize/latinize.html">
      latinize</a>,
      a program which
      adjusts N points in M dimensions to form a Latin hypercube;
    </li>
    <li>
      <a href = "lattice_rule/lattice_rule.html">
      lattice_rule</a>,
      a library which
      returns lattice rules for M-dimensional integration;
    </li>
    <li>
      <a href = "lcvt/lcvt.html">
      lcvt</a>,
      a library which
      makes a sort of Latinized Centroidal Voronoi Tessellation (CVT);
    </li>
    <li>
      <a href = "lcvt_dataset/lcvt_dataset.html">
      lcvt_dataset</a>,
      a program which
      creates a Latinized Centroidal Voronoi Tessellation (CVT) dataset;
    </li>
    <li>
      <a href = "legendre_polynomial/legendre_polynomial.html">
      legendre_polynomial</a>,
      a library which
      evaluates the Legendre polynomial and associated functions.
    </li>
    <li>
      <a href = "legendre_rule/legendre_rule.html">
      legendre_rule</a>,
      a program which
      writes out a Gauss-Legendre quadrature rule of given order.
    </li>
    <li>
      <a href = "legendre_rule_fast/legendre_rule_fast.html">
      legendre_rule_fast</a>,
      a program which
      uses a fast (order N) algorithm to compute a Gauss-Legendre
      quadrature rule of given order.
    </li>
    <li>
      <a href = "lemke/lemke.html">
      lemke</a>,
      a library which
      implements Lemke's algorithm for the linear complementarity problem,
      by Paul Fackler and Mario Miranda.
    </li>
    <li>
      <a href = "levels/levels.html">
      levels</a>,
      a library which
      makes a contour plot, choosing the contour levels using random sampling.
    </li>
    <li>
      <a href = "linear_solve_distributed/linear_solve_distributed.html">
      linear_solve_distributed</a>,
      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.
    </li>
    <li>
      <a href = "linpack/linpack.html">
      linpack</a>,
      a library which
      solves linear systems for a variety of matrix storage schemes,
      real or complex arithmetic, and single or double precision.
      The original version of this library is 
      by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
    </li>
    <li>
      <a href = "linpack_bench/linpack_bench.html">
      linpack_bench</a>,
      a program which
      is the linpack benchmark;
    </li>
    <li>
      <a href = "linpack_bench_backslash/linpack_bench_backslash.html">
      linpack_bench_backslash</a>,
      a program which
      is the linpack benchmark, using MATLAB's built-in backslash operator;
    </li>
    <li>
      <a href = "linpack_c/linpack_c.html">
      linpack_c</a>,
      a library which
      constitutes a linear algebra library
      for single precision complex arithmetic;
      it includes a function to compute the singular value decomposition (SVD)
      of a rectangular matrix.
      The original version of this library is 
      by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
    </li>
    <li>
      <a href = "linpack_d/linpack_d.html">
      linpack_d</a>,
      a library which
      constitutes a linear algebra library
      for double precision real arithmetic;
      it includes a function to compute the singular value decomposition (SVD)
      of a rectangular matrix.
      The original version of this library is 
      by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
    </li>
    <li>
      <a href = "linpack_s/linpack_s.html">
      linpack_s</a>,
      a library which
      constitutes a linear algebra library;
      for single precision real arithmetic;
      it includes a function to compute the singular value decomposition (SVD)
      of a rectangular matrix.
      The original version of this library is 
      by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
    </li>
    <li>
      <a href = "linpack_z/linpack_z.html">
      linpack_z</a>,
      a library which
      constitutes a linear algebra library
      for double precision complex arithmetic;
      it includes a function to compute the singular value decomposition (SVD)
      of a rectangular matrix.
      The original version of this library is 
      by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
    </li>
    <li>
      <a href = "linplus/linplus.html">
      linplus</a>,
      a library which
      factors/solves/multiplies matrices in a variety of formats;
    </li>
    <li>
      <a href = "llsq/llsq.html">
      llsq</a>,
      a library which
      solves the simple linear least squares problem of finding the formula
      of a straight line y=a*x+b which minimizes the root-mean-square error
      to a set of N data points.
    </li>
    <li>
      <a href = "lorenz_simulation/lorenz_simulation.html">
      lorenz_simulation</a>,
      a program which
      computes and displays solutions of the Lorenz equations
      for various initial conditions.
    </li>
    <li>
      <a href = "lyness_rule/lyness_rule.html">
      lyness_rule</a>,
      a library which
      returns Lyness-Jespersen quadrature rules for the triangle.
    </li>
    <li>
      <a href = "lyrics_remote/lyrics_remote.html">
      lyrics_remote</a>,
      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.
    </li>
    <li>
      <a href = "machar/machar.html">
      machar</a>,
      a library which
      dynamically computes the values of various machine characteristic constants,
      by William Cody;
    </li>
    <li>
      <a href = "machine/machine.html">
      machine</a>,
      a library which
      returns tabulated values of
      the constants associated with computer arithmetic;
    </li>
    <li>
      <a href = "mandelbrot/mandelbrot.html">
      mandelbrot</a>,
      a program which
      generates an image of the Mandelbrot set;
    </li>
    <li>
      <a href = "../classes/math2070_1999/math2070_1999.html">
      math2070_1999</a>,
      programs which
      were used for a numerical analysis laboratory class.
    </li>
    <li>
      <a href = "../classes/math2071_2000/math2071_2000.html">
      math2071_2000</a>,
      programs which
      were used for a numerical analysis laboratory class.
    </li>
    <li>
      <a href = "matlab/matlab.html">
      matlab</a>,
      programs which
      illustrate the use of MATLAB scripts and M-files;
    </li>
    <li>
      <a href = "matlab_calls_c/matlab_calls_c.html">
      matlab_calls_c</a>,
      programs which
      illustrate how C functions can be written, compiled, and
      called from MATLAB using the mex facility;
    </li>
    <li>
      <a href = "matlab_calls_f77/matlab_calls_f77.html">
      matlab_calls_f77</a>,
      programs which
      illustrate how FORTRAN77 functions can be written, compiled, and
      called from MATLAB using the mex facility;
    </li>
    <li>
      <a href = "matlab_commandline/matlab_commandline.html">
      matlab_commandline</a>,
      programs which
      illustrate how MATLAB can be run from the UNIX command line, that is,
      not with the usual MATLAB command window.
    </li>
    <li>
      <a href = "matlab_condor/matlab_condor.html">
      matlab_condor</a>,
      programs which
      illustrate how MATLAB can be run in batch mode using the condor
      queueing system.
    </li>
    <li>
      <a href = "matlab_distcomp/matlab_distcomp.html">
      matlab_distcomp</a>,
      a program which
      remotely runs a set of 5 jobs on Virginia Tech's ithaca cluster.
    </li>
    <li>
      <a href = "matlab_movies/matlab_movies.html">
      matlab_movies</a>,
      programs which
      illustrate making movies using MATLAB;
    </li>
    <li>
      <a href = "matlab_os/matlab_os.html">
      matlab_os</a>,
      programs which
      illustrate how the system command can be used to allow MATLAB
      to issue commands to the computer operating system (UNIX or DOS);
    </li>
    <li>
      <a href = "matlab_parallel/matlab_parallel.html">
      matlab_parallel</a>,
      programs which
      illustrate local parallel programming on a single computer
      with MATLAB's Parallel Computing Toolbox.
    </li>
    <li>
      <a href = "matlab_random/matlab_random.html">
      matlab_random</a>,
      programs which
      illustrate the use of Matlab's random number generator routines.
    </li>
    <li>
      <a href = "matlab_remote/matlab_remote.html">
      matlab_remote</a>,
      programs 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.
    </li>
    <li>
      <a href = "matlab_return/matlab_return.html">
      matlab_return</a>,
      programs which
      illustrate that explicitly invoking the return statment
      can be surprisingly costly;
    </li>
    <li>
      <a href = "matrix_assemble_parfor/matrix_assemble_parfor.html">
      matrix_assemble_parfor</a>,
      a program which
      demonstrates the parfor parallel programming feature by assembling the
      Hilbert matrix in a parallel loop.
    </li>
    <li>
      <a href = "matrix_assemble_spmd/matrix_assemble_spmd.html">
      matrix_assemble_spmd</a>,
      a program which
      demonstrates the spmd parallel programming feature by having each worker
      assemble part of the Hilbert matrix, which is then combined into one
      array by the client program.
    </li>
    <li>
      <a href = "matrix_exponential/matrix_exponential.html">
      matrix_exponential</a>,
      a library which
      demonstrates some simple approaches to the problem of computing the
      exponential of a matrix.
    </li>
    <li>
      <a href = "md/md.html">
      md</a>,
      a program which
      carries out a molecular dynamics simulation, and is intended as
      a starting point for implementing a parallel version.
    </li>
    <li>
      <a href = "md_parfor/md_parfor.html">
      md_parfor</a>,
      a program which
      carries out a molecular dynamics simulation; it runs in parallel
      using MATLAB's parfor facility.
    </li>
    <li>
      <a href = "memory_test/memory_test.html">
      memory_test</a>,
      a program which
      tests the memory available on the computer by declaring
      and using big vectors.
    </li>
    <li>
      <a href = "mesh_bandwidth/mesh_bandwidth.html">
      mesh_bandwidth</a>,
      a program which
      returns the geometric bandwidth associated with a mesh of
      elements of any order and in a space of M dimensions.
    </li>
    <li>
      <a href = "mesh_display/mesh_display.html">
      mesh_display</a>,
      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.
    </li>
    <li>
      <a href = "mesh_io/mesh_io.html">
      mesh_io</a>,
      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.
    </li>
    <li>
      <a href = "mesh_to_ice/mesh_to_ice.html">
      mesh_to_ice</a>,
      a program which
      reads the ICE dataset information from a MESH file and rewrites
      it to a netcdf file.
    </li>
    <li>
      <a href = "mesh2d/mesh2d.html">
      mesh2d</a>,
      a library which
      can automatically create a triangular mesh for a given polygonal region,
      by Darren Engwirda.
    </li>
    <li>
      <a href = "mesh2d_write/mesh2d_write.html">
      mesh2d_write</a>,
      a program which
      demonstrates how node and element data from mesh2d can be written to files.
    </li>
    <li>
      <a href = "mex/mex.html">
      mex</a>,
      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.
    </li>
    <li>
      <a href = "mgmres/mgmres.html">
      mgmres</a>,
      a library which
      applies the restarted GMRES algorithm to a sparse linear system,
      by Lili Ju;
    </li>
    <li>
      <a href = "mgs/mgs.html">
      mgs</a>,
      a library which
      is an example of legacy code, which the student is encouraged to
      study, understand, and document.  This example is due to Diane O'Leary.
    </li>
    <li>
      <a href = "mm_io/mm_io.html">
      mm_io</a>,
      a library which
      reads and writes a Matrix Market (MM) Sparse Matrix File;
    </li>
    <li>
      <a href = "mm_to_hb/mm_to_hb.html">
      mm_to_hb</a>,
      a program which
      reads a Matrix Market (MM) sparse matrix file and creates a corresponding
      Harwell Boeing (HB) sparse matrix file.
    </li>
    <li>
      <a href = "mm_to_msm/mm_to_msm.html">
      mm_to_msm</a>,
      a program which
      reads a Matrix Market (MM) sparse matrix file and creates a corresponding
      MATLAB sparse matrix data structure.
    </li>
    <li>
      <a href = "mm_to_st/mm_to_st.html">
      mm_to_st</a>,
      a program which
      reads a Matrix Market (MM) sparse matrix file and writes a corresponding
      Sparse Triplet (ST) file.
    </li>
    <li>
      <a href = "moc_display/moc_display.html">
      moc_display</a>,
      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.
    </li>
    <li>
      <a href = "mpas_grid_display/mpas_grid_display.html">
      mpas_grid_display</a>,
      programs which
      can read an MPAS netcdf grid file and display the primary polygonal
      mesh or the dual triangular mesh.
    </li>
    <li>
      <a href = "msm_to_hb/msm_to_hb.html">
      msm_to_hb</a>,
      a program which
      writes a MATLAB sparse matrix to a Harwell Boeing (HB) file;
    </li>
    <li>
      <a href = "msm_to_mm/msm_to_mm.html">
      msm_to_mm</a>,
      a program which
      writes a MATLAB sparse matrix to a Matrix Market (MM) file;
    </li>
    <li>
      <a href = "msm_to_st/msm_to_st.html">
      msm_to_st</a>,
      a program which
      writes a MATLAB sparse matrix to a Sparse Triplet (ST) file;
    </li>
    <li>
      <a href = "multigrid_poisson_1d/multigrid_poisson_1d.html">
      multigrid_poisson_1d</a>,
      a library which
      applies the multigrid method to a discretized version of the 
      1D Poisson equation.
    </li>
    <li>
      <a href = "mxm/mxm.html">
      mxm</a>,
      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.
    </li>
    <li>
      <a href = "mxv/mxv.html">
      mxv</a>,
      a program which
      compares the performance of (for i, for j) loops and (for j, for i) loops
      for computing the product of an MxN matrix A and an N vector X.
    </li>
    <li>
      <a href = "nas/nas.html">
      nas</a>,
      a program which
      runs the NASA kernel benchmark.
    </li>
    <li>
      <a href = "ncc_tetrahedron/ncc_tetrahedron.html">
      ncc_tetrahedron</a>,
      a library which
      defines Newton-Cotes closed quadrature rules in a tetrahedron;
    </li>
    <li>
      <a href = "ncc_triangle/ncc_triangle.html">
      ncc_triangle</a>,
      a library which
      defines Newton-Cotes closed quadrature rules in a triangle;
    </li>
    <li>
      <a href = "nco_tetrahedron/nco_tetrahedron.html">
      nco_tetrahedron</a>,
      a library which
      defines Newton-Cotes open quadrature rules in a tetrahedron;
    </li>
    <li>
      <a href = "nco_triangle/nco_triangle.html">
      nco_triangle</a>,
      a library which
      defines Newton-Cotes open quadrature rules in a triangle;
    </li>
    <li>
      <a href = "nearest_interp_1d/nearest_interp_1d.html">
      nearest_interp_1d</a>,
      a library which
      interpolates a set of data using a piecewise constant interpolant
      defined by the nearest neighbor criterion.
    </li>
    <li>
      <a href = "neighbors_to_metis_graph/neighbors_to_metis_graph.html">
      neighbors_to_metis_graph</a>,
      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
      on METIS.
    </li>
    <li>
      <a href = "nelder_mead/nelder_mead.html">
      nelder_mead</a>,
      a program which
      implements the Nelder-Mead algorithm for the minimization of a
      scalar function of several variables, by Jeff Borggaard.
    </li>
    <li>
      <a href = "nested_sequence_display/nested_sequence_display.html">
      nested_sequence_display</a>,
      a program which
      displays a set of nested sequences.
    </li>
    <li>
      <a href = "netcdf/netcdf.html">
      netcdf</a>,
      a directory of example programs which
      read and write netcdf files.
    </li>
    <li>
      <a href = "netcdf_gis_read/netcdf_gis_read.html">
      netcdf_gis_read</a>,
      a library which
      reads GIS data for Greenland stored as a netcdf file.
    </li>
    <li>
      <a href = "netcdf_glimmer/netcdf_glimmer.html">
      netcdf_glimmer</a>,
      programs which
      read and write GLIMMER grid and solution data stored as a netcdf file.
    </li>
    <li>
      <a href = "netcdf_mpas/netcdf_mpas.html">
      netcdf_mpas</a>,
      a library which
      reads MPAS grid data stored as a netcdf file.
    </li>
    <li>
      <a href = "niederreiter2/niederreiter2.html">
      niederreiter2</a>,
      a library which
      computes the Niederreiter M-dimensional
      quasirandom sequence, base 2;
    </li>
    <li>
      <a href = "niederreiter2_dataset/niederreiter2_dataset.html">
      niederreiter2_dataset</a>,
      a program which
      creates a Niederreiter quasirandom dataset with base 2;
    </li>
    <li>
      <a href = "nint_exactness/nint_exactness.html">
      nint_exactness</a>,
      a program which
      demonstrates how to test the polynomial exactness
      of an M-dimensional quadrature rule
      defined over a finite rectangular product region.
    </li>
    <li>
      <a href = "nint_exactness_mixed/nint_exactness_mixed.html">
      nint_exactness_mixed</a>,
      a program which
      measures the polynomial exactness of an M-dimensional quadrature rule
      based on a mixture of 1D quadrature rule factors.
    </li>
    <li>
      <a href = "nintlib/nintlib.html">
      nintlib</a>,
      a library which
      carries out approximate integration (quadrature) in M dimensions;
    </li>
    <li>
      <a href = "normal/normal.html">
      normal</a>,
      a library which
      generates uniform pseudorandom numbers;
    </li>
    <li>
      <a href = "normal_dataset/normal_dataset.html">
      normal_dataset</a>,
      a program which
      creates a multivariate normal random dataset;
    </li>
    <li>
      <a href = "ns3d_fem/ns3d_fem.html">
      ns3d_fem</a>,
      a program which
      sets up and solves a finite element formulation of the steady
      incompressible 3D Navier Stokes equations on a user-defined geometry,
      by Jeff Borggaard.
    </li>
    <li>
      <a href = "obj_display/obj_display.html">
      obj_display</a>,
      a program which
      displays an OBJ 3D graphics file;
    </li>
    <li>
      <a href = "obj_io/obj_io.html">
      obj_io</a>,
      a library which
      reads and writes the data in an OBJ 3D graphics file;
    </li>
    <li>
      <a href = "obj_to_tri_surface/obj_to_tri_surface.html">
      obj_to_tri_surface</a>,
      a program which
      reads an OBJ 3D graphics file and extracts
      the surface mesh data as a TRI_SURFACE dataset.
    </li>
    <li>
      <a href = "ode_predator_prey/ode_predator_prey.html">
      ode_predator_prey</a>,
      a program which
      solves a time-dependent predator-prey system 
      of ordinary differential equations (ODE's) using MATLAB's ode23() function.
    </li>
    <li>
      <a href = "ode_sweep_parfor/ode_sweep_parfor.html">
      ode_sweep_parfor</a>,
      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 
      ordinary differential equations (ODE's).
    </li>
    <li>
      <a href = "ode_sweep_serial/ode_sweep_serial.html">
      ode_sweep_serial</a>,
      a program which
      computes a grid of solutions to a parameterized system of 
      ordinary differential equations (ODE's).
    </li>
    <li>
      <a href = "oned/oned.html">
      oned</a>,
      a library which
      contains functions useful for 1D finite element calculations,
      by Jeff Borggaard.
    </li>
    <li>
      <a href = "optimal_control_1d/optimal_control_1d.html">
      optimal_control_1d</a>,
      a program which
      seeks the optimal control function for
      a one dimensional system which is represented using the finite
      element formulation;
    </li>
    <li>
      <a href = "owens/owens.html">
      owens</a>,
      a library which
      evaluates Owen's T function;
    </li>
    <li>
      <a href = "partition_problem/partition_problem.html">
      partition_problem</a>,
      a library which
      seeks solutions of the partition problem, splitting a set of integers into
      two subsets with equal sum.
    </li>
    <li>
      <a href = "patterson_rule/patterson_rule.html">
      patterson_rule</a>,
      a program which
      looks up and writes out a Gauss-Patterson quadrature rule of given order.
    </li>
    <li>
      <a href = "pbma_io/pbma_io.html">
      pbma_io</a>,
      a library which
      reads or writes an ASCII Portable Bit Map (PBM) graphics file;
    </li>
    <li>
      <a href = "pce_burgers/pce_burgers.html">
      pce_burgers</a>,
      a program which
      defines and solves a version of the time-dependent viscous Burgers equation,
      with uncertain viscosity, 
      using a polynomial chaos expansion (PCE) in terms of Hermite polynomials,
      by Gianluca Iaccarino.
    </li>
    <li>
      <a href = "pce_legendre/pce_legendre.html">
      pce_legendre</a>,
      a program which
      assembles the system matrix of a 2D stochastic partial differential equation (SPDE), 
      using a polynomial chaos expansion (PCE) in terms of Legendre polynomials;
    </li>
    <li>
      <a href = "pce_ode_hermite/pce_ode_hermite.html">
      pce_ode_hermite</a>,
      a program which
      sets up a simple scalar stochastic differential equation (SDE) for exponential decay
      with an uncertain decay rate, using a polynomial chaos expansion (PCE)
      in terms of Hermite polynomials.
    </li>
    <li>
      <a href = "peak_movie/peak_movie.html">
      peak_movie</a>,
      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.
    </li>
    <li>
      <a href = "peridynamics_1d_steady/peridynamics_1d_steady.html">
      peridynamics_1d_steady</a>,
      a library which
      solves a 1D steady version of the Poisson equation, 
      using the non-local peridynamics model,
      by Marta D'Elia.
    </li>
    <li>
      <a href = "pgma_io/pgma_io.html">
      pgma_io</a>,
      a library which
      reads or writes an ASCII Portable Gray Map (PGM) image file;
    </li>
    <li>
      <a href = "piecewise_linear_product_integral/piecewise_linear_product_integral.html">
      piecewise_linear_product_integral</a>,
      a library which
      calculates the exact value of the integral of the product of two
      piecewise linear functions f(x) and g(x).
    </li>
    <li>
      <a href = "pink_noise/pink_noise.html">
      pink_noise</a>,
      a library which
      computes a pink noise signal obeying a 1/f power law.
    </li>
    <li>
      <a href = "plinth/plinth.html">
      plinth</a>,
      a library which
      carries out tasks associated with the interpolation of
      data or a function by a hierarchical set of piecewise linear functions.
    </li>
    <li>
      <a href = "plot_spmd/plot_spmd.html">
      plot_spmd</a>,
      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.
    </li>
    <li>
      <a href = "ply_display/ply_display.html">
      ply_display</a>,
      a program which
      displays a 3D PLY graphics file;
    </li>
    <li>
      <a href = "ply_io/ply_io.html">
      ply_io</a>,
      a library which
      reads or writes a PLY file.
    </li>
    <li>
      <a href = "ply_to_tri_surface/ply_to_tri_surface.html">
      ply_to_tri_surface</a>,
      a program which
      reads a PLY file and extracts
      the surface mesh data as a TRI_SURFACE dataset.
    </li>
    <li>
      <a href = "points_01_plot/points_01_plot.html">
      points_01_plot</a>,
      a program which
      reads an ASCII file containing points
      in the unit square, and makes an Encapsulated PostScript (EPS) image;
    </li>
    <li>
      <a href = "point_merge/point_merge.html">
      point_merge</a>,
      a library which
      considers N points in M-dimensional space, and counts or indexes
      the unique or tolerably unique items.
    </li>
    <li>
      <a href = "poisson_serial/poisson_serial.html">
      poisson_serial</a>,
      a program which
      computes an approximate solution to the Poisson equation in a rectangle,
      and is intended as the starting point for the creation of a parallel version.
    </li>
    <li>
      <a href = "poisson_simulation/poisson_simulation.html">
      poisson_simulation</a>,
      a library which
      simulates a Poisson process in which events randomly occur with an
      average waiting time of Lambda.
    </li>
    <li>
      <a href = "polpak/polpak.html">
      polpak</a>,
      a library which
      evaluates a variety of mathematical functions, including
      Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials,
      and the Collatz sequence.
    </li>
    <li>
      <a href = "polygon_moments/polygon_moments.html">
      polygon_moments</a>,
      a library which
      computes arbitrary moments of a polygon.
    </li>
    <li>
      <a href = "polygonal_surface_display/polygonal_surface_display.html">
      polygonal_surface_display</a>,
      a program which
      displays a surface in 3D described as a set of polygons;
    </li>
    <li>
      <a href = "power_method/power_method.html">
      power_method</a>,
      a library which
      carries out the power method for finding a dominant eigenvalue
      and its eigenvector.
    </li>
    <li>
      <a href = "power_rule/power_rule.html">
      power_rule</a>,
      a program which
      constructs a power rule, that is, a product quadrature rule 
      from identical 1D factor rules.
    </li>
    <li>
      <a href = "pplane8/pplane8.html">
      pplane8</a>,
      a program which
      interactively displays the phase plane of a differential equation,
      by John Polking.
    </li>
    <li>
      <a href = "ppma_io/ppma_io.html">
      ppma_io</a>,
      a library which
      reads or writes an ASCII Portable Pixel Map (PPM) image file;
    </li>
    <li>
      <a href = "prime_parfor/prime_parfor.html">
      prime_parfor</a>,
      a program which
      counts the number of primes between 1 and N; it runs in parallel
      using MATLAB's parfor facility.
    </li>
    <li>
      <a href = "prime_plot/prime_plot.html">
      prime_plot</a>
      a program which 
      displays a box plot of the prime and composite numbers.
    </li>
    <li>
      <a href = "prime_serial/prime_serial.html">
      prime_serial</a>,
      a program which
      counts the number of primes between 1 and N,
      and is intended as a starting point for a parallel version.
    </li>
    <li>
      <a href = "prime_spmd/prime_spmd.html">
      prime_spmd</a>,
      a program which
      counts the number of primes between 1 and N;
      running in parallel using MATLAB's spmd feature.
    </li>
    <li>
      <a href = "prob/prob.html">
      prob</a>,
      a library which
      evaluates and samples various probability density functions;
    </li>
    <li>
      <a href = "product_rule/product_rule.html">
      product_rule</a>,
      a program which
      creates an M-dimensional quadrature rule
      from a product of distinct 1d quadrature rules;
    </li>
    <li>
      <a href = "profile/profile.html">
      profile</a>,
      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.
    </li>
    <li>
      <a href = "puzzles/puzzles.html">
      puzzles</a>,
      executable programs which
      solve simple puzzles;
    </li>
    <li>
      <a href = "pwl_approx_1d/pwl_approx_1d.html">
      pwl_approx_1d</a>,
      a library which
      approximates a set of data using a piecewise linear function.
    </li>
    <li>
      <a href = "pwl_interp_1d/pwl_interp_1d.html">
      pwl_interp_1d</a>,
      a library which
      interpolates a set of data using a piecewise linear function.
    </li>
    <li>
     <a href = "pwl_interp_2d/pwl_interp_2d.html">
      pwl_interp_2d</a>,
      a library which
      evaluates a piecewise linear interpolant to data defined on
      a regular 2D grid.
    </li>
    <li>
      <a href = "pwl_interp_2d_scattered/pwl_interp_2d_scattered.html">
      pwl_interp_2d_scattered</a>,
      a library which
      evaluates a piecewise linear interpolant to data which is available
      at an irregularly arranged set of points.
    </li>
    <li>
      <a href = "pyramid_exactness/pyramid_exactness.html">
      pyramid_exactness</a>,
      a program which
      investigates the polynomial exactness of a quadrature rule for the pyramid.
    </li>
    <li>
      <a href = "pyramid_rule/pyramid_rule.html">
      pyramid_rule</a>,
      a program which
      computes a quadrature rule for a pyramid.
    </li>
    <li>
      <a href = "quad_mesh/quad_mesh.html">
      quad_mesh</a>,
      a library which
      handles meshes of quadrilaterals over a 2D region;
    </li>
    <li>
      <a href = "quad_mesh_rcm/quad_mesh_rcm.html">
      quad_mesh_rcm</a>,
      a program which
      computes the Reverse Cuthill-McKee (RCM) reordering for nodes in a mesh
      of 4-node quadrilaterals.
    </li>
    <li>
      <a href = "quad_parfor/quad_parfor.html">
      quad_parfor</a>,
      a program which
      estimates an integral using quadrature;
      running in parallel using MATLAB's parfor feature.
    </li>
    <li>
      <a href = "quad_serial/quad_serial.html">
      quad_serial</a>,
      a program which
      applies a quadrature rule to estimate an integral,
      intended as a starting point for parallelization exercises.
    </li>
    <li>
      <a href = "quad_spmd/quad_spmd.html">
      quad_spmd</a>,
      a program which
      estimates an integral using quadrature;
      running in parallel using MATLAB's spmd feature.
    </li>
    <li>
      <a href = "quad_surface_display/quad_surface_display.html">
      quad_surface_display</a>,
      a program which
      plots piecewise bilinear data associated with a quad_surface, that
      is, a 3D surface defined by a quadrilateral mesh;
    </li>
    <li>
      <a href = "quad_tasks/quad_tasks.html">
      quad_tasks</a>,
      a program which
      estimates an integral using quadrature;
      running in parallel using MATLAB's task feature.
    </li>
    <li>
      <a href = "quad2d_serial/quad2d_serial.html">
      quad2d_serial</a>,
      a program which
      applies a product quadrature rule to estimate an integral over a 2D rectangle,
      intended as a starting point for parallelization exercises.
    </li>
    <li>
      <a href = "quadrature_test/quadrature_test.html">
      quadrature_test</a>,
      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.
    </li>
    <li>
      <a href = "quadrature_test_2d/quadrature_test_2d.html">
      quadrature_test_2d</a>,
      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.
    </li>
    <li>
      <a href = "quadrule/quadrule.html">
      quadrule</a>,
      a library which
      defines quadrature rules for approximating an integral;
    </li>
    <li>
      <a href = "quadrule_fast/quadrule_fast.html">
      quadrule_fast</a>,
      a library which
      rapidly defines certain quadrature rules for approximating an integral;
    </li>
    <li>
      <a href = "quality/quality.html">
      quality</a>,
      a library which
      measures the dispersion of pointsets in M dimensions;
    </li>
    <li>
      <a href = "r8lib/r8lib.html">
      r8lib</a>,
      a library which
      contains many utility routines, using
      double precision real (R8) arithmetic.
    </li>
    <li>
      <a href = "randlc/randlc.html">
      randlc</a>,
      a library which
      generates a sequence of pseudorandom numbers,
      used by the NAS Benchmark programs.
    </li>
    <li>
      <a href = "random_data/random_data.html">
      random_data</a>,
      a library which
      generates sample points for various
      probability density functions, geometries, and dimensions;
    </li>
    <li>
      <a href = "random_walk_1d_simulation/random_walk_1d_simulation.html">
      random_walk_1d_simulation</a>,
      a program which
      simulates a random walk in a 1-dimensional region.
    </li>
    <li>
      <a href = "random_walk_2d_avoid_simulation/random_walk_2d_avoid_simulation.html">
      random_walk_2d_avoid_simulation</a>,
      a program which
      simulates a self-avoiding random walk in a 2-dimensional region.
    </li>
    <li>
      <a href = "random_walk_2d_avoid_tasks/random_walk_2d_avoid_tasks.html">
      random_walk_2d_avoid_tasks</a>,
      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.
    </li>
    <li>
      <a href = "random_walk_2d_simulation/random_walk_2d_simulation.html">
      random_walk_2d_simulation</a>,
      a program which
      simulates a random walk in a 2-dimensional region.
    </li>
    <li>
      <a href = "random_walk_3d_simulation/random_walk_3d_simulation.html">
      random_walk_3d_simulation</a>,
      a program which
      simulates a random walk in a 3-dimensional region.
    </li>
    <li>
      <a href = "rbf_interp_1d/rbf_interp_1d.html">
      rbf_interp_1d</a>,
      a library which
      defines and evaluates radial basis function (RBF) interpolants to 1D data.
    </li>
    <li>
      <a href = "rbf_interp_2d/rbf_interp_2d.html">
      rbf_interp_2d</a>,
      a library which
      defines and evaluates radial basis function (RBF) interpolants to 2D data.
    </li>
    <li>
      <a href = "rbf_interp_nd/rbf_interp_nd.html">
      rbf_interp_nd</a>,
      a library which
      defines and evaluates radial basis function (RBF) interpolants to multidimensional data.
    </li>
    <li>
      <a href = "rcm/rcm.html">
      rcm</a>,
      a library which
      applies the Reverse Cuthill McKee (RCM) algorithm for
      reordering the nodes of a graph, and reducing the bandwidth of a
      corresponding sparse matrix;
    </li>
    <li>
      <a href = "reactor_simulation/reactor_simulation.html">
      reactor simulation</a>,
      a program which
      is a simple Monte Carlo simulation of the shielding effect of a slab
      of a certain thickness in front of a neutron source.  This program was
      provided as an example with the book "Numerical Methods and Software."
    </li>
    <li>
      <a href = "rk4/rk4.html">
      rk4</a>,
      a library which
      applies the fourth order Runge-Kutta (RK) algorithm to estimate the
      solution of an ordinary differential equation (ODE) at the next time step.
    </li>
    <li>
      <a href = "rkf45/rkf45.html">
      rkf45</a>,
      a library which
      applies a Runge-Kutta-Fehlberg (RKF) solver to a system of 
      ordinary differential equations (ODE's);
    </li>
    <li>
      <a href = "sammon_data/sammon_data.html">
      sammon_data</a>,
      a program which
      generates six examples of M-dimensional datasets for cluster analysis.
    </li>
    <li>
      <a href = "sandia_cubature/sandia_cubature.html">
      sandia_cubature</a>,
      a library which
      implements quadrature rules for certain M-dimensional regions
      and weight functions.
    </li>
    <li>
      <a href = "sandia_rules/sandia_rules.html">
      sandia_rules</a>,
      a library which
      produces a standard 1D Gauss quadrature rule of
      Chebyshev, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite,
      Jacobi, Laguerre, and Legendre types.
    </li>
    <li>
      <a href = "sandia_sgmgg/sandia_sgmgg.html">
      sandia_sgmgg</a>,
      a library which
      explores a generalized construction method for sparse grids.
    </li>
    <li>
      <a href = "sandia_sparse/sandia_sparse.html">
      sandia_sparse</a>,
      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.
    </li>
    <li>
      <a href = "satisfy/satisfy.html">
      satisfy</a>,
      a program which
      demonstrates, for a particular circuit, an exhaustive search
      for solutions of the circuit satisfiability problem.
    </li>
    <li>
      <a href = "satisfy_parfor/satisfy_parfor.html">
      satisfy_parfor</a>,
      a program which
      carries out a circuit satisfiability search; it runs in parallel
      using MATLAB's parfor facility.
    </li>
    <li>
      <a href = "sde/sde.html">
      sde</a>,
      a library which
      illustrates the properties of stochastic differential equations (SDE's), and
      common algorithms for their analysis, 
      by Desmond Higham;
    </li>
    <li>
      <a href = "search_serial/search_serial.html">
      search_serial</a>,
      a program which
      searches the integers from A to B for a value J such that F(J) = C.
      this version of the program is intended as a starting point for
      a parallel approach.
    </li>
    <li>
      <a href = "sequence_streak_display/sequence_streak_display.html">
      sequence_streak_display</a>,
      a program which
      displays a streak plot of a numeric sequence;
    </li>
    <li>
      <a href = "set_theory/set_theory.html">
      set_theory</a>,
      a library which
      demonstrates MATLAB commands that implement various set theoretic operations.
    </li>
    <li>
      <a href = "sftpack/sftpack.html">
      sftpack</a>,
      a library which
      implements the slow Fourier transform, intended as a teaching
      tool and comparison with the Fast Fourier Transform (FFT).
    </li>
    <li>
      <a href = "sgmga/sgmga.html">
      sgmga</a>,
      a library which
      creates sparse grids based on a mixture of 1D quadrature rules,
      allowing anisotropic weights for each dimension.
    </li>
    <li>
      <a href = "shallow_water_1d/shallow_water_1d.html">
      shallow_water_1d</a>,
      a program which
      simulates the evolution of a 1D fluid governed by the
      time-dependent shallow water equations.
    </li>
    <li>
      <a href = "shallow_water_1d_display/shallow_water_1d_display.html">
      shallow_water_1d_display</a>, 
      a program which 
      can display a solution of the shallow water equations in 1D, 
      generally as computed by the program shallow_water_1d.
    </li>
    <li>
      <a href = "shallow_water_2d/shallow_water_2d.html">
      shallow_water_2d</a>,
      a program which
      simulates the evolution of a 2D fluid governed by the
      time-dependent shallow water equations, by Cleve Moler.
    </li>
    <li>
      <a href = "shepard_interp_1d/shepard_interp_1d.html">
      shepard_interp_1d</a>,
      a library which
      defines and evaluates Shepard interpolants to 1D data,
      based on inverse distance weighting.
    </li>
    <li>
      <a href = "shepard_interp_2d/shepard_interp_2d.html">
      shepard_interp_2d</a>,
      a library which
      defines and evaluates Shepard interpolants to 2D data,
      based on inverse distance weighting.
    </li>
    <li>
      <a href = "shepard_interp_nd/shepard_interp_nd.html">
      shepard_interp_nd</a>,
      a library which
      defines and evaluates Shepard interpolants to multidimensional data,
      based on inverse distance weighting.
    </li>
    <li>
      <a href = "shoreline/shoreline.html">
      shoreline</a>,
      a program which
      tries to identify and triangulate the 2D domain over which some 
      function f(x,y) is nonnegative.
    </li>
    <li>
      <a href = "shoreline2/shoreline2.html">
      shoreline2</a>,
      a program which
      tries to identify and triangulate the 2D domain over which some 
      function f(x,y) is approximately zero.
    </li>
    <li>
      <a href = "simplex_coordinates/simplex_coordinates.html">
      simplex_coordinates</a>,
      a library which
      computes the Cartesian coordinates of the vertices of a regular
      simplex in M dimensions.
    </li>
    <li>
      <a href = "sine_transform/sine_transform.html">
      sine_transform</a>,
      a library which
      demonstrates some simple properties of the discrete sine transform.
    </li>
    <li>
      <a href = "sir_simulation/sir_simulation.html">
      sir_simulation</a>,
      a program which
      simulates the spread of a disease through a hospital room of M by N beds,
      using the Susceptible/Infected/Recovered (SIR) model.
    </li>
    <li>
      <a href = "sobol/sobol.html">
      sobol</a>,
      a library which
      generates elements of the Sobol M-dimensional quasirandom sequence,
      by Bennett Fox.
    </li>
    <li>
      <a href = "sobol_dataset/sobol_dataset.html">
      sobol_dataset</a>,
      a program which
      creates a Sobol quasirandom dataset;
    </li>
    <li>
      <a href = "sor/sor.html">
      sor</a>,
      a library which
      implements a simple version of the successive over-relaxation (SOR)
      method for the iteration solution of a linear system of equations.
    </li>
    <li>
      <a href = "sparse/sparse.html">
      sparse</a>,
      programs which
      illustrate the use of MATLAB's sparse matrix utilities;
    </li>
    <li>
      <a href = "sparse_grid_cc/sparse_grid_cc.html">
      sparse_grid_cc</a>,
      a library which
      creates sparse grids based on Clenshaw-Curtis quadrature rules.
    </li>
    <li>
      <a href = "sparse_grid_cc_dataset/sparse_grid_cc_dataset.html">
      sparse_grid_cc_dataset</a>,
      a program which
      creates sparse grids based on Clenshaw-Curtis quadrature rules.
    </li>
    <li>
      <a href = "sparse_grid_composite/sparse_grid_composite.html">
      sparse_grid_composite</a>,
      a library which
      creates sparse grids based on 1D composite rules (currently only
      of order 1).
    </li>
    <li>
      <a href = "sparse_grid_gl/sparse_grid_gl.html">
      sparse_grid_gl</a>,
      a library which
      creates sparse grids based on Gauss-Legendre rules.
    </li>
    <li>
      <a href = "sparse_grid_gl_dataset/sparse_grid_gl_dataset.html">
      sparse_grid_gl_dataset</a>,
      a program which
      creates a sparse grid dataset based on Gauss-Legendre rules.
    </li>
    <li>
      <a href = "sparse_grid_hermite/sparse_grid_hermite.html">
      sparse_grid_hermite</a>,
      a library which
      creates sparse grids based on Gauss-Hermite rules.
    </li>
    <li>
      <a href = "sparse_grid_hermite_dataset/sparse_grid_hermite_dataset.html">
      sparse_grid_hermite_dataset</a>,
      a program which
      creates a sparse grid dataset based on Gauss-Hermite rules.
    </li>
    <li>
      <a href = "sparse_grid_hw/sparse_grid_hw.html">
      sparse_grid_hw</a>,
      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.
    </li>
    <li>
      <a href = "sparse_grid_laguerre/sparse_grid_laguerre.html">
      sparse_grid_laguerre</a>,
      a library which
      creates sparse grids based on Gauss-Laguerre rules.
    </li>
    <li>
      <a href = "sparse_grid_laguerre_dataset/sparse_grid_laguerre_dataset.html">
      sparse_grid_laguerre_dataset</a>,
      a program which
      creates a sparse grid dataset based on Gauss-Laguerrre rules.
    </li>
    <li>
      <a href = "sparse_grid_mixed/sparse_grid_mixed.html">
      sparse_grid_mixed</a>,
      a library which
      creates sparse grids based a mixture of 1D factor rules.
    </li>
    <li>
      <a href = "sparse_grid_mixed_dataset/sparse_grid_mixed_dataset.html">
      sparse_grid_mixed_dataset</a>,
      a program which
      creates a sparse grid dataset based on a mixture of 1D rules.
    </li>
    <li>
      <a href = "sparse_grid_open/sparse_grid_open.html">
      sparse_grid_open</a>,
      a library which
      creates sparse grids based on one of the following
      open 1D rules: Fejer 2, Gauss-Patterson, Newton-Cotes-Open.
    </li>
    <li>
      <a href = "sparse_grid_open_dataset/sparse_grid_open_dataset.html">
      sparse_grid_open_dataset</a>,
      a program which
      creates a sparse grid dataset based on one of the following
      open 1D rules: Fejer 2, Gauss-Patterson, Newton-Cotes-Open.
    </li>
    <li>
      <a href = "sparse_grid_pure/sparse_grid_pure.html">
      sparse_grid_pure</a>,
      a library which
      is for the analysis and creation of sparse grids in which a single family
      of 1D quadrature rules is used for all spatial dimensions.
    </li>
    <li>
      <a href = "sparse_grid_total_poly/sparse_grid_total_poly.html">
      sparse_grid_total_poly</a>,
      a library which
      investigates the efficient approximation of all polynomials
      up to a given total degree using sparse grids.
    </li>
    <li>
      <a href = "sparse_interp_nd/sparse_interp_nd.html">
      sparse_interp_nd</a>,
      a library which
      can be used to define a sparse interpolant to a function f(x) of a 
      multidimensional argument.
    </li>
    <li>
      <a href = "sparse_parfor/sparse_parfor.html">
      sparse_parfor</a>,
      a library which
      demonstrates how a sparse matrix can be constructed by
      evaluating individual blocks in parallel with the parfor
      command, and then assembled (on a single processor) using the 
      sparse() command,
      by Gene Cliff.
    </li>
    <li>
      <a href = "sphere_cvt/sphere_cvt.html">
      sphere_cvt</a>,
      a program which
      carries out the Centroidal Voronoi Tessellation (CVT) iteration on the
      unit sphere.
    </li>
    <li>
      <a href = "sphere_delaunay/sphere_delaunay.html">
      sphere_delaunay</a>,
      a program which
      computes the Delaunay triangulation of points on the unit sphere.
    </li>
    <li>
      <a href = "sphere_exactness/sphere_exactness.html">
      sphere_exactness</a>,
      a program which
      tests the polynomial exactness of a quadrature rule for the unit sphere;
    </li>
    <li>
      <a href = "sphere_grid/sphere_grid.html">
      sphere_grid</a>,
      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.
    </li>
    <li>
      <a href = "sphere_lebedev_rule/sphere_lebedev_rule.html">
      sphere_lebedev_rule</a>,
      a library which
      computes Lebedev quadrature rules for the unit sphere;
    </li>
    <li>
      <a href = "sphere_lebedev_rule_display/sphere_lebedev_rule_display.html">
      sphere_lebedev_rule_display</a>,
      a program which
      reads a file defining a Lebedev quadrature rule for the sphere and
      displays the point locations.
    </li>
    <li>
      <a href = "sphere_monte_carlo/sphere_monte_carlo.html">
      sphere_monte_carlo</a>,
      a library which
      applies a Monte Carlo method to estimate the integral of a function
      over the surface of the unit sphere in 3D;
    </li>
    <li>
      <a href = "sphere_quad/sphere_quad.html">
      sphere_quad</a>,
      a library which
      approximates an integral over the surface of the unit sphere
      by applying a triangulation to the surface;
    </li>
    <li>
      <a href = "sphere_stereograph/sphere_stereograph.html">
      sphere_stereograph</a>,
      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.
    </li>
    <li>
      <a href = "sphere_stereograph_display/sphere_stereograph_display.html">
      sphere_stereograph_display</a>,
      a library which
      computes and displays the results of several stereographic projections
      between a sphere and a plane.
    </li>
    <li>
      <a href = "sphere_voronoi/sphere_voronoi.html">
      sphere_voronoi</a>,
      a program which
      computes the Voronoi diagram of points on the unit sphere.
    </li>
    <li>
      <a href = "sphere_xyz_display/sphere_xyz_display.html">
      sphere_xyz_display</a>,
      a program which
      reads XYZ information defining points in 3D,
      and displays a unit sphere and the points in the MATLAB 3D graphics window.
    </li>
    <li>
      <a href = "sphere_xyzf_display/sphere_xyzf_display.html">
      sphere_xyzf_display</a>,
      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.
    </li>
    <li>
      <a href = "spherical_harmonic/spherical_harmonic.html">
      spherical_harmonic</a>,
      a library which
      evaluates spherical harmonic functions.
    </li>
    <li>
      <a href = "spinterp/spinterp.html">
      spinterp</a>,
      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.
    </li>
    <li>
      <a href = "spinterp_examples/spinterp_examples.html">
      spinterp_examples</a>,
      a library which
      demonstrates some simple uses of the spinterp program, which uses
      sparse grids for interpolation, optimization, and quadrature in
      higher dimensions.
    </li>
    <li>
      <a href = "spline/spline.html">
      spline</a>,
      a library which
      interpolates and approximates via splines;
    </li>
    <li>
      <a href = "spring_ode/spring_ode.html">
      spring_ode</a>,
      a program which
      shows how line printer graphics can be used to make a crude illustration
      of a solution of the ordinary differential equation (ODE) that describes
      the motion of a weight attached to a spring.
    </li>
    <li>
      <a href = "spring_ode2/spring_ode2.html">
      spring_ode2</a>,
      a program which
      shows how gnuplot graphics can be used to illustrate
      a solution of the ordinary differential equation (ODE) that describes
      the motion of a weight attached to a spring.
    </li>
    <li>
      <a href = "st_io/st_io.html">
      st_io</a>
      a library which
      reads and writes sparse linear systems stored in the Sparse Triplet (ST)
      format.
    </li>
    <li>
      <a href = "st_to_hb/st_to_hb.html">
      st_to_hb</a>,
      a program which
      converts a sparse matrix file from the Sparse Triplet (ST) format to
      Harwell Boeing (HB) format;
    </li>
    <li>
      <a href = "st_to_mm/st_to_mm.html">
      st_to_mm</a>,
      a program which
      converts a sparse matrix file from Sparse Triplet (ST) format 
      to Matrix Market (MM) format;
    </li>
    <li>
      <a href = "st_to_msm/st_to_msm.html">
      st_to_msm</a>,
      a program which
      reads a Sparse Triplet (ST) file
      and creates a corresponding MATLAB Sparse Matrix.
    </li>
    <li>
      <a href = "stla_display/stla_display.html">
      stla_display</a>,
      a program which
      displays an ASCII stereolithography (STL) 3D graphics file;
    </li>
    <li>
      <a href = "stla_io/stla_io.html">
      stla_io</a>,
      a library which
      reads and writes an ASCII stereolithography (STL) 3D graphics file;
    </li>
    <li>
      <a href = "stla_to_tri_surface/stla_to_tri_surface.html">
      stla_to_tri_surface</a>,
      a program which
      reads an ASCII stereolithography (STL) 3D graphics file and extracts
      the surface mesh data as a tri_surface dataset.
    </li>
    <li>
      <a href = "stla_to_tri_surface_fast/stla_to_tri_surface_fast.html">
      stla_to_tri_surface_fast</a>,
      a program which
      is a faster version of stla_to_tri_surface.
    </li>
    <li>
      <a href = "stochastic_diffusion/stochastic_diffusion.html">
      stochastic_diffusion</a>,
      functions which
      implement several versions of a stochastic diffusivity coefficient.
    </li>
    <li>
      <a href = "stochastic_gradient_nd_noise/stochastic_gradient_nd_noise.html">
      stochastic_gradient_nd_noise</a>,
      a program which
      solves an optimization problem involving a functional over a system
      with stochastic noise.
    </li>
    <li>
      <a href = "stochastic_rk/stochastic_rk.html">
      stochastic_rk</a>,
      a library which
      applies a Runge-Kutta (RK) scheme to a stochastic differential equation (SDE).
    </li>
    <li>
      <a href = "stroud/stroud.html">
      stroud</a>,
      a library which
      implements numerical integration over M-dimensional
      regions, including spheres, toruses and other shapes;
    </li>
    <li>
      <a href = "subpak/subpak.html">
      subpak</a>,
      a library which
      includes many utility routines;
    </li>
    <li>
      <a href = "subset/subset.html">
      subset</a>,
      a library which
      ranks, unranks, and generates random subsets,
      combinations, permutations, and so on;
    </li>
    <li>
      <a href = "subset_sum/subset_sum.html">
      subset_sum</a>,
      a program which
      seeks solutions of the subset sum problem.
    </li>
    <li>
      <a href = "subset_sum_serial/subset_sum_serial.html">
      subset_sum_serial</a>,
      a program which
      seeks solutions of the subset sum problem, and is intended as a
      starting point for a parallel computing approach.
    </li>
    <li>
      <a href = "subset_sum_tasks/subset_sum_tasks.html">
      subset_sum_tasks</a>,
      a program which
      solves a subset sum problem by exhaustive search,
      solving the problem in parallel by subdividing the search range 
      among separate tasks.
    </li>
    <li>
      <a href = "sudoku/sudoku.html">
      sudoku</a>,
      a library which
      handles Sudoku puzzles;
    </li>
    <li>
      <a href = "sum_million/sum_million.html">
      sum_million</a>,
      a program which
      sums the integers from 1 to 1,000,000, as a demonstration of how
      to rate a computer's speed;
    </li>
    <li>
      <a href = "svd_basis/svd_basis.html">
      svd_basis</a>,
      a program which
      applies the singular value decomposition (SVD) to a collection of data vectors,
      extracting dominant modes;
    </li>
    <li>
      <a href = "svd_demo/svd_demo.html">
      svd_demo</a>,
      a program which
      demonstrates the calculation of
      the singular value decomposition (SVD) and some of its properties;
    </li>
    <li>
      <a href = "svd_fingerprint/svd_fingerprint.html">
      svd_fingerprint</a>,
      a program which
      reads a file containing a fingerprint image and 
      uses the singular value decomposition (SVD) to
      compute and display a series of low rank approximations to the image.
    </li>
    <li>
      <a href = "svd_snowfall/svd_snowfall.html">
      svd_snowfall</a>,
      a program which
      reads a file containing historical snowfall data and 
      analyzes the data with the Singular Value Decomposition (SVD).
    </li>
    <li>
      <a href = "svd_truncated/svd_truncated.html">
      svd_truncated</a>,
      a program which
      demonstrates the computation of the reduced or truncated 
      Singular Value Decomposition (SVD) that is useful for cases when
      one dimension of the matrix is much smaller than the other.
    </li>
    <li>
      <a href = "table_delaunay/table_delaunay.html">
      table_delaunay</a>,
      a program which
      reads a table file of N
      points in 2 dimensions and writes out the Delaunay triangulation;
    </li>
    <li>
      <a href = "table_io/table_io.html">
      table_io</a>,
      a library which
      reads and writes a simple table file;
    </li>
    <li>
      <a href = "table_latinize/table_latinize.html">
      table_latinize</a>,
      a program which
      reads a table file
      of N points in M dimensions, adjusts to form a Latin hypercube;
    </li>
    <li>
      <a href = "table_merge/table_merge.html">
      table_merge</a>,
      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.
    </li>
    <li>
      <a href = "table_quality/table_quality.html">
      table_quality</a>,
      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;
    </li>
    <li>
      <a href = "table_read/table_read.html">
      table_read</a>,
      a program which
      reads a table file
      containing comment lines
      beginning with '#', and a matrix of data, one row per line;
    </li>
    <li>
      <a href = "table_voronoi/table_voronoi.html">
      table_voronoi</a>,
      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;
    </li>
    <li>
      <a href = "tanh_quad/tanh_quad.html">
      tanh_quad</a>,
      a library which
      sets up the tanh quadrature rule;
    </li>
    <li>
      <a href = "tanh_sinh_rule/tanh_sinh_rule.html">
      tanh_sinh_rule</a>,
      a program which
      computes and writes out a tanh-sinh quadrature rule of given order.
    </li>
    <li>
      <a href = "task_division/task_division.html">
      task_division</a>,
      a library which
      implements a simple procedure for smoothly dividing T tasks among
      P processors; such a method can be useful in MPI and other parallel
      environments, particularly when T is not an exact multiple of P,
      and when the processors can be indexed starting from 0 or from 1.
    </li>
    <li>
      <a href = "tcell_flow_display/tcell_flow_display.html">
      tcell_flow_display</a>,
      a library which
      displays a single velocity field solution for the T cell;
    </li>
    <li>
      <a href = "tcell_flow_movie/tcell_flow_movie.html">
      tcell_flow_movie</a>,
      a library which
      creates an animation of the velocity solutions for the T cell;
    </li>
    <li>
      <a href = "tcell_rom/tcell_rom.html">
      tcell_rom</a>,
      a program which
      solves a reduced order model of a
      finite element solution of the Navier Stokes equations in
      a T-Cell flow region,
      by Hyung-Chun Lee.
    </li>
    <li>
      <a href = "tec_io/tec_io.html">
      tec_io</a>,
      a library which
      reads or writes a tecplot ASCII file
      containing finite element information;
    </li>
    <li>
      <a href = "tec_to_fem/tec_to_fem.html">
      tec_to_fem</a>,
      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;
    </li>
    <li>
      <a href = "tec_to_vtk/tec_to_vtk.html">
      tec_to_vtk</a>,
      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.
    </li>
    <li>
      <a href = "templates/templates.html">
      templates</a>,
      a library which
      carries out the iterative solution of linear systems;
    </li>
    <li>
      <a href = "tensor_grid_display/tensor_grid_display.html">
      tensor_grid_display</a>,
      a program which
      can display the grid points of a tensor product rule used for
      interpolation or quadrature, in 1D, 2D or 3D.
    </li>
    <li>
      <a href = "test_approx/test_approx.html">
      test_approx</a>,
      a library which
      implements test problems for approximation,
      provided as a set of (x,y) data.
    </li>
    <li>
      <a href = "test_con/test_con.html">
      test_con</a>,
      a library which
      implements test problems for
      numerical continuation.
    </li>
    <li>
      <a href = "test_eigen/test_eigen.html">
      test_eigen</a>,
      a library which
      implements test matrices for eigenvalue analysis.
    </li>
    <li>
      <a href = "test_int/test_int.html">
      test_int</a>,
      a library which
      implements test problems for
      approximate integration (quadrature) in one dimension.
    </li>
    <li>
      <a href = "test_int_2d/test_int_2d.html">
      test_int_2d</a>,
      a library which
      implements test problems for
      approximate integration (quadrature) in two dimensions.
    </li>
    <li>
      <a href = "test_int_hermite/test_int_hermite.html">
      test_int_hermite</a>,
      a library which
      defines test integrands for Hermite integrals with 
      interval (-oo,+oo) and weight exp(-x^2).
    </li>
    <li>
      <a href = "test_int_laguerre/test_int_laguerre.html">
      test_int_laguerre</a>,
      a library which
      implements test problems for
      approximate integration over a semi-infinite interval.
    </li>
    <li>
      <a href = "test_int_margin/test_int_margin.html">
      test_int_margin</a>,
      a library which
      implements test functions for the task of locating the region
      for which margin <= f(x), and estimating an integral over that region.
    </li>
    <li>
      <a href = "test_interp/test_interp.html">
      test_interp</a>,
      a library which
      defines test problems for interpolation,
      provided as a set of (x,y(x)) data.
    </li>
    <li>
      <a href = "test_interp_1d/test_interp_1d.html">
      test_interp_1d</a>,
      a library which
      defines test problems for interpolation of data y(x),
      which depends on a 1D argument.
    </li>
    <li>
      <a href = "test_interp_2d/test_interp_2d.html">
      test_interp_2d</a>,
      a library which
      defines test problems for interpolation of data z(x,y),
      which depends on a 2D argument.
    </li>
    <li>
      <a href = "test_interp_nd/test_interp_nd.html">
      test_interp_nd</a>,
      a library which
      defines test problems for interpolation of data z(x),
      depending on an M-dimensional argument.
    </li>
    <li>
      <a href = "test_ls/test_ls.html">
      test_ls</a>,
      a library which
      implements linear least squares test problems of the form A*x=b.
    </li>
    <li>
      <a href = "test_mat/test_mat.html">
      test_mat</a>,
      a library which
      defines a set of test matrices.
    </li>
    <li>
      <a href = "test_matrix/test_matrix.html">
      test_matrix</a>,
      a library which
      defines a set of test matrices and utilities,
      by Nick Higham;
    </li>
    <li>
      <a href = "test_matrix_exponential/test_matrix_exponential.html">
      test_matrix_exponential</a>,
      a library which
      defines a set of test cases for computing the matrix exponential.
    </li>
    <li>
      <a href = "test_min/test_min.html">
      test_min</a>,
      a library which
      implements test problems for
      minimization of a scalar function of a scalar variable.
    </li>
    <li>
      <a href = "test_nint/test_nint.html">
      test_nint</a>,
      a library which
      implements test problems for
      approximate integration (quadrature) in M dimensions.
    </li>
    <li>
      <a href = "test_ode/test_ode.html">
      test_ode</a>,
      a library which
      defines some sample ordinary differential equations (ODE's) for testing initial value
      problem solvers;
    </li>
    <li>
      <a href = "test_opt/test_opt.html">
      test_opt</a>,
      a library which
      implements test problems for optimization
      of a scalar function of several variables.
    </li>
    <li>
      <a href = "test_opt_con/test_opt_con.html">
      test_opt_con</a>,
      a library which
      defines test problems for the minimization of a scalar function of several variables, 
      with the search constrained to lie within a specified hyper-rectangle.
    </li>
    <li>
      <a href = "test_optimization/test_optimization.html">
      test_optimization</a>,
      a library which
      implements test problems for optimization
      of a scalar function of several variables,
      as described by Molga and Smutnicki.
    </li>
    <li>
      <a href = "test_tri_int/test_tri_int.html">
      test_tri_int</a>,
      a library which
      implements test functions for integration
      over a triangle in 2 dimensions.
    </li>
    <li>
      <a href = "test_triangulation/test_triangulation.html">
      test_triangulation</a>,
      a library which
      defines test problems for triangulation;
    </li>
    <li>
      <a href = "test_values/test_values.html">
      test_values</a>,
      a library which
      returns selected values of some special functions;
    </li>
    <li>
      <a href = "test_zero/test_zero.html">
      test_zero</a>,
      a library which
      defines some functions f(x) suitable for testing
      software that solves f(x)=0;
    </li>
    <li>
      <a href = "testpack/testpack.html">
      testpack</a>,
      a library which
      defines a set of test integrand functions,
      by Alan Genz.
    </li>
    <li>
      <a href = "tet_mesh/tet_mesh.html">
      tet_mesh</a>,
      a library which
      works with tetrahedral meshes in 3D;
    </li>
    <li>
      <a href = "tet_mesh_boundary/tet_mesh_boundary.html">
      tet_mesh_boundary</a>,
      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 data.
    </li>
    <li>
      <a href = "tet_mesh_display/tet_mesh_display.html">
      tet_mesh_display</a>,
      a program which
      reads data defining a (small) tet mesh,
      displays a wireframe image of the nodes and edges;
    </li>
    <li>
      <a href = "tet_mesh_l2q/tet_mesh_l2q.html">
      tet_mesh_l2q</a>,
      a program which
      reads information about a 4-node (linear) tet mesh and
      creates data defining a corresponding 10-node (quadratic)
      tet mesh;
    </li>
    <li>
      <a href = "tet_mesh_q2l/tet_mesh_q2l.html">
      tet_mesh_q2l</a>,
      a program which
      reads information about a 10-node (quadratic) tet mesh and
      creates data defining a corresponding 4-node (linear)
      tet mesh;
    </li>
    <li>
      <a href = "tet_mesh_quality/tet_mesh_quality.html">
      tet_mesh_quality</a>,
      a program which
      computes various quality measures for a
      tet mesh of a set of nodes in 3D;
    </li>
    <li>
      <a href = "tet_mesh_rcm/tet_mesh_rcm.html">
      tet_mesh_rcm</a>,
      a program which
      computes the Reverse Cuthill McKee (RCM) reordering for the nodes
      of a tet mesh that uses 4-node or 10-node tetrahedrons;
    </li>
    <li>
      <a href = "tet_mesh_refine/tet_mesh_refine.html">
      tet_mesh_refine</a>,
      a program which
      refines a tet mesh;
    </li>
    <li>
      <a href = "tet_mesh_tet_neighbors/tet_mesh_tet_neighbors.html">
      tet_mesh_tet_neighbors</a>,
      a program which
      reads information about a tet mesh and writes out a list of the
      tetrahedrons that are adjacent to a given tetrahedron;
    </li>
    <li>
      <a href = "tet_mesh_volumes/tet_mesh_volumes.html">
      tet_mesh_volumes</a>,
      a program which
      computes the volume of each tetrahedron in a tet mesh;
    </li>
    <li>
      <a href = "tetrahedron_exactness/tetrahedron_exactness.html">
      tetrahedron_exactness</a>,
      a program which
      tests the polynomial
      exactness of a quadrature rule for the tetrahedron;
    </li>
    <li>
      <a href = "tetrahedron_grid/tetrahedron_grid.html">
      tetrahedron_grid</a>,
      a library which
      computes a grid of points inside a 3D tetrahedron.
    </li>
    <li>
      <a href = "tetrahedron_monte_carlo/tetrahedron_monte_carlo.html">
      tetrahedron_monte_carlo</a>,
      a program which
      uses the Monte Carlo method to estimate an integral over a tetrahedron.
    </li>
    <li>
      <a href = "tetrahedron_properties/tetrahedron_properties.html">
      tetrahedron_properties</a>,
      a program which
      prints out the properties of a tetrahedron
      whose vertex coordinates are read from a file;
    </li>
    <li>
      <a href = "tetrahedron_slice_animate/tetrahedron_slice_animate.html">
      tetrahedron_slice_animate</a>,
      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.
    </li>
    <li>
      <a href = "tetrahedron_slice_display/tetrahedron_slice_display.html">
      tetrahedron_slice_display</a>,
      a program which
      determines the intersection between a tetrahedron and a plane and
      displays the result.
    </li>
    <li>
      <a href = "three_body_simulation/three_body_simulation.html">
      three_body_simulation</a>,
      a program which
      simulates the behavior of three planets, constrained to lie in a plane,
      and moving under the influence of gravity,
      by Walter Gander and Jiri Hrebicek.
    </li>
    <li>
      <a href = "threed/threed.html">
      threed</a>,
      a library which
      contains functions useful for 3D finite element calculations,
      by Jeff Borggaard.
    </li>
    <li>
      <a href = "threed_to_tecplot/threed_to_tecplot.html">
      threed_to_tecplot</a>,
      a program which
      accepts computational data from a 3D finite element fluid flow program
      and writes it to a tecplot ASCII graphics file.
    </li>
    <li>
      <a href = "threed_to_vtk/threed_to_vtk.html">
      threed_to_vtk</a>,
      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.
    </li>
    <li>
      <a href = "threed_to_vtu/threed_to_vtu.html">
      threed_to_vtu</a>,
      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.
    </li>
    <li>
      <a href = "threed_to_vu/threed_to_vu.html">
      threed_to_vu</a>,
      a program which
      accepts computational data from a 3D finite element fluid flow program
      and writes it to a file for postprocessing by vu.
    </li>
    <li>
      <a href = "tic_toc/tic_toc.html">
      tic_toc</a>,
      programs which
      demonstrate some features of MATLAB's tic and toc functions for wallclock timing.
    </li>
    <li>
      <a href = "timer/timer.html">
      timer</a>,
      programs which
      illustrate how to time a piece of code;
    </li>
    <li>
      <a href = "timestamp/timestamp.html">
      timestamp</a>,
      a library which
      prints the current YMDHMS date as a timestamp;
    </li>
    <li>
      <a href = "toeplitz_cholesky/toeplitz_cholesky.html">
      toeplitz_cholesky</a>,
      a library which
      computes the Cholesky factorization of a nonnegative definite symmetric
      Toeplitz matrix.
    </li>
    <li>
      <a href = "toms178/toms178.html">
      toms178</a>,
      a library which
      seeks the minimizer of a scalar function of several variables
      using the Hooke-Jeeves method, by Arthur Kaupe.
      this is a MATLAB version of ACM TOMS algorithm 178.
    </li>
    <li>
      <a href = "toms179/toms179.html">
      toms179</a>,
      a library which
      calculates the incomplete Beta ratio,
      by Oliver Ludwig;
      this is a MATLAB version of ACM TOMS algorithm 179.
    </li>
    <li>
      <a href = "toms291/toms291.html">
      toms291</a>,
      a library which
      approximates the logarithm of the Gamma function;
      this is a MATLAB version of ACM TOMS algorithm 291.
    </li>
    <li>
      <a href = "toms446/toms446.html">
      toms446</a>,
      a library which
      manipulates Chebyshev series for interpolation and approximation;
      this is a MATLAB version of ACM TOMS algorithm 446,
      by Roger Broucke.
    </li>
    <li>
      <a href = "toms462/toms462.html">
      toms462</a>,
      a library which
      evaluates the upper right tail of the bivariate normal distribution; that is,
      the probability that normal variables X and Y with correlation R will
      satisfy H <= X and K <= Y;
      this is a MATLAB version of ACM TOMS algorithm 462.
    </li>
    <li>
      <a href = "toms655/toms655.html">
      toms655</a>,
      a library which
      computes the weights for interpolatory quadrature rule;
      this library is commonly called IQPACK;
      this is a MATLAB version of ACM TOMS algorithm 655.
    </li>
    <li>
      <a href = "toms847/toms847.html">
      toms847</a>,
      a library which
      carries out piecewise multilinear
      hierarchical sparse grid interpolation, commonly known as
      SPINTERP, by Andreas Klimke;
      this is ACM TOMS Algorithm 847.
    </li>
    <li>
      <a href = "toms866/toms866.html">
      toms866</a>,
      a library which
      contains the Incompressible Flow Iterative Solution Software (IFISS),
      by Howard Elman, Alison Ramage, David Silvester;
      this is ACM TOMS algorithm 866.
    </li>
    <li>
      <a href = "traffic_simulation/traffic_simulation.html">
      traffic_simulation</a>,
      a program which
      simulates the cars waiting to get through a traffic light.
    </li>
    <li>
      <a href = "tri_surface_display/tri_surface_display.html">
      tri_surface_display</a>,
      a program which
      displays a triangulated surface;
    </li>
    <li>
      <a href = "tri_surface_io/tri_surface_io.html">
      tri_surface_io</a>,
      a library which
      reads and writes the 3D graphics information
      in a tri_surface file;
    </li>
    <li>
      <a href = "tri_surface_to_obj/tri_surface_to_obj.html">
      tri_surface_to_obj</a>,
      a program which
      reads a tri_surface dataset and extracts
      the surface mesh data as an OBJ file.
    </li>
    <li>
      <a href = "tri_surface_to_ply/tri_surface_to_ply.html">
      tri_surface_to_ply</a>,
      a program which
      converts a tri_surface dataset
      to a dataset suitable for storage as a PLY file.
    </li>
    <li>
      <a href = "tri_surface_to_stla/tri_surface_to_stla.html">
      tri_surface_to_stla</a>,
      a program which
      reads a tri_surface dataset and extracts
      the surface mesh data as an ASCII stereolithography (STL) file.
    </li>
    <li>
      <a href = "triangle_display/triangle_display.html">
      triangle_display</a>,
      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.
    </li>
    <li>
      <a href = "triangle_exactness/triangle_exactness.html">
      triangle_exactness</a>,
      a program which
      tests the polynomial exactness of a quadrature rule for triangles;
    </li>
    <li>
      <a href = "triangle_grid/triangle_grid.html">
      triangle_grid</a>,
      a library which
      computes a triangular grid of points.
    </li>
    <li>
      <a href = "triangle_histogram/triangle_histogram.html">
      triangle_histogram</a>,
      a program which
      computes histograms of data on the unit triangle.
    </li>
    <li>
      <a href = "triangle_monte_carlo/triangle_monte_carlo.html">
      triangle_monte_carlo</a>,
      a program which
      uses the Monte Carlo method to estimate an integral over a triangle.
    </li>
    <li>
      <a href = "triangle_properties/triangle_properties.html">
      triangle_properties</a>,
      a program which
      computes properties of a triangle
      whose vertex coordinates are read from a file.
    </li>
    <li>
      <a href = "triangulate/triangulate.html">
      triangulate</a>,
      a program which
      triangulates a polygonal region,
      based on a C program by Joseph ORourke;
    </li>
    <li>
      <a href = "triangulation/triangulation.html">
      triangulation</a>,
      a library which
      computes the triangulation of
      a set of points in the plane, and to perform various operations
      using a triangulation;
    </li>
    <li>
      <a href = "triangulation_boundary_nodes/triangulation_boundary_nodes.html">
      triangulation_boundary_nodes</a>,
      a program which
      reads data defining a triangulation, determines which nodes
      lie on the boundary, and writes their coordinates to a file;
    </li>
    <li>
      <a href = "triangulation_corner/triangulation_corner.html">
      triangulation_corner</a>,
      a program which
      modifies triangulations in which one or more triangles have more
      than one boundary edge.
    </li>
    <li>
      <a href = "triangulation_delaunay_discrepancy/triangulation_delaunay_discrepancy.html">
      triangulation_delaunay_discrepancy</a>,
      a program which
      measures the amount by which a triangulation fails the local Delaunay test;
    </li>
    <li>
      <a href = "triangulation_display/triangulation_display.html">
      triangulation_display</a>,
      a program which
      displays the nodes and elements of a triangulation on the MATLAB
      graphics screen;
    </li>
    <li>
      <a href = "triangulation_histogram/triangulation_histogram.html">
      triangulation_histogram</a>,
      a program which
      computes histograms of data over a triangulation.
    </li>
    <li>
      <a href = "triangulation_l2q/triangulation_l2q.html">
      triangulation_l2q</a>,
      a program which
      reads information about a 3-node (linear) triangulation and creates data
      defining a corresponding 6-node (quadratic) triangulation;
    </li>
    <li>
      <a href = "triangulation_mask/triangulation_mask.html">
      triangulation_mask</a>,
      a program which
      reads a triangulation and calls
      a user-supplied routine to consider each triangle for deletion;
    </li>
    <li>
      <a href = "triangulation_order1_display/triangulation_order1_display.html">
      triangulation_order1_display</a>,
      a program which
      plots piecewise constant data associated with a triangulation;
    </li>
    <li>
      <a href = "triangulation_order3_contour/triangulation_order3_contour.html">
      triangulation_order3_contour</a>,
      a program which
      plots color contours of a scalar
      quantity evaluated at the nodes of a 3-node triangle triangulation.
    </li>
    <li>
      <a href = "triangulation_order6_contour/triangulation_order6_contour.html">
      triangulation_order6_contour</a>,
      a program which
      plots color contours of a scalar
      quantity evaluated at the nodes of a 6-node triangle triangulation.
    </li>
    <li>
      <a href = "triangulation_orient/triangulation_orient.html">
      triangulation_orient</a>,
      a program which
      ensures that the triangles in
      an order 3 or order 6 triangulation have positive orientation;
    </li>
    <li>
      <a href = "triangulation_plot/triangulation_plot.html">
      triangulation_plot</a>,
      a program which
      plots the nodes and elements of a triangulation as a PostScript file;
    </li>
    <li>
      <a href = "triangulation_q2l/triangulation_q2l.html">
      triangulation_q2l</a>,
      a program which
      reads information about a 6-node triangulation and creates data
      defining a corresponding 3-node triangulation;
    </li>
    <li>
      <a href = "triangulation_quad/triangulation_quad.html">
      triangulation_quad</a>,
      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.
    </li>
    <li>
      <a href = "triangulation_quality/triangulation_quality.html">
      triangulation_quality</a>,
      a program which
      reads information about a triangulation and computes various
      quality measures;
    </li>
    <li>
      <a href = "triangulation_rcm/triangulation_rcm.html">
      triangulation_rcm</a>,
      a program which
      computes the Reverse Cuthill McKee (RCM) reordering for the nodes
      of a triangulation that uses 3-node or 6-node triangles;
    </li>
    <li>
      <a href = "triangulation_refine/triangulation_refine.html">
      triangulation_refine</a>,
      a program which
      refines a triangulation;
    </li>
    <li>
      <a href = "triangulation_refine_local/triangulation_refine_local.html">
      triangulation_refine_local</a>,
      a program which
      refines a triangulation locally; a single triangular element is replaced
      by four smaller triangles, and neighboring information is updated.
    </li>
    <li>
      <a href = "triangulation_t3_to_t4/triangulation_t3_to_t4.html">
      triangulation_t3_to_t4</a>,
      a program which
      reads information about a 3-node T3 triangulation and creates data
      defining a corresponding 4-node T4 triangulation;
    </li>
    <li>
      <a href = "triangulation_triangle_neighbors/triangulation_triangle_neighbors.html">
      triangulation_triangle_neighbors</a>,
      a program which
      reads data defining a triangulation, finds the three neighbor
      triangles for each triangle, and writes them to a file;
    </li>
    <li>
      <a href = "truel_simulation/truel_simulation.html">
      truel_simulation</a>,
      a program which
      simulates N repetitions of a duel between three players, each of
      whom has a known firing accuracy.
    </li>
    <li>
      <a href = "tumor/tumor.html">
      tumor</a>,
      a program which
      demonstrates a model of tumor growth;
    </li>
    <li>
      <a href = "two_body_simulation/two_body_simulation.html">
      two_body_simulation</a>,
      a program which
      simulates the behavior of two bodies, constrained to lie in a plane,
      moving under the influence of gravity, with one body much more massive 
      than the other.
    </li>
    <li>
      <a href = "twod/twod.html">
      twod</a>,
      a library which
      contains functions useful for 2D finite element calculations,
      by Jeff Borggaard.
    </li>
    <li>
      <a href = "twod_plotc/twod_plotc.html">
      twod_plotc</a>,
      a program which
      makes a color contour plot of scalar data defined on a 2D finite
      element mesh.
    </li>
    <li>
      <a href = "twod_to_vtk/twod_to_vtk.html">
      twod_to_vtk</a>,
      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.
    </li>
    <li>
      <a href = "twod_to_vtu/twod_to_vtu.html">
      twod_to_vtu</a>,
      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.
    </li>
    <li>
      <a href = "unicycle/unicycle.html">
      unicycle</a>,
      a library which
      considers permutations containing a single cycle, sometimes called cyclic permutations.
    </li>
    <li>
      <a href = "uniform/uniform.html">
      uniform</a>,
      a library which
      computes N elements of a uniform pseudorandom sequence;
    </li>
    <li>
      <a href = "uniform_dataset/uniform_dataset.html">
      uniform_dataset</a>,
      a program which
      creates N elements of an M-dimensional uniform pseudorandom sequence and
      writes them to a file.
    </li>
    <li>
      <a href = "van_der_corput/van_der_corput.html">
      van_der_corput</a>,
      a library which
      computes elements of the van der Corput
      1-dimensional quasirandom sequence;
    </li>
    <li>
      <a href = "van_der_corput_dataset/van_der_corput_dataset.html">
      van_der_corput_dataset</a>,
      a program which
      creates N elements of a van der Corput sequence and
      writes them to a file.
    </li>
    <li>
      <a href = "vandermonde_approx_1d/vandermonde_approx_1d.html">
      vandermonde_approx_1d</a>,
      a library which
      finds a polynomial approximant to data y(x) of a 1D argument by setting up and
      solving an overdetermined linear system for the polynomial coefficients 
      involving the Vandermonde matrix.
    </li>
    <li>
      <a href = "vandermonde_approx_2d/vandermonde_approx_2d.html">
      vandermonde_approx_2d</a>,
      a library which
      finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and
      solving an overdetermined linear system for the polynomial coefficients 
      involving the Vandermonde matrix.
    </li>
    <li>
      <a href = "vandermonde_interp_1d/vandermonde_interp_1d.html">
      vandermonde_interp_1d</a>,
      a library which
      finds a polynomial interpolant to data y(x) of a 1D argument by setting up and
      solving a linear system for the polynomial coefficients 
      involving the Vandermonde matrix.
    </li>
    <li>
      <a href = "vandermonde_interp_2d/vandermonde_interp_2d.html">
      vandermonde_interp_2d</a>,
      a library which
      finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and
      solving a linear system for the polynomial coefficients 
      involving the Vandermonde matrix.
    </li>
    <li>
      <a href = "vector_magnitude_grid/vector_magnitude_grid.html">
      vector_magnitude_grid</a>,
      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.
    </li>
    <li>
      <a href = "vector_stream_grid/vector_stream_grid.html">
      vector_stream_grid</a>,
      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.
    </li>
    <li>
      <a href = "velocity_arrows/velocity_arrows.html">
      velocity_arrows</a>,
      a program which
      reads coordinate data and velocity data
      from two files and makes an arrow plot of the velocity field.
    </li>
    <li>
      <a href = "velocity_arrows_grid/velocity_arrows_grid.html">
      velocity_arrows_grid</a>,
      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.
    </li>
    <li>
      <a href = "velocity_arrows_grid_sequence2/velocity_arrows_grid_sequence2.html">
      velocity_arrows_grid_sequence2</a>,
      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.
    </li>
    <li>
      <a href = "velocity_arrows_sequence/velocity_arrows_sequence.html">
      velocity_arrows_sequence</a>,
      a program which
      reads a fixed coordinate data file,
      and a sequence of velocity data files, and makes a sequence
      of velocity arrow plots.
    </li>
    <li>
      <a href = "velocity_arrows_sequence2/velocity_arrows_sequence2.html">
      velocity_arrows_sequence2</a>,
      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.
    </li>
    <li>
      <a href = "voronoi_display/voronoi_display.html">
      voronoi_display</a>,
      a program which
      computes the exact Voronoi diagram using geompack, and displays it.
    </li>
    <li>
      <a href = "voronoi_mountains/voronoi_mountains.html">
      voronoi_mountains</a>,
      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.
    </li>
    <li>
      <a href = "voronoi_plot/voronoi_plot.html">
      voronoi_plot</a>,
      a program which
      estimates the Voronoi neighborhoods of points using sampling,
      and with a distance based on the L1, L2, LInfinity or arbitrary LP norms;
    </li>
    <li>
      <a href = "vpa/vpa.html">
      vpa</a>,
      programs which
      use the Variable Precision Arithmetic (VPA) feature of the
      Symbolic Math Toolbox to compute arbitrary precision quantities.
    </li>
    <li>
      <a href = "walsh/walsh.html">
      walsh</a>,
      a library which
      implements versions of the Walsh and Haar transforms.
    </li>
    <li>
      <a href = "wandzura/wandzura.html">
      wandzura</a>,
      a library which
      returns one of 6 Wandzura rules for quadrature in a triangle;
    </li>
    <li>
      <a href = "wavelet/wavelet.html">
      wavelet</a>,
      a library which
      does some simple wavelet calculations;
    </li>
    <li>
      <a href = "weekday/weekday.html">
      weekday</a>,
      a library which
      determines the day of the week corresponding to a given date,
      such as 14 October 1066, Julian calendar, ...which was a Saturday.
    </li>
    <li>
      <a href = "wtime/wtime.html">
      wtime</a>,
      a library which
      returns a reading of the wall clock time in seconds.
    </li>
    <li>
      <a href = "xy_display/xy_display.html">
      xy_display</a>,
      a program which
      reads an XY file containing
      the coordinates of points in 2D,
      and displays an image in the MATLAB graphics window;
    </li>
    <li>
      <a href = "xy_io/xy_io.html">
      xy_io</a>,
      a library which
      reads and writes XY files.
    </li>
    <li>
      <a href = "xyf_display/xyf_display.html">
      xyf_display</a>,
       a program which
      reads XYF information defining points and faces in 2D,
      and displays an image in the MATLAB graphics window.
    </li>
    <li>
      <a href = "xyl_display/xyl_display.html">
      xyl_display</a>,
      a program which
      reads XYL information defining points and lines in 2D,
      and displays an image in the MATLAB graphics window.
    </li>
    <li>
      <a href = "xyz_display/xyz_display.html">
      xyz_display</a>,
      a program which
      reads XYZ information defining points in 3D,
      and displays an image in the MATLAB 3D graphics window.
    </li>
    <li>
      <a href = "xyz_io/xyz_io.html">
      xyz_io</a>,
      a library which
      reads and writes XYZ files.
    </li>
    <li>
      <a href = "xyzf_display/xyzf_display.html">
      xyzf_display</a>,
      a program which
      reads XYZF information defining points and faces in 3D,
      and displays an image in the MATLAB 3D graphics window.
    </li>
    <li>
      <a href = "xyzl_display/xyzl_display.html">
      xyzl_display</a>,
      a program which
      reads XYZL information defining points and lines in 3D,
      and displays an image in the MATLAB 3D graphics window.
    </li>
    <li>
      <a href = "ziggurat/ziggurat.html">
      ziggurat</a>,
      a library which
      samples the uniform, normal or exponential distributions,
      using the ziggurat method, 
      by Marsaglia and Tsang.
    </li>
  </ol>
</p

<p>
  You can go up one level to
  <a href = "../index.html">the main web page.</a>
</p>

<hr>

<i>
  Last revised on 27 November 2012.
</i>

<!-- John Burkardt -->

About

An official Git Mirror of John Burkardt's great collection of MATLAB Software

Resources

Stars

Watchers

Forks

Releases

No releases published

Packages

No packages published

Languages

  • MATLAB 65.4%
  • Gnuplot 31.3%
  • M 3.1%
  • Mercury 0.1%
  • Objective-C++ 0.1%
  • Smalltalk 0.0%