MATLAB Source Codes
In many cases, the software is available in a program directory,
while an accompanying test case is provided in a program_test directory.
-
alpert_rule,
a library which
can set up an Alpert quadrature rule for functions which are
regular, log(x) singular, or 1/sqrt(x) singular.
-
alpert_rule_test
-
analemma,
a program which
evaluates the equation of time, a formula for the difference between
the uniform 24 hour day and the actual position of the sun,
based on a C program by Brian Tung.
-
analemma_test
-
annulus_monte_carlo,
a library which
uses the Monte Carlo method to estimate the integral of a function
over the interior of a circular annulus in 2D.
-
annulus_monte_carlo_test
-
annulus_rule,
a library which
computes a quadrature rule for estimating integrals of a function
over the interior of a circular annulus in 2D.
-
annulus_rule_test
-
area_under_curve,
a function which
displays the area under a curve, that is, the points (x,y)
between the x axis and the curve y=f(x).
-
area_under_curve_test
-
args,
a function which
shows how to count and report command line arguments;
-
args_test
-
arpack_test
-
asa005,
a library which
evaluates the lower tail of the noncentral Student's T distribution,
by BE Cooper.
This is a version of Applied Statistics Algorithm 5;
-
asa005_test
-
asa006,
a library which
computes the Cholesky factor of a positive definite symmetric matrix,
by Michael Healy;
This is a version of Applied Statistics Algorithm 6;
-
asa006_test
-
asa007,
a library which
computes the inverse of a positive definite symmetric matrix,
by Michael Healy;
This is a version of Applied Statistics Algorithm 7.
-
asa007_test
-
asa032,
a library which
evaluates the incomplete Gamma function,
by G Bhattacharjee.
This is a version of Applied Statistics Algorithm 32;
-
asa032_test
-
asa047,
a library which
minimizes a scalar function of several variables
using the Nelder-Mead algorithm,
by R ONeill.
This is a version of Applied Statistics Algorithm 47;
-
asa047_test
-
asa053,
a library which
produces sample matrices from the Wishart distribution,
by William Smith and Ronald Hocking.
This is a version of Applied Statistics Algorithm 53.
-
asa053_test
-
asa058,
a library which
carries out clustering of data,
by David Sparks.
This is a version of Applied Statistics Algorithm 58;
-
asa058_test
-
asa063,
a library which
evaluates the incomplete Beta function,
by KL Majumder and G Bhattacharjee.
This is a version of Applied Statistics Algorithm 63;
-
asa063_test
-
asa066,
a library which
computes the cumulative density function (CDF) of the standard normal
distribution, by David Hill.
This is a version of Applied Statistics Algorithm 66;
-
asa066_test
-
asa076,
a library which
evaluates Owen's T function,
by Young and Minder.
This is a version of Applied Statistics Algorithm 76;
-
asa076_test
-
asa091,
a library which
computes the percentage points of the Chi-square distribution,
by Best and Roberts.
This is a version of Applied Statistics Algorithm 91;
-
asa091_test
-
asa103,
a library which
evaluates the digamma or psi function,
by Jose Bernardo.
This is a version of Applied Statistics Algorithm 103;
-
asa103_test
-
asa109
a library which
inverts the incomplete Beta function,
by Cran, Martin and Thomas.
This is a version of Applied Statistics Algorithm 109;
-
asa109_test
-
asa111
a library which
evaluates the percentage points of the normal distribution,
by Beasley and Springer.
This is a version of Applied Statistics Algorithm 111;
-
asa111_test
-
asa113
a library which
clusters data using a transfer and swap algorithm,
by Banfield and Bassill;
This is a version of Applied Statistics Algorithm 113;
-
asa113_test
-
asa121,
a library which
evaluates the trigamma function,
by BE Schneider.
This is a version of Applied Statistics Algorithm 121;
-
asa121_test
-
asa136,
a library which
implements a clustering algorithm,
by Hartigan and Wong.
This is a version of Applied Statistics Algorithm 136;
-
asa136_test
-
asa144,
a library which
randomly generates tables with given row and column sums,
by James Boyett.
This is a version of Applied Statistics Algorithm 144;
-
asa144_test
-
asa147,
a library which
evaluates the incomplete Gamma function,
by Chi Leung Lau.
This is a version of Applied Statistics Algorithm 147;
-
asa147_test
-
asa152,
a library which
evaluates the probability density function (PDF) and
cumulative density function (CDF) associated with the
hypergeometric distribution,
by Richard Lund;
This is a version of Applied Statistics Algorithm 152;
-
asa152_test
-
asa159,
a library which
computes a random table with given row and column sums,
by Michael Patefield;
This is a version of Applied Statistics Algorithm 159;
-
asa159_test
-
asa172,
a library which
generates all M dimensional indices in a given range,
simulating the behavior of an arbitrary number of nested loops,
by OFlaherty and MacKenzie;
this is a version of Applied Statistics Algorithm 172;
-
asa172_test
-
asa183,
a library which
implements a random number generator (RNG),
by Wichman and Hill;
this is a version of Applied Statistics Algorithm 183;
-
asa183_test
-
asa226,
a library which
evaluates the noncentral incomplete Beta function,
by Russell Lenth;
this is a version of Applied Statistics Algorithm 226;
-
asa226_test
-
asa239,
a library which
evaluates the incomplete Gamma function,
by Shea;
this is a version of Applied Statistics Algorithm 239;
-
asa239_test
-
asa241,
a library which
computes the inverse of the normal cumulative density function (CDF),
by Michael Wichura;
this is a version of Applied Statistics Algorithm 241;
-
asa241_test
-
asa243,
a library which
evaluates the lower tail of the noncentral Student's T distribution,
by Russell Lenth;
this is a version of Applied Statistics Algorithm 243;
-
asa243_test
-
asa245,
a library which
evaluates the logarithm of the Gamma function,
by Allan Mcleod;
this is a version of Applied Statistics Algorithm 245;
-
asa245_test
-
asa266,
a library which
evaluates various properties of the Dirichlet
probability density function (PDF);
this is a version of Applied Statistics Algorithm 266;
-
asa266_test
-
asa299,
a library which
computes the lattice points (integer coordinates)
in an M dimensional simplex,
by Chasalow and Brand;
this is a version of Applied Statistics Algorithm 299;
-
asa299_test
-
asa310,
a library which
evaluates the noncentral incomplete Beta function,
by Chattamvelli and Shanmugam.
This is a version of Applied Statistics Algorithm 310;
-
asa310_test
-
asa314,
a library which
computes the inverse of a matrix whose elements are subject to
modulo arithmetic,
by Roger Payne.
This is a version of Applied Statistics Algorithm 314.
-
asa314_test
-
atbash,
a library which
applies the Atbash substitution cipher to a string of text.
-
atbash_test
-
backtrack_binary_rc,
a library which
carries out a backtrack search for a set of binary decisions, using
reverse communication (RC).
-
backtrack_binary_rc_test
-
ball_and_stick_display,
a program which
demonstrates the creation of a 3D image constructed from
balls and sticks;
-
ball_and_stick_display_test
-
ball_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected in the unit ball in 3D.
-
ball_distance_test
-
ball_grid,
a library which
computes a grid of points
over the interior of the unit ball in 3D.
-
ball_grid_test
-
ball_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit ball in 3D.
-
ball_integrals_test
-
ball_monte_carlo,
a library which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the unit ball in 3D;
-
ball_monte_carlo_test
-
bank,
a library which
computes the check digit associated with a US Bank Routing Number
check digit, or reports whether a 9-digit code is actually valid.
-
bank_test
-
barycentric_interp_1d,
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.
-
barycentric_interp_1d_test
-
bellman_ford,
a library which
implements the Bellman-Ford algorithm for finding the shortest
distance from a given node to all other nodes in a directed graph
whose edges have been assigned real-valued lengths.
-
bellman_ford_test
-
bernstein_approximation,
a library which
looks at some simple cases of approximation of a function f(x)
by a Bernstein polynomial.
-
bernstein_approximation_test
-
bernstein_polynomial,
a library which
evaluates the Bernstein polynomials;
-
bernstein_polynomial_test
-
besselj,
a library which
evaluates Bessel J functions of noninteger order;
-
besselj_test
-
beta_nc,
a library which
evaluates the cumulative density function (CDF) of
the noncentral Beta distribution;
-
beta_nc_test
-
bezier_surface,
a library which
reads, writes, prints and manipulates
the data that defines a Bezier surface;
-
bezier_surface_test
-
bezier_surface_display,
a program which
displays a Bezier surface;
-
bezier_surface_display_test
-
bicycle_lock,
a library which
simulates the process of determining the secret combination of
a bicycle lock, an integer between 000 and 999.
-
bicycle_lock_test
-
bisection_integer,
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].
-
bisection_integer_test
-
bisection_rc,
a library which
seeks a solution to the equation F(X)=0 using bisection
within a user-supplied change of sign interval [A,B].
The procedure is written using reverse communication (RC).
-
bisection_rc_test
-
black_scholes,
a library which
implements some simple approaches to
the Black-Scholes option valuation theory,
by Desmond Higham.
-
black_scholes_test
-
blas0,
a library which
contains auxilliary functions for the Basic Linear Algebra Subprograms
(BLAS).
-
blas0_test
-
blas1_d,
a library which
implements the Level 1 Basic Linear Algebra Subprograms (BLAS),
using double precision real arithmetic;
-
blas1_d_test
-
blas1_z,
a library which
implements the Level 1 Basic Linear Algebra Subprograms (BLAS),
using double precision complex arithmetic;
-
blas1_z_test
-
blas2_d,
a library which
contains the Level 2 Basic Linear Algebra Subprograms (BLAS)
for matrix-vector operations,
using double precision real arithmetic.
-
blas2_d_test
-
blas3_d,
a library which
constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS),
for matrix-matrix operations
using double precision real arithmetic.
-
blas3_d_test
-
blend,
a library which
carries out 1D/2D/3D blending interpolation;
-
blend_test
-
blsprice_test
-
box_behnken,
a library which
computes a Box-Behnken design,
that is, a set of arguments to sample the behavior
of a function of multiple parameters;
-
box_behnken_test
-
box_display,
a program which
displays a box plot, over integer pairs of data, of a function
defined by two formulas.
-
box_display_test
-
box_flow,
a program which
solves the Navier Stokes equations (NSE), replacing the continuity
equation with a pressure Poisson equation (PPE), by John Cornthwaite.
-
box_flow_test
-
box_games,
a library which
assists in the display of game boards (checkers, cellular automatons,
life);
-
box_games_test
-
box_plot,
a program which
displays a box plot of data that consists of pairs of integers;
-
box_plot_test
-
brain_sensor_pod,
a program which
applies the method of Proper Orthogonal Decomposition (POD)
to seek underlying patterns in sets of 40 sensor readings of
brain activity.
-
brain_sensor_pod_test
-
brent,
a library which
contains routines for finding zeroes or minima of a scalar function
of a scalar variable, without the use of derivative information,
including a reverse communication (RC) option,
by Richard Brent.
-
brent_test
-
brownian_motion_simulation,
a library which
simulates Brownian motion in an M dimensional region.
-
brownian_motion_simulation_test
-
buckling_spring,
a program which
plots solutions of the buckling spring equations.
-
buckling_spring_test
-
burgers_solution,
a library which
evaluates exact solutions
of the time-dependent 1D viscous Burgers equation.
-
burgers_solution_test
-
burgers_steady_viscous,
a library which
solves the steady (time-independent) viscous Burgers equation
using the finite difference method (FDM) applied to the
conservative form of the equation, using Newton's method to solve the
resulting nonlinear system.
-
burgers_steady_viscous_test
-
burgers_time_inviscid,
a library which
solves the time-dependent inviscid Burgers equation
using the finite difference method (FDM), and one of six solution
methods selected by the user.
-
burgers_time_inviscid_test
-
burgers_time_viscous,
a library which
solves the time-dependent viscous Burgers equation
using the finite difference method (FDM) applied to the
conservative form of the equation.
-
burgers_time_viscous_test
-
bvec,
a library which
demonstrates how signed integers can be stored as
binary vectors, and arithmetic can be performed on them.
-
bvec_test
-
bvp4c_test
-
c8lib,
a library which
implements certain elementary functions for
double precision complex ("C8") variables;
-
c8lib_test
-
caesar,
a library which
can apply a Caesar Shift Cipher to a string of text.
-
caesar_test
-
calendar_nyt,
a library which
shows the correspondence between dates and
the New York Times volume and issue number;
-
calendar_nyt_test
-
calpak,
a library which
makes various calendar calculations;
-
calpak_test
-
cauchy_principal_value,
a library which
uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value
(CPV) of certain singular integrals.
-
cauchy_principal_value_test
-
cavity_flow_display,
a library which
displays a single velocity field solution for the driven cavity;
-
cavity_flow_display_test
-
cavity_flow_movie,
a library which
animates the velocity solutions for the driven cavity;
-
cc_display,
a program which
displays the points used in a 2D Clenshaw-Curtis quadrature rule;
-
cc_display_test
-
cc_io
a library which
reads and writes sparse linear systems
stored in the Compressed Column (CC) format.
-
cc_io_test
-
cc_project,
a library which
investigates generalized Clenshaw-Curtis quadrature rules
for semi-infinite and infinite intervals, by John Boyd.
-
cc_project_test
-
cc_to_st
a library which
converts a sparse matrix from compressed column (CC) to
sparse triplet (ST) format.
-
cc_to_st_test
-
ccl_test
-
ccn_rule,
a program which
defines a Clenshaw Curtis Nested (CCN) quadrature rule.
-
ccn_rule_test
-
ccvt_box,
a program which
calculates a Constrained Centroidal Voronoi Tessellation (CCVT)
for points constrained to lie in a box, with some points moved
to the boundary;
-
ccn_box_test
-
ccvt_reflect,
a program which
calculates a Constrained Centroidal Voronoi Tessellation (CCVT)
for points constrained to lie in a box, with some points pushed
towards the boundary;
-
ccn_reflect_test
-
cell,
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.
-
cell_test
-
cellular_automaton,
a program which
demonstrates the 1D Cellular Automaton known as rule #30.
-
cellular_automaton_test
-
cg,
a library which
implements a simple version of the conjugate gradient (CG) method
for solving a system of linear equations of the form A*x=b,
suitable for situations in which the matrix A is positive definite
(only real, positive eigenvalues) and symmetric.
-
cg_test
-
cg_lab_triangles,
a collection of programs associated with a computer lab
assignment on computational geometry and triangles;
-
cg_rc,
a library which
implements the conjugate gradient (CG) method for solving
a positive definite sparse linear system A*x=b,
using reverse communication (RC).
-
cg_rc_test
-
chain_letter_tree,
a program which
analyzes a similarity matrix for 11 versions of a single chain letter
and produces a dendrogram or tree diagram that suggests the degrees
of relatedness and the evolutionary history of the letters.
-
change_making,
a library which
considers the change making problem,
in which a given sum is to be formed using coins of various denominations.
-
change_making_test
-
chebyshev,
a library which
computes the Chebyshev interpolant/approximant to a given function
over an interval.
-
chebyshev_test
-
chebyshev_interp_1d,
a library which
determines the combination of Chebyshev polynomials which
interpolates a set of data, so that p(x(i)) = y(i).
-
chebyshev_interp_1d_test
-
chebyshev_polynomial,
a library which
considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x).
-
chebyshev_polynomial_test
-
chebyshev_series,
a library which
can evaluate a Chebyshev series approximating a function f(x),
while efficiently computing one, two or three derivatives of the
series, which approximate f'(x), f''(x), and f'''(x),
by Manfred Zimmer.
-
chebyshev_series_test
-
chebyshev1_exactness,
a program which
tests the polynomial exactness of
Gauss-Chebyshev type 1 quadrature rules.
-
chebyshev1_exactness_test
-
chebyshev1_rule,
a program which
computes and writes out a Gauss-Chebyshev type 1 quadrature rule
of given order.
-
chebyshev1_rule_test
-
chebyshev2_exactness,
a program which
tests the polynomial exactness of Gauss-Chebyshev type 2
quadrature rules.
-
chebyshev2_exactness_test
-
chebyshev2_rule,
a program which
computes and writes out a Gauss-Chebyshev type 2 quadrature rule
of given order.
-
chebyshev2_rule_test
-
chrpak,
a library which
manipulates characters and strings;
-
chrpak_test
-
chuckaluck_simulation,
a program which
simulates the Chuck-a-Luck gambling game.
-
chuckaluck_simulation_test
-
circle_arc_grid,
a program which
computes grid points along a circular arc.
-
circle_arc_grid_test
-
circle_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected on the unit circle.
-
circle_distance_test
-
circle_grid_display
a program which
reads a matrix of integers, and draws a corresponding
grid of circles filled with color.
-
circle_grid_display_test
-
circle_integrals,
a library which
returns the exact value of the integral of any monomial
over the circumference of the unit circle in 2D.
-
circle_integrals_test
-
circle_map,
a library which
illustrates how a matrix maps points on the unit circle to an ellipse.
-
circle_map_test
-
circle_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
along the circumference of the unit circle in 2D;
-
circle_monte_carlo_test
-
circle_rule,
a library which
computes quadrature rules for the unit circle in 2D, that is, the
circumference of the circle of radius 1 and center (0,0).
-
circle_rule_test
-
circle_segment,
a library which
carries out computations associated with a circle segment, including
height, angle, area, centroid, sampling, and quadrature.
-
circle_segment_test
-
circles,
a library which
can be used, when creating graphics, to draw one or more circles,
while controlling the center locations, radii, colors, edge
colors, and transparency, by Chad Greene.
-
circles_test
-
cities,
a library which
works with city-to-city distance matrices;
-
cities_test
-
clausen,
a library which
evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
-
clausen_test
-
clenshaw_curtis_rule,
a program which
implements a Clenshaw Curtis quadrature rule;
-
clenshaw_curtis_rule_test
-
cnoise,
a library which
generates samples of noise obeying a 1/f^alpha power law,
by Miroslav Stoyanov.
-
cnoise_test
-
coin_simulation,
a library which
looks at ways of simulating or visualizing the results of
many tosses of a fair or biased coin.
-
coin_simulation_test
-
collatz,
a library which
computes and analyzes the Collatz
sequence, also known as the hailstone sequence or 3n+1 sequence;
-
collatz_test
-
collatz_recursive,
a library which
demonstrates recursive programming by considering
the simple Collatz 3n+1 problem.
-
collatz_recursive_test
-
collocation,
a library which
demonstrates the use of collocation
to produce a function g(x) that satisfies the same constraints
as a function f(x), but only at a discrete set of points.
-
collocation_test
-
colored_noise,
a library which
generates samples of noise obeying a 1/f^alpha power law.
-
colored_noise_test
-
combination_lock,
a program which
simulates the process of determining the secret combination of a lock.
-
combination_lock_test
-
combo,
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.
-
combo_test
-
compass_search,
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.
-
compass_search_test
-
complex_numbers_test
-
complexity_test
-
condition,
a library which
implements methods of computing or estimating
the condition number of a matrix.
-
condition_test
-
continuation,
a library which
implements the continuation method for a simple 2D problem.
-
continuation_test
-
continued_fraction
a library which
implements some simple algorithms for dealing with simple and
generalized continued fractions.
-
continued_fraction_test
-
contour_gradient,
a program which
displays contours and gradient vectors for a function f(x,y).
-
contour_gradient_test
-
contour_gradient_3d,
a program which
displays contours and gradient vectors for a function f(x,y)
in a 3D display.
-
contour_gradient_3d_test
-
contour_sequence4,
a program which
creates images suitable for animation
from one XY file and a sequence of u(x,y) data files;
-
contour_sequence4_test
-
convex_hull,
a program which
demonstrates the computation of the convex hull of a set of 2D points.
-
convex_hull_test
-
coordinate_search,
a program which
seeks the minimizer of a scalar function of several variables,
by Jeff Borggaard.
-
coordinate_search_test
-
cordic,
a library which
computes a few special functions using the CORDIC algorithm.
-
cordic_test
-
correlation,
a library which
contains statistical correlation functions.
-
correlation_test
-
cosine_transform,
a library which
demonstrates some simple properties of the discrete cosine transform (DCT).
-
cosine_transform_test
-
counterfeit_detection,
a library which
considers problems in which one or more counterfeit coins
are to be identified by the fact that they do not have the standard weight.
-
counterfeit_detection_test
-
cplex_solution_read,
a program which
extracts solution data from a CPLEX result file.
-
cplex_solution_read_test
-
cube_arbq_rule,
a library which
returns quadrature rules,
with exactness up to total degree 15,
over the interior of the symmetric cube in 3D,
by Hong Xiao and Zydrunas Gimbutas.
-
cube_arbq_rule_test
-
cube_display,
a program which
displays a cube plot, over integer triples of data, of a function
defined by two formulas, using plotcube.m, by Thomas Montagnon.
-
cube_display_test
-
cube_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected in the unit cube in 3D.
-
cube_distance_test
-
cube_exactness,
a library which
investigates the polynomial exactness of quadrature rules
over the interior of a cube in 3D.
-
cube_exactness_test
-
cube_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a cube in 3D.
-
cube_felippa_rule_test
-
cube_grid,
a library which
computes a grid of points
over the interior of a cube in 3D.
-
cube_grid_test
-
cube_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit cube in 3D.
-
cube_integrals_test
-
cube_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit cube in 3D.
-
cube_monte_carlo_test
-
cuda_loop,
a library which
shows how, in a CUDA program, the user's choice of block and
thread factors determines the allocation of tasks to processors.
-
cuda_loop_test
-
cvt,
a library which
computes an N-point Centroidal Voronoi Tessellation (CVT)
in M dimensions;
-
cvt_1d_lloyd,
a program which
computes an N-point Centroidal Voronoi Tessellation (CVT)
within the interval [0,1], under a uniform density,
using Lloyd's method to compute the Voronoi regions exactly.
-
cvt_1d_lloyd_test
-
cvt_1d_lumping,
a program which
allows the user to carry out a lumped version of Lloyd's iterative
algorithm for a centroidal Voronoi Tessellation (CVT() in the interval
[-1,+1], and is applied to investigate a relationship between CVT's
and the Chebyshev Zero nodes.
-
cvt_1d_lumping_test
-
cvt_1d_nonuniform,
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;
-
cvt_1d_nonuniform_test
-
cvt_1d_sampling,
a program which
computes an N-point Centroidal Voronoi Tessellation (CVT)
within the interval [0,1], under a uniform density,
using sampling to estimate the Voronoi regions.
-
cvt_1d_sampling_test
-
cvt_2d_lumping,
a program which
computes an N-point Centroidal Voronoi Tessellation (CVT)
within the unit square [-1,1]^2, under a Chebyshev density,
using weighted sampling ("lumping") to estimate the Voronoi regions.
-
cvt_2d_sampling,
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.
-
cvt_2d_sampling_test
-
cvt_3d_lumping,
a program which
computes an N-point Centroidal Voronoi Tessellation (CVT)
within the unit cube [-1,1]^3, under a Chebyshev density,
using weighted sampling ("lumping") to estimate the Voronoi regions.
-
cvt_3d_sampling,
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.
-
cvt_circle_nonuniform,
a program which
demonstrates the computation of a centroidal Voronoi Tessellation (CVT)
over a circular region, using a nonuniform density.
-
cvt_circle_nonuniform_test
-
cvt_circle_uniform,
a program which
demonstrates the computation of a centroidal Voronoi Tessellation (CVT)
over a circular region, using a uniform density.
-
cvt_circle_uniform_test
-
cvt_corn,
a program which
studies a 2D model of the growth of a corn kernel, by treating
the surface and interior biological cells as points to be
organized by a Centroidal Voronoi Tessellation (CVT)
with a nonuniform density; during a sequence of growth steps,
new biological cells are randomly added to the surface and interior.
-
cvt_ellipse_uniform,
a program which
iteratively calculates a Centroidal Voronoi Tessellation (CVT)
over an ellipse, with a uniform density.
-
cvt_ellipse_uniform_test
-
cvt_example_fifty_points,
a program which
illustrates the steps involved in the calculation of a
Centroidal Voronoi Tessellation (CVT) of the unit square,
with 50 generator points.
-
cvt_example_five_points,
a program which
illustrates the steps involved in the calculation of a
Centroidal Voronoi Tessellation (CVT) of the unit square,
with 5 generator points.
-
cvt_metric,
a program which
computes a Centroidal Voronoi Tessellation (CVT)
under a spatially varying metric;
-
cvt_movie,
a program which
creates an animation of the evolution of a
Centroidal Voronoi Tessellation (CVT);
-
cvt_movie2,
a program which
creates a Centroidal Voronoi Tessellation (CVT) movie;
-
cvt_movie3,
a program which
creates a Centroidal Voronoi Tessellation (CVT) movie
in a region of unusual shape;
-
cvt_movie4,
a program which
creates a Centroidal Voronoi Tessellation (CVT) movie in a square,
with a density function that drives points to the corners;
-
cvt_movie5,
a program which
repeats cvt_movie3, but with hexagonal
grid initialization, fixed points, and boundary projection;
-
cvt_square_nonuniform,
a program which
iteratively calculates a Centroidal Voronoi Tessellation (CVT)
over a square, with a nonuniform density.
-
cvt_square_nonuniform_test
-
cvt_square_pdf_discrete,
a program which
iteratively calculates a Centroidal Voronoi Tessellation (CVT)
over a square, with a density determined from a discrete PDF.
-
cvt_square_pdf_discrete_test
-
cvt_square_uniform,
a program which
iteratively calculates a Centroidal Voronoi Tessellation (CVT)
over a square, with a uniform density.
-
cvt_square_uniform_test
-
cvt_triangle_uniform,
a program which
iteratively calculates a Centroidal Voronoi Tessellation (CVT)
over a triangle, with a uniform density.
-
cvt_triangle_uniform_test
-
cvtm_1d,
a program which
estimates a mirror-periodic centroidal Voronoi Tessellation (CVTM)
in the periodic interval [0,1], using a version of Lloyd's iteration.
-
cvtm_1d_test
-
cvtp,
a library which
creates a CVTP dataset, that is, a Centroidal Voronoi Tessellation
on a periodic region.
-
cvtp_test
-
cvtp_1d,
a program which
estimates a periodic centroidal Voronoi Tessellation (CVTP) in the
periodic interval [0,1], using a version of Lloyd's iteration.
-
cvtp_1d_test
-
cycle_brent,
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.
-
cycle_brent_test
-
cycle_floyd,
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.
-
cycle_floyd_test
-
cyclic_reduction,
a library which
solves a tridiagonal linear system using cyclic reduction;
-
cyclic_reduction_test
-
dg1d_advection,
a library which
uses the Discontinuous Galerkin Method (DG) to approximate a
solution of the advection equation.
The original version of the code was written by Jan Hesthaven
and Tim Warburton.
-
dg1d_advection_test
-
dg1d_burgers,
a library which
uses the Discontinuous Galerkin Method (DG) to approximate a
solution of the unsteady 1D Burgers equation.
The original version of the code was written by Jan Hesthaven
and Tim Warburton.
-
dg1d_burgers_test
-
dg1d_heat,
a library which
uses the Discontinuous Galerkin Method (DG) to approximate a
solution of the unsteady 1D heat equation.
The original version of the code was written by Jan Hesthaven
and Tim Warburton.
-
dg1d_heat_test
-
dg1d_maxwell,
a library which
uses the Discontinuous Galerkin Method (DG) to approximate a
solution of Maxwell's equations.
The original version of the code was written by Jan Hesthaven
and Tim Warburton.
-
dg1d_maxwell_test
-
dg1d_poisson,
a program which
applies the discontinuous Galerkin method (DG) to a 1D version of
the Poisson equation;
the original version of the code was written by Beatrice Riviere.
-
dg1d_poisson_test
-
diaphony,
a program which
reads a file of N points in M dimensions and computes its diaphony,
a measure of point dispersion.
-
diaphony_test
-
dice_simulation,
a program which
simulates N tosses of M dice, making a histogram of the results.
-
dice_simulation_test
-
dictionary_code,
a library which
demonstates how a text file can be compressed and decompressed
using a dictionary code.
-
dictionary_code_test
-
differ,
a library which
determines the finite difference coefficients necessary in order to
combine function values at known locations to compute an approximation
of given accuracy to a derivative of a given order.
-
differ_test
-
digital_dice,
a library which
contains the scripts used to carry out the probability simulations
described in Paul Nahin's "Digital Dice";
-
digital_dice_test
-
dijkstra,
a library which
implements a simple version of Dijkstra's minimum distance algorithm
for graphs.
-
dijkstra_test
-
discrete_pdf_sample_2d,
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.
-
discrete_pdf_sample_2d_test
-
disk_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected in the unit disk.
-
disk_distance_test
-
disk_grid,
a library which
computes grid points within the interior of
a disk of user specified radius and center in 2D,
using gnuplot to create an image of the grid.
-
disk_grid_test
-
disk_integrands,
a library which
defines several test integrals over the unit disk, making it possible
to check the accuracy of quadrature rules.
-
disk_integrands_test
-
disk_monte_carlo,
a library which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the general disk in 2D.
-
disk_monte_carlo_test
-
disk_rule,
a library which
computes quadrature rules for the general disk in 2D.
-
disk_rule_test
-
disk01_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit disk in 2D.
-
disk01_integrals_test
-
disk01_monte_carlo,
a library which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the unit disk in 2D;
-
disk01_monte_carlo_test
-
disk01_quarter_monte_carlo,
a library which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the unit quarter disk in 2D;
-
disk01_quarter_monte_carlo_test
-
disk01_quarter_rule,
a program which
computes a quadrature rule for the unit quarter disk in 2D,
that is, the interior of the circle of radius 1 and center (0,0).
-
disk01_quarter_rule_test
-
disk01_rule,
a library which
computes quadrature rules for the unit disk in 2D.
-
disk01_rule_test
-
dist_plot,
a program which
makes contour plots of the distance function,
as defined and used in Persson and Strang's
distmesh() code;
-
dist_plot_test
-
distance_to_position,
a program which
estimates the positions of cities which minimizes the discrepancy
with a city-to-city distance table.
-
distance_to_position_test
-
distance_to_position_sphere,
a program which
estimates the positions of cities on a sphere (such as the earth)
based on a city-to-city distance table.
-
distance_to_position_sphere_test
-
distmesh,
a library which
carries out a method of mesh generation;
by Per-Olof Persson and Gilbert Strang.
-
distmesh_test
-
distmesh_3d,
a library which
carries out a method of mesh generation in 3D,
by Per-Olof Persson and Gilbert Strang.
-
distmesh_3d_test
-
divdif,
a library which
uses divided differences to compute the polynomial interpolant
to a given set of data.
-
divdif_test
-
dlap_io,
a library which
reads and writes DLAP sparse matrix files;
-
dlap_io_test
-
doomsday,
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.
-
doomsday_test
-
double_c_data,
programs which
generate, plot or write out 2D data that forms two interlocking
"C" shapes.
-
double_c_data_test
-
dream,
a program which
implements the DREAM algorithm for accelerating
Markov Chain Monte Carlo (MCMC) convergence using differential
evolution,
using five user functions to define the problem, by Guannan Zhang.
-
dream_test
-
drug_dosage,
a program which
simulates the variation in the blood levels of
a medicinal drug being administered at specific dosages and times over
a course of treatment. The level should rise about a given medicinal
level for some time, but stay below the toxic level.
-
drug_dosage_test
-
duel_simulation,
a program which
simulates N repetitions of a duel between two players, each of
whom has a known firing accuracy.
-
duel_simulation_test
-
dueling_idiots,
a library which
contains the scripts used to carry out the probability simulations
described in Paul Nahin's "Dueling Idiots";
-
dueling_idiots_test
-
e_spigot,
a program which
produces N digits of the decimal expansion of e.
-
e_spigot_test
-
earth_sphere,
a program which
can display a 3D image of the earth;
-
earth_sphere_test
-
edge,
a library which
defines some test functions in 1D, 2D and 3D
for the detection of edges or discontinuities.
-
edge_test
-
eigenfaces,
a MATLAB library which
applies principal component analysis to a set of images.
-
eigenfaces_test
-
ellipse_grid,
a library which
computes a grid of points
over the interior of an ellipse in 2D.
-
ellipse_grid_test
-
ellipse_monte_carlo,
a library which
uses the Monte Carlo method to estimate the value of integrals
over the interior of an ellipse in 2D.
-
ellipse_monte_carlo_test
-
ellipsoid_grid,
a library which
computes a grid of points
over the interior of an ellipsoid in 3D.
-
ellipsoid_grid_test
-
ellipsoid_monte_carlo,
a library which
uses the Monte Carlo method to estimate the value of integrals
over the interior of an ellipsoid in M dimensions.
-
ellipsoid_monte_carlo_test
-
elliptic_integral,
a library which
evaluates complete elliptic integrals of first, second and third kind,
using Carlson's elliptic integral functions.
-
elliptic_integral_test
-
entrust,
a library which
uses trust-region methods to solve problems in scalar optimization
or nonlinear least squares (NLS),
by Jeff Borggaard and Gene Cliff.
-
entrust_test
-
epicycloid,
a library which
computes, plots and tabulates an epicycloid curve.
-
epicycloid_test
-
equidistribution,
investigates equidistribution properties relating to density functions
and point sets.
-
equidistribution_test
-
errors,
programs which
illustrate the failure of numerical algorithms;
-
errors_test
-
exactness,
a library which
investigates the exactness of quadrature rules that estimate the
integral of a function with a density, such as 1, exp(-x) or
exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).
-
exactness_test
-
exm,
a library which
illustrates the computational experiments in
"Experiments with Matlab", by Cleve Moler.
-
faces_average,
a program which
averages several images of the same face;
-
faces_average_test
-
fair_dice_simulation,
a program which
simulates N tosses of 2 dice, making a histogram of the results.
-
fair_dice_simulation_test
-
fastgl,
a library which
carries out the rapid computation of the Kth value and weight of
an N point Gauss-Legendre quadrature rule,
by Ignace Bogaert.
-
fastgl_test
-
faure,
a library which
computes the Faure M dimensional Quasi Mont Carlo (QMC) sequence;
-
faure_test
-
fd_predator_prey,
a program which
solves a time-dependent predator prey system using the
finite difference method (FDM).
-
fd_predator_prey_test
-
fd1d_advection_diffusion_steady,
a program which
applies the finite difference method (FDM) to solve the
steady advection diffusion equation v*ux-k*uxx=0 in
one spatial dimension, with constant velocity v and diffusivity k.
-
fd1d_advection_diffusion_steady_test
-
fd1d_advection_ftcs,
a program which
applies the finite difference method (FDM) to solve the time-dependent
advection equation ut = - c * ux in one spatial dimension, with
a constant velocity, using the forward time centered space (FTCS)
difference scheme.
-
fd1d_advection_ftcs_test
-
fd1d_advection_lax,
a program which
applies the finite difference method (FDM) to solve the time-dependent
advection equation ut = - c * ux in one spatial dimension, with
a constant velocity, using the Lax method to approximate the
time derivative.
-
fd1d_advection_lax_test
-
fd1d_advection_lax_wendroff,
a program which
applies the finite difference method (FDM) to solve the time-dependent
advection equation ut = - c * ux in one spatial dimension, with
a constant velocity, using the Lax-Wendroff method to approximate the
time derivative.
-
fd1d_advection_lax_wendroff_test
-
fd1d_burgers_lax,
a program which
applies the finite difference method (FDM) and the Lax Wendroff method
to solve the non-viscous time-dependent Burgers equation
in one spatial dimension.
-
fd1d_burgers_lax_test
-
fd1d_burgers_leap,
a program which
applies the finite difference method (FDM) and the leapfrog approach
to solve the non-viscous time-dependent Burgers equation
in one spatial dimension.
-
fd1d_burgers_leap_test
-
fd1d_bvp,
a program which
applies the finite difference method (FDM)
to a two point boundary value problem (BVP) in one spatial dimension.
-
fd1d_bvp_test
-
fd1d_display,
a program which
reads a pair of files defining a 1D model for the
finite difference method (FDM), and plots the data.
-
fd1d_display_test
-
fd1d_heat_explicit,
a library which
implements a finite difference method (FDM), explicit in time,
to solve the time dependent 1D heat equation;
-
fd1d_heat_explicit_test
-
fd1d_heat_implicit,
a program which
implements a finite difference method (FDM), implicit in time,
to solve the time dependent 1D heat equation;
-
fd1d_heat_implicit_test
-
fd1d_heat_steady,
a program which
implements a finite difference method (FDM) for the steady
(time independent) 1D heat equation;
-
fd1d_heat_steady_test
-
fd1d_predator_prey,
a program which
implements a finite difference method (FDM) for a time and
1D space dependent predator-prey system,
by Marcus Garvie.
-
fd1d_predator_prey_test
-
fd1d_predator_prey_plot,
a program which
plots solutions from the fd1d_predator_prey program,
by Marcus Garvie.
-
fd1d_predator_prey_plot_test
-
fd1d_wave,
a library which
applies the finite difference method (FDM) to solve the time-dependent
wave equation utt = c * uxx in one spatial dimension.
-
fd1d_wave_test
-
fd2d_heat_steady,
a program which
implements a finite difference method (FDM) for the steady
(time independent) 2D heat equation;
-
fd2d_heat_steady_test
-
fd2d_predator_prey,
a program which
implements a finite difference method (FDM) for a
time and 2D space dependent predator-prey system,
by Marcus Garvie.
-
fd2d_predator_prey_test
-
fe2d_predator_prey_fast,
programs which
implement a finite element method (FEM) for a
time and 2D space dependent predator-prey system,
on an arbitrary triangulated region,
with a variety of possible boundary conditions,
incorporating some Matlab optimizations,
by Marcus Garvie.
-
fe2d_predator_prey_fast_test
-
fem_basis,
a library which
can define and evaluate finite element method (FEM) basis functions
for any degree in an M dimensional simplex (1D interval, 2D triangle,
3D tetrahedron, and higher dimensional generalizations.)
-
fem_basis_test
-
fem_basis_q4_display,
a program which
displays any single finite element method (FEM) basis function
associated with an arbitrary linear quadrilateral Q4 mesh;
-
fem_basis_q4_display_test
-
fem_basis_t3_display,
a program which
displays a basis function for the finite element method (FEM)
associated with an arbitrary 3-node triangle T3 mesh;
-
fem_basis_t3_display_test
-
fem_basis_t4_display,
a program which
displays a basis function for the finite element method (FEM)
associated with an arbitrary 4-node triangle T4 mesh;
-
fem_basis_t6_display,
a program which
displays a basis function for the finite element method (FEM)
associated with an arbitrary 6-node triangle T6 mesh;
-
fem_io,
a library which
reads or writes FEM files,
which describe the nodes, elements, and function values
associated with a finite element method (FEM) model;
-
fem_io_test
-
fem_neumann,
a program which
sets up a time-dependent reaction-diffusion equation in 1D,
with Neumann boundary conditions,
discretized using the finite element method (FEM).
-
fem_neumann_test
-
fem_to_gmsh,
a program which
reads a pair of FEM files defining node coordinates and elements,
of a 1D, 2D or 3D mesh, namely
a file of node coordinates and a file of elements defined by
node indices, and creates a Gmsh mesh file.
-
fem_to_gmsh_test
-
fem_to_mesh,
a program which
reads a set of FEM files defining the node coordinates, boundary nodes,
and elements of a finite element mesh, and rewrites the data as a MESH file.
-
fem_to_mesh_test
-
fem_to_triangle,
a program which
reads FEM files defining a 2D mesh of triangles, namely
a file of node coordinates and a file of elements defined by
node indices, and creates a corresponding pair of node
and element files for use by Jonathan Shewchuk's triangle program.
-
fem_to_triangle_test
-
fem_to_xml,
reads a pair of FEM files defining node coordinates and elements,
of a 1D, 2D or 3D mesh, namely
a file of node coordinates and a file of elements defined by
node indices, and creates a corresponding XML file for input
to DOLFIN or FENICS.
-
fem_to_xml_test
-
fem1d,
a program which
applies the finite element method (FEM),
using piecewise linear basis functions, to a linear
two point boundary value problem (BVP) in 1D;
-
fem1d_test
-
fem1d_adaptive,
a program which
uses an adaptive mesh when
applying the finite element method (FEM),
with piecewise linear basis functions, to a linear
two point boundary value problem (BVP) in 1D;
-
fem1d_adaptive_test
-
fem1d_approximate,
a program which
uses a given finite element mesh and piecewise linear basis functions
to approximate a set of data points,
while controlling the variation in the derivative.
-
fem1d_approximate_test
-
fem1d_bvp_linear,
a program which
applies the finite element method (FEM), with piecewise linear elements,
to a two point boundary value problem (BVP) in one spatial dimension,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem1d_bvp_linear_test
-
fem1d_bvp_quadratic,
a program which
applies the finite element method (FEM),
with piecewise quadratic elements,
to a two point boundary value problem (BVP) in one spatial dimension,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem1d_bvp_quadratic_test
-
fem1d_display,
a program which
reads three files defining a 1D arbitrary degree basis function
associated with the finite element method (FEM),
and displays a plot.
-
fem1d_display_test
-
fem1d_function_10_display,
a program which
reads three files defining a 1D piecewise linear finite element method (FEM)
function and displays a plot.
-
fem1d_display_function_10_test
-
fem1d_heat_explicit,
a program which
uses the finite element method (FEM) and explicit time stepping
to solve the time dependent heat equation in 1D.
-
fem1d_heat_explicit_test
-
fem1d_heat_implicit,
a program which
uses the finite element method (FEM) and implicit time stepping
to solve the time dependent heat equation in 1D.
-
fem1d_heat_implicit_test
-
fem1d_heat_steady,
a program which
implements the finite element method (FEM) for the steady
(time independent) 1D heat equation;
-
fem1d_heat_steady_test
-
fem1d_lagrange,
a library which
sets up the matrices and vectors associated with the finite element
method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x),
using Lagrange basis polynomials.
-
fem1d_lagrange_test
-
fem1d_nonlinear,
a program which
applies the finite element method (FEM),
with piecewise linear basis functions, to a nonlinear
two point boundary value problem (BVP) in 1D;
-
fem1d_nonlinear_test
-
fem1d_pack,
a library which
contains utilities for 1D finite element method (FEM) calculations.
-
fem1d_pack_test
-
fem1d_pmethod,
a program which
applies the p-method version of
the finite element method (FEM) to a linear
two point boundary value problem (BVP) in 1D;
-
fem1d_pmethod_test
-
fem1d_project,
a program which
projects data into a finite element space, including the least squares
approximation of data, or the projection of a finite element solution
from one mesh to another.
-
fem1d_project_test
-
fem1d_sample,
a program which
samples a scalar or vector finite element function of one variable,
defined by FEM files,
returning interpolated values at the sample points.
-
fem1d_sample_test
-
fem1d_spectral_numeric,
a program which
applies the spectral finite element method (FEM) to solve the problem
u'' = - pi^2 sin(x) over [-1,+1] with zero boundary conditions,
using as basis elements the functions x^n*(x-1)*(x+1),
and carrying out the integration numerically,
using MATLAB's quad() function,
by Miro Stoyanov.
-
fem1d_spectral_numeric_test
-
fem1d_spectral_symbolic,
a program which
applies the spectral finite element method (FEM) to solve the problem
u'' = - pi^2 sin(x) over [-1,+1] with zero boundary conditions,
using as basis elements the functions x^n*(x-1)*(x+1),
and carrying out the integration using MATLAB's symbolic toolbox,
by Miro Stoyanov.
-
fem1d_spectral_symbolic_test
-
fem2d_bvp_linear,
a program which
applies the finite element method (FEM),
with piecewise bilinear elements,
to a 2D boundary value problem (BVP) in a rectangle,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem2d_bvp_linear_test
-
fem2d_bvp_quadratic,
a program which
applies the finite element method (FEM),
with piecewise quadratic elements,
to a 2D boundary value problem (BVP) in a rectangle,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem2d_bvp_quadratic_test
-
fem2d_bvp_serene,
a program which
applies the finite element method (FEM), with serendipity elements,
to a 2D boundary value problem (BVP) in a rectangle,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem2d_bvp_serene_test
-
fem2d_heat,
a program which
applies the finite element method (FEM) to the time dependent
heat equation on an arbitrary triangulated region in 2D;
-
fem2d_heat_test
-
fem2d_heat_rectangle,
a program which
applies the finite element method (FEM) for the time-dependent
heat equation on a triangulated square in 2D;
-
fem2d_heat_sparse,
a program which
applies the finite element method (FEM) to the heat equation
on an arbitrary triangulated region in 2D, using MATLAB's
sparse matrix features;
-
fem2d_heat_sparse_test
-
fem2d_mesh_display,
a program which
reads a FEM model of a 2D mesh of elements of any uniform order
and displays a plot of the elements and nodes,
with optional numbering.
-
fem2d_mesh_display_test
-
fem2d_pack,
a library which
performs simple 2D finite element method (FEM) computations;
-
fem2d_pack_test
-
fem2d_poisson_rectangle,
a program which
solves the 2D Poisson equation on a rectangle,
using the finite element method (FEM),
and piecewise quadratic triangular elements.
-
fem2d_poisson_rectangle_linear,
a program which
solves the 2D Poisson equation on a rectangle,
using the finite element method (FEM),
and piecewise linear triangular elements.
-
fem2d_project,
a program which
projects a function f(x,y), given as data,
into a given finite element space
of piecewise linear triangular elements.
-
fem2d_project_test
-
fem2d_project_function,
a program which
projects a function f(x,y), given as a formula,
into a given finite element space
of piecewise linear triangular elements.
-
fem2d_project_function_test
-
fem2d_sample,
a program which
samples a finite element
function, defined by FEM files,
(three text files describing the nodes, triangles, and coefficients);
at arbitrary points.
-
fem2d_sample_test
-
fem2d_scalar_display,
a program which
reads information about nodes, elements and nodal values for a
2D finite element method (FEM) and creates a surface plot of U(X,Y),
using the MATLAB graphics system.
-
fem2d_scalar_display_test,
a program which
reads information about nodes, elements and nodal values for a
2D finite element method (FEM) and creates a surface plot of U(X,Y),
using the MATLAB graphics system.
-
fem2d_scalar_display_brief,
a program which
reads information about nodes, elements and nodal values for a
2D finite element method (FEM) and creates a surface plot of U(X,Y),
using the MATLAB graphics system, in 5 lines of code.
-
fem2d_scalar_display_brief_test
-
fem2d_scalar_display_gpl,
a program which
reads information about nodes, elements and nodal values for a
2D finite element method (FEM) and creates a GPL file describing
a surface plot of U(X,Y), which can be displayed by GNUPLOT.
-
fem2d_scalar_display_gpl_test,
-
fem3d_pack,
a library which
contains utilities for 3D finite element method (FEM) calculations.
-
fem3d_pack_test
-
fem3d_project,
a program which
projects a function f(x,y,z), given as a data,
into a given space of piecewise linear tetrahedral elements
for use in the finite element method (FEM).
-
fem3d_project_test
-
fem3d_sample,
a program library which
evaluates a function defined on a 3D tetrahedral mesh as part of
the finite element method (FEM).
-
fem3d_sample_test
-
fern,
a program which
uses MATLAB graphics to compute and display the Barnsley fractal fern.
-
fern_test
-
feynman_kac_1d,
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.
-
feynman_kac_1d_test
-
feynman_kac_2d,
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.
-
feynman_kac_2d_test
-
feynman_kac_3d,
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.
-
feynman_kac_1d_test
-
fft_serial,
a program which
computes a Fast Fourier Transform (FFT), and is intended as
a starting point for implementing a parallel version.
-
fft_serial_test
-
fibonacci_spiral,
a program which
displays points on a Fibonacci spiral, suggesting the arrangement
of seeds in a sunflower, for instance.
-
fibonacci_spiral_test
-
file_increment,
a program which
makes a copy of a file containing an integer array,
after incrementing each entry by a given value.
-
file_increment_test
-
file_name_sequence,
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.
-
file_name_sequence_test
-
files_multiple_test
-
filon,
a library which
can approximate integrals in which the integrand includes an
oscillatory factor of sin(k*x) or cos(k*x).
-
filon_test
-
filum,
a library which
handles files and filenames;
-
filum_test
-
fire_serial,
a program which
simulates a forest fire over a rectangular array of trees,
starting at a single random location. It is intended as a starting
point for the development of a parallel version.
-
fire_serial_test
-
fitnlm_test
-
flame_ode,
a library which
considers an ordinary differential equation (ODE) which models
the growth of a ball of flame in a combustion process.
-
fire_serial_test
-
florida_cvt_geo,
programs which
explore the creation of a centroidal Voronoi Tessellation (CVT) of
the state of Florida, based solely on geometric considerations.
-
florida_cvt_pop,
programs which
explore the creation of a centroidal Voronoi Tessellation (CVT) of
the state of Florida, based on population considerations.
-
floyd,
a library which
implements Floyd's algorithm for finding the shortest distance
between pairs of nodes on a directed graph.
-
floyd_test
-
fmincon_test
-
fn,
a library which
evaluates elementary and special functions using Chebyshev polynomials;
functions include Airy, Bessel I, J, K and Y, beta,
confluent hypergeometric, error, gamma, log gamma, Pochhammer, Spence;
integrals include hyperbolic cosine, cosine, Dawson, exponential,
logarithmic, hyperbolic sine, sine; by Wayne Fullerton.
-
fn_test
-
freefem_msh_io,
a library which
can read and write files used by the FreeFem++ finite element program
to store mesh information.
-
freefem_msh_io_test
-
gamblers_ruin_simulation,
a program which
simulates the game of gambler's ruin.
-
gamblers_ruin_simulation_test
-
gauss_seidel,
a program which
implements the Gauss-Seidel iteration for linear systems.
-
gauss_seidel_test
-
gauss_seidel_poisson_1d,
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.
-
gauss_seidel_poisson_1d_test
-
gegenbauer_cc,
a library which
computes the Gegenbauer weighted integral of a function f(x)
using a Clenshaw-Curtis approach.
-
gegenbauer_cc_test
-
gegenbauer_exactness,
a program which
tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
-
gegenbauer_exactness_test
-
gegenbauer_polynomial,
a library which
evaluates the Gegenbauer polynomial and associated functions.
-
gegenbauer_polynomial_test
-
gegenbauer_rule,
a program which
computes and writes out a Gauss-Gegenbauer quadrature rule
of given order.
-
gegenbauer_rule_test
-
gen_hermite_exactness,
a program which
tests the polynomial
exactness of generalized Gauss-Hermite quadrature rules.
-
gen_hermite_exactness_test
-
gen_hermite_rule,
a program which
computes and writes out a generalized Gauss-Hermite quadrature rule of
given order and parameter value.
-
gen_hermite_rule_test
-
gen_laguerre_exactness,
a program which
tests the polynomial exactness of generalized Gauss-Laguerre
quadrature rules.
-
gen_laguerre_exactness_test
-
gen_laguerre_rule,
a program which
computes and writes out a generalized Gauss-Laguerre quadrature rule
of given order and parameter value.
-
gen_laguerre_rule_test
-
geometry,
a library which
performs geometric calculations in 2, 3 and M dimensional space,
including the computation of angles, areas, containment, distances,
intersections, lengths, and volumes.
-
geometry_test
-
gl_display,
a program which
displays the points used in a 2D Gauss-Legendre quadrature rule;
-
gl_display_test
-
gmsh_io,
a library which
can read or write some of the files created by the Gmsh
program for 1D, 2D or 3D meshes
used by the finite element method (FEM).
-
gmsh_io_test
-
gmsh_to_fem,
a program which
reads a mesh data file created by the GMSH program
and writes a pair of node and element files that correspond
to the FEM format.
-
gmsh_to_fem_test
-
gnuplot_test
-
gpl_display,
a library which
tries to read the data in a typical gnuplot GPL file,
and display it in a more attractive way than gnuplot is capable of.
-
gpl_display_test
-
gram_schmidt,
a library which
implements the Gram-Schmidt process to orthogonalize and normalize a set of
vectors.
-
gram_schmidt_test
-
graph_representation,
a library which
can express the representation of an abstract mathematical graph
in several ways.
-
graph_representation_test
-
graphics_test
-
gray_code_display,
a program which
computes the Hamming distance tables
for both the binary and Gray codes,
and displays 3D plots that illustrate how the Gray code does a better
job of providing nearby representations for nearby numbers.
-
gray_code_display_test
-
grf_display,
a program which
reads a GRF file defining a mathematical graph and
displays it in the MATLAB graphics window.
-
grf_display_test
-
grf_io,
a library which
reads or writes a GRF file;
-
grf_io_test
-
grid,
a library which
randomly selects N distinct points from a uniform grid
in the unit hypercube in M-dimensional space.
-
grid_test
-
grid_display,
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;
-
grid_display_test
-
gridlines,
a library which
gives the user more control over drawing gridlines on a graph
than the built in "grid on" command.
-
gridlines_test
-
grids_display,
a program which
reads two files of grids or sparse grids, displaying the
first with hollow blue dots, the second with solid red dots.
-
grids_display_test
-
gurobi_solution_read,
a program which
reads a file created by the optimization package GUROBI, representing
the solution of a polyomino tiling problem, and writes out a simple
ASCII file that can be read by load().
-
gurobi_solution_read_test
-
haar,
a library which
computes the Haar transform of data.
-
haar_test
-
halton,
a library which
computes elements of a Halton Quasi Monte Carlo (QMC) sequence,
using a simple interface.
-
halton_test
-
hammersley,
a library which
computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence,
using a simple interface.
-
hammersley_test
-
hamming,
a MATLAB library which
implements some simple versions of Hamming codes which can detect
and correct errors in data.
-
hamming_test
-
hand_area,
a program which
estimates the area of a curve which outlines a person's hand.
-
hand_area_test
-
hand_data,
programs which
carry out some numerical exercises based on data that came from
tracing several points on a person's hand.
-
hand_data_test
-
hankel_cholesky,
a library which
computes the upper Cholesky factor R of a nonnegative definite
symmetric H matrix so that H = R' * R.
-
hankel_cholesky_test
-
hankel_pds,
a library which
can compute a lower triangular matrix L which is the Cholesky factor
of a positive definite (symmetric) Hankel matrix H, that is,
H = L * L'.
-
hankel_pds_test
-
heated_plate,
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.
-
heated_plate_test
-
hello,
a program which
prints out "Hello, world!".
-
hello_test
-
hermite,
a library which
computes the Hermite interpolant, a polynomial that matches
function values and derivatives.
-
hermite_test
-
hermite_cubic,
a library which
can compute the value, derivatives or integral
of a Hermite cubic polynomial,
or manipulate an interpolating function made up of
piecewise Hermite cubic polynomials.
-
hermite_cubic_test
-
hermite_exactness,
a program which
tests the polynomial exactness of Gauss-Hermite quadrature rules
to estimate the integral of a function with density exp(-x^2)
over the interval (-oo,+oo).
-
hermite_exactness_test
-
hermite_polynomial,
a library which
evaluates the physicist's Hermite polynomial,
the probabilist's Hermite polynomial,
the Hermite function, and related functions.
-
hermite_polynomial_test
-
hermite_product_display,
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).
-
hermite_product_display_test
-
hermite_product_polynomial,
a library which
defines Hermite product polynomials, creating a multivariate
polynomial as the product of univariate Hermite polynomials.
-
hermite_product_polynomial_test
-
hermite_rule,
a program which
computes and writes out a Gauss-Hermite quadrature rule
to estimate the integral of a function with density exp(-x^2)
over the interval (-oo,+oo).
-
hermite_rule_test
-
hermite_integrands,
a library which
defines test integrands for Hermite integrals
with density exp(-x^2) over the interval (-oo,+oo).
-
hermite_integrands_test
-
hexagon_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of a hexagon.
-
hexagon_integrals_test
-
hexagon_rule,
a MATLAB library which
computes a quadrature rule
over the interior of the unit hexagon.
-
hexagon_rule_test
-
high_card_simulation,
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.
-
high_card_simulation_test
-
hilbert_curve,
a library which
computes the sequence of discrete Hilbert curves whose limit
is a space-filling curve.
-
hilbert_curve_test
-
hilbert_curve_display,
a library which
can plot a Hilbert curve of given order.
-
hilbert_curve_display_test
-
histogram_data_2d_sample,
a program which
demonstrates how to construct a Probability Density Function (PDF)
from sample data over a 2D domain,
and then to use that PDF to create new samples.
-
histogram_data_2d_test
-
histogram_discrete,
a library which
tries to make a histogram of data without using bins.
-
histogram_discrete_test
-
histogram_display,
a program which
makes a bar plot of a set of data stored
as columns in a file; the first column is the X values, and
all the other columns are Y values to be shown as a stack of bars;
-
histogram_display_test
-
histogram_pdf_sample,
a library which
demonstrates how sampling can be done by starting with the
formula for a PDF, creating a histogram, constructing a
histogram for the CDF, and then sampling.
-
histogram_pdf_sample_test
-
histogram_pdf_2d_sample,
a library which
demonstrates how uniform sampling of a 2D region with respect to some
known Probability Density Function (PDF) can be approximated by
decomposing the region into rectangles, approximating the PDF by
a piecewise constant function, constructing a histogram for the CDF,
and then sampling.
-
histogram_pdf_2d_sample_test
-
histogramize,
a program which
takes a vector of data and organizes it into a histogram of a
given number of bins with given width and range,
which can be displayed as a bar chart.
-
histogramize_test
-
hits,
a library which
uses the HITS algorithm to assign authority and hub indices to a set of
nodes in a directed network.
-
hits_test
-
hyperball_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected in the unit hyperball
in M dimensions.
-
hyperball_distance_test
-
hyperball_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit hyperball in M dimensions.
-
hyperball_integrals_test
-
hyperball_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit ball in M dimensions;
-
hyperball_monte_carlo_test
-
hypercube_exactness,
a program which
tests the polynomial exactness of a quadrature rule
over the interior of the unit hypercube in M dimensions.
-
hyperball_exactness_test
-
hypercube_grid,
a library which
computes a grid of points
over the interior of a hypercube in M dimensions.
-
hypercube_grid_test
-
hypercube_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit hypercube in M dimensions.
-
hypercube_integrals_test
-
hypercube_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit hypercube in M dimensions.
-
hypercube_monte_carlo_test
-
hypersphere_angle,
a MATLAB library which
considers the problem of describing the typical value of the angle
between a pair of points randomly selected on the unit hypersphere
in M dimensions. Since by symmetry, this will be zero, we instead look
at the average of the absolute value of the dot product, and the
corresponding angle. This starts out at 1 for dimension 1, and
rapidly decreases as the spatial dimension increases.
-
hypersphere_angle_test
-
hypersphere_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected on the unit hypersphere
in M dimensions.
-
hypersphere_distance_test
-
hypersphere_integrals,
a library which
returns the exact value of the integral of any monomial
over the surface of the unit hypersphere in M dimensions.
-
hypersphere_integrals_test
-
hypersphere_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
on the surface of the unit sphere in M dimensions;
-
hypersphere_monte_carlo_test
-
hypersphere_properties,
a library which
carries out various operations for an M dimensional hypersphere,
including converting between Cartesian and spherical coordinates,
stereographic projection, sampling the surface of the sphere, and
computing the surface area and volume.
-
hypersphere_properties_test
-
hypersphere_surface,
a library which
illustrates a procedure for estimating the location of a hypersurface
in M dimensional space defined by a characteristic function
or a signed function.
-
hypersphere_surface_test
-
i4lib,
a library which
contains many utility routines, using single precision integer (I4)
arithmetic.
-
i4lib_test
-
i4mat_rref2,
a library which
computes a version of the reduced row echelon form of an integer matrix.
-
i4mat_rref2_test
-
ihs,
a library which
generates the Improved Hypercube Sampling (IHS)
M dimensional Quasi Mont Carlo (QMC) sequence;
-
ihs_test
-
image_boundary,
a library which
reports the pixels which form the boundary between the black and
white regions of a simple image.
-
image_boundary_test
-
image_components,
a library which
seeks the connected nonzero or nonblack components of an image
or an integer array.
-
image_components_test
-
image_contrast,
programs which
applies image processing techniques to increase the contrast
in an image.
-
image_contrast_test
-
image_decimate,
a library which
drops the even rows and columns from an image.
-
image_decimate_test
-
image_denoise,
a library which
applies simple filtering operations to a noisy image.
-
image_denoise_test
-
image_diffuse,
a library which
uses diffusion to smooth out an image.
-
image_diffuse_test
-
image_double,
a library which
doubles the height and width of an image by repeating each row
and column.
-
image_double_test
-
image_edge,
a library which
demonstrates a simple procedure for edge detection in images.
-
image_edge_test
-
image_match_genetic,
a program which
tries to match a 256x256 JPEG image by blending 32 colored rectangles,
using ideas from genetic algorithms,
based on an program by Nick Berry.
-
image_noise,
programs which
add noise to an image.
-
image_noise_test
-
image_normalize,
a MATLAB program which
reads image data from a file, converts it (if necessary) to grayscale,
resizes it to H pixels by W pixels.
-
image_normalize_test
-
image_quantization,
a library which
demonstrates how the KMEANS algorithm can be used to reduce the number
of colors or shades of gray in an image.
-
image_quantization_test
-
image_rgb_to_gray,
programs which
makes a grayscale version of an RGB image.
-
image_rgb_to_gray_test
-
image_threshold,
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.
-
image_threshold_test
-
imshow_numeric,
a program which
accepts a numeric 2D array and displays it as a grayscale image.
-
imshow_numeric_test
-
index,
a library which
converts an M dimensional 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.
-
index_test
-
interp,
a library which
can be used for parameterizing and interpolating data;
-
interp_test
-
interp_trig,
a library which
can be used for trigonometric interpolation.
-
interp_trig_test
-
isbn,
a library which
can determine the check digit for an International Standard Book Number
or report whether a given ISBN is valid.
-
isbn_test
-
ising_2d_simulation,
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.
-
ising_2d_simulation_test
-
jacobi,
a program which
implements the Jacobi iteration for the iterative solution of
linear systems.
-
jacobi_test
-
jacobi_eigenvalue,
a library which
implements the Jacobi iteration for the iterative determination
of the eigenvalues and eigenvectors of a real symmetric matrix.
-
jacobi_eigenvalue_test
-
jacobi_exactness,
a program which
tests the polynomial exactness of rules for integrals with
a Jacobi weight function.
-
jacobi_exactness_test
-
jacobi_poisson_1d,
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.
-
jacobi_poisson_1d_test
-
jacobi_polynomial,
a library which
evaluates the Jacobi polynomial and associated functions.
-
jacobi_polynomial_test
-
jacobi_rule,
a program which
computes and writes out a Gauss-Jacobi quadrature rule of given order.
-
jacobi_rule_test
-
kelley,
a library which
implements iterative methods for linear and nonlinear problems,
by Tim Kelley.
-
kelley_test
-
kmeans,
a library which
handles the K-Means problem,
which organizes a set of N points in M dimensions into K clusters;
-
kmeans_test
-
kmeans_fast,
a library which
contains several different algorithms for the K-Means problem,
which organizes a set of N points in M dimensions into K clusters,
by Charles Elkan.
-
kmeans_fast_test
-
knapsack_01,
a library which
uses brute force to solve small versions of the 0/1 knapsack problem;
-
knapsack_01_test
-
kronrod,
a library which
can compute a Gauss and Gauss-Kronrod pair of quadrature rules
of arbitrary order,
by Robert Piessens, Maria Branders.
-
kronrod_test
-
l4lib,
a library which
contains many utility routines, using one byte logical (L4)
variables.
-
l4lib_test
-
lagrange_approx_1d,
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)).
-
lagrange_approx_1d_test
-
lagrange_basis_display,
a library which
displays the basis functions associated with a given set of nodes used
with the Lagrange interpolation scheme.
-
lagrange_basis_display_test
-
lagrange_interp_1d,
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).
-
lagrange_interp_1d_test
-
lagrange_interp_2d,
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).
-
lagrange_interp_2d_test
-
lagrange_interp_nd,
a library which
defines and evaluates the Lagrange polynomial p(x)
which interpolates a set of data depending on an M dimensional
argument that was evaluated on a product grid,
so that p(x(i)) = z(i).
-
lagrange_interp_nd_test
-
lagrange_nd,
a library which
implements several multivariate Lagrange interpolation schemes
developed by Tomas Sauer.
-
lagrange_nd_test
-
laguerre_exactness,
a program which
tests the polynomial exactness of Gauss-Laguerre quadrature rules
for integrating functions with density exp(-x) over [0,+oo).
-
laguerre_exactness_test
-
laguerre_integrands,
a library which
implements test problems for
approximate integration over a semi-infinite interval,
often carried out using Gauss-Laguerre quadrature.
-
laguerre_integrands_test
-
laguerre_polynomial,
a library which
evaluates the Laguerre polynomial,
the generalized Laguerre polynomials,
and the Laguerre function.
-
laguerre_polynomial_test
-
laguerre_product,
a library which
computes weighted integrals of products of Laguerre polynomials.
-
laguerre_product_test
-
laguerre_rule,
a program which
computes a Gauss-Laguerre quadrature rule of given order,
and writes it to a file.
-
laguerre_rule_test
-
laplacian,
a library which
carries out computations related to the discrete
Laplacian operator, including full or sparse evaluation,
evaluation for unequally spaced data sampling points,
application to a set of data samples, solution of associated
linear systems, eigenvalues and eigenvectors, and extension
to 2D and 3D geometry.
-
laplacian_test
-
latin_center,
a library which
computes N points in an M dimensional Latin Center square;
latin_center_test
-
latin_cover,
a library which
produces N Latin squares which cover an NxN square, or NxN Latin cubes
which cover an NxNxN cube.
-
latin_cover_test
-
latin_edge,
a library which
returns N points in an M dimensional Latin Edge square;
-
latin_edge_test
-
latin_random,
a library which
returns N points in an M dimensional Latin Random square;
-
latin_random_test
-
latinize,
a program which
adjusts N points in M dimensions to form a Latin hypercube;
-
latinize_test
-
lattice_rule,
a library which
returns lattice rules for M dimensional integration;
-
lattice_rule_test
-
lcvt,
a library which
makes a sort of Latinized Centroidal Voronoi Tessellation (LCVT);
-
lcvt_test
-
least_squares_approximant,
a library which
finds a polynomial approximant to data using linear least squares (LLS).
-
least_squares_approximant_test
-
lebesgue,
a library which
is given a set of nodes in 1D, and
plots the Lebesgue function, and estimates the Lebesgue constant,
which measures the maximum magnitude of the potential error
of Lagrange polynomial interpolation.
-
lebesgue_test
-
legendre_exactness,
a program which
tests the monomial exactness of quadrature rules for the Legendre
problem of integrating a function with density 1
over the interval [-1,+1].
-
legendre_exactness_test
-
legendre_polynomial,
a library which
evaluates the Legendre polynomial and associated functions.
-
legendre_polynomial_test
-
legendre_product,
a library which
computes weighted integrals of products of Legendre polynomials.
-
legendre_product_test
-
legendre_product_polynomial,
a library which
defines Legendre product polynomials, creating a multivariate
polynomial as the product of univariate Legendre polynomials.
-
legendre_product_polynomial_test
-
legendre_rule,
a program which
writes out a Gauss-Legendre quadrature rule of given order.
-
legendre_rule_test
-
legendre_rule_fast,
a program which
uses a fast (order N) algorithm to compute a Gauss-Legendre
quadrature rule of given order.
-
legendre_rule_fast_test
-
legendre_shifted_polynomial,
a library which
evaluates the shifted Legendre polynomial, with the domain [0,1].
-
legendre_shifted_polynomial_test
-
levels,
a library which
makes a contour plot,
choosing the contour levels using random sampling.
-
levels_test
-
levenshtein,
a library which
returns the Levenshtein distance between two strings.
-
levenshtein_test
-
life,
a program which
computes a few steps of the evolution of John Conway's Game of Life,
intended as a starting point for implementing a parallel version.
-
life_test
-
lights_out,
a program which
sets up the "Lights Out" game and allows a user to try to solve it.
-
line_cvt_lloyd,
a library which
applies Lloyd's iteration repeatedly to a set of N points,
to compute a Centroidal Voronoi Tessellation (CVT)
over the interior of a line segment in 1D.
-
line_cvt_lloyd_test
-
line_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected in the unit line segment.
-
line_distance_test
-
line_fekete_rule,
a library which
estimates the location of N Fekete points, for polynomial
interpolation or quadrature,
over the interior of a line segment in 1D.
-
line_fekete_rule_test
-
line_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a line segment in 1D.
-
line_felippa_rule_test
-
line_grid,
a library which
computes a grid of points
over the interior of a line segment in 1D.
-
line_grid_test
-
line_integrals,
a library which
returns the exact value of the integral of any monomial
over the length of the unit line in 1D.
-
line_integrals_test
-
line_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
over the length of the unit line in 1D.
-
line_monte_carlo_test
-
line_ncc_rule,
a library which
computes a Newton Cotes Closed (NCC) quadrature rule,
using equally spaced points,
over the interior of a line segment in 1D.
-
line_ncc_rule_test
-
line_nco_rule,
a library which
computes a Newton Cotes Open (NCO) quadrature rule,
using equally spaced points,
over the interior of a line segment in 1D.
-
line_nco_rule_test
-
linpack_bench,
a program which
is the linpack benchmark;
-
linpack_bench_test
-
linpack_bench_backslash,
a program which
is the linpack benchmark, using MATLAB's built-in backslash operator;
-
linpack_bench_backslash_test
-
linpack_d,
a library which
constitutes a linear algebra library
for double precision real arithmetic;
it includes a function for 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.
-
linpack_d_test
-
linpack_z,
a library which
constitutes a linear algebra library
for double precision complex arithmetic;
it includes a function for 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.
-
linpack_z_test
-
llsq,
a library which
solves the simple linear least squares (LLS) 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.
-
llsq_test
-
lobatto_polynomial,
a library which
evaluates Lobatto polynomials similar to Legendre polynomials
except that they are 0 at both endpoints.
-
lobatto_polynomial_test
-
local_min_rc,
a library which
finds a local minimum of a scalar function of a scalar variable,
without the use of derivative information,
using reverse communication (RC),
by Richard Brent.
-
local_min_rc_test
-
log_normal,
a library which
returns quantities related to the log normal Probability
Distribution Function (PDF).
-
log_normal_test
-
log_normal_truncated_ab,
a library which
returns quantities related to the log normal Probability
Distribution Function (PDF) truncated to the interval [A,B].
-
log_normal_truncated_ab_test
-
lorenz_cluster_test
-
lorenz_ode_test
-
lorenz_simulation,
a program which
computes and displays solutions of the Lorenz equations
for various initial conditions.
-
luhn,
a library which
can compute the Luhn check digit for a string, or verify a string,
as used for error detection in credit card numbers.
-
luhn_test
-
machar,
a library which
dynamically computes the values of
various machine characteristic constants,
by William Cody;
-
machar_test
-
machine,
a library which
returns tabulated values of
the constants associated with computer arithmetic;
-
machine_test
-
mandelbrot,
a program which
generates an image of the Mandelbrot set;
-
mandelbrot_test
-
maple_area,
a library which
takes the list of pixels that form the boundary of the image
of a maple leaf within a picture, and uses grid, Monte Carlo,
and Quasi Monte Carlo (QMC) sampling to estimate the area of the leaf.
-
maple_area_test
-
maple_boundary,
a library which
reads an image of a maple leaf and extracts the list of pixels
that form the boundary.
-
maple_boundary_test
-
mario,
a program which
creates a sort of "needlepoint" image of Mario, as an array of
colored squares.
-
mario_test
-
matlab,
programs which
illustrate the use of MATLAB scripts and M-files;
-
matlab_calls_c,
programs which
illustrate how C functions can be written, compiled, and
called from MATLAB using the mex facility;
-
matlab_calls_c++,
programs which
illustrate how C++ functions can be written, compiled, and
called from MATLAB using the mex facility;
-
matlab_calls_f77,
programs which
illustrate how FORTRAN77 functions can be written, compiled, and
called from MATLAB using the mex facility;
-
matlab_calls_f90,
programs which
illustrate how FORTRAN90 functions can be written, compiled, and
called from MATLAB using the mex facility;
-
matlab_commandline,
programs which
illustrate how MATLAB can be run from the UNIX command line, that is,
not with the usual MATLAB command window.
-
matlab_compiler,
programs which
illustrate the use of the Matlab compiler, which allows you
to run a Matlab application outside the Matlab environment.
-
matlab_condor,
programs which
illustrate how MATLAB can be run in batch mode using the condor
queueing system.
-
matlab_graphics,
programs which
demonstrate a few issues that arise when producing graphic
images with MATLAB.
-
matlab_kmeans,
programs which
illustrate the use of Matlab's kmeans() function for clustering
N sets of M-dimensional data into K clusters.
-
matlab_map,
programs which
illustrate the use of MATLAB's mapping toolbox to draw maps of
the world, countries, the US, or individual states.
-
matlab_mistake,
programs which
illustrate some simple but devious programming mistakes in MATLAB.
-
matlab_movies,
programs which
illustrate making movies using MATLAB;
-
matlab_os,
programs which
illustrate how the system command can be used to allow MATLAB
to issue commands to the computer operating system (UNIX or DOS);
-
matlab_random,
programs which
illustrate the use of Matlab's random number generator (RNG) routines.
-
matlab_return,
programs which
illustrate that explicitly invoking the return statment
can be surprisingly costly;
-
matrix_analyze,
a library which
reports whether a matrix has various properties.
-
matrix_analyze_test
-
matrix_exponential,
a library which
demonstrates some simple approaches to the problem of computing the
exponential of a matrix.
-
matrix_exponential_test
-
md,
a program which
carries out a molecular dynamics simulation, and is intended as
a starting point for implementing a parallel version.
-
md_test
-
md_fast,
a program which
carries out a molecular dynamics simulation; it is a version of MD
that has been revised to take advantage of MATLAB's vector abilities.
-
md_fast_test
-
memory_test
-
mesh_bandwidth,
a program which
returns the geometric bandwidth associated with a mesh of
elements of any order and in a space of M dimensions.
-
mesh_bandwidth_test
-
mesh_display,
a program which
plots the nodes and elements of a polygonal mesh, with optional numbering.
-
mesh_display_test,
a program which
plots the nodes and elements of a polygonal mesh, with optional numbering.
-
mesh_etoe,
a program which
uses ETOV, the mesh element-to-vertex connectivity,
to construct ETOE, the element-to-element connectivity.
-
mesh_etoe_test
-
mesh_vtoe,
a program which
uses ETOV, the mesh element-to-vertex connectivity,
to construct VTOE, the vertex-to-element connectivity.
-
mesh_vtoe_test
-
mesh2d,
a library which
can automatically create a triangular mesh for a given polygonal
region, by Darren Engwirda.
-
mesh2d_test
-
mesh2d_hand,
a program which
reads in a set of 59 points which outline a human hand,
and calls mesh2d(), which is able to create a fine triangular
mesh of the region outlined by the points.
-
mesh2d_write,
a program which
demonstrates how node and element data from mesh2d can be written
to files.
-
mgmres,
a library which
applies the restarted Generalized Minimum Residual (GMRES) algorithm
to solve a sparse linear system, using compressed row (CR) or
sparse triplet (ST) format, by Lili Ju.
-
mgmres_test
-
mgs,
a library which
is a legacy code, which the student is encouraged to
study, understand, and document.
This example is due to Diane O'Leary.
-
mgs_test
-
mm_io,
a library which
reads and writes a Matrix Market (MM) Sparse Matrix File;
-
mm_io_test
-
mm_to_msm,
a program which
reads a Matrix Market (MM) sparse matrix file and creates a
corresponding MATLAB sparse matrix data structure.
-
mm_to_msm_test
-
mm_to_st,
a program which
reads a Matrix Market (MM) sparse matrix file and writes a
corresponding Sparse Triplet (ST) file.
-
mm_to_st_test
-
mnist_neural,
a program which
constructs a neural network in order to classify images of digits.
-
mnist_neural_test
-
monoalphabetic,
a library which
can apply a monoalphabetic substitution cipher to a string of text.
-
monoalphabetic_test
-
monomial,
a library which
enumerates, lists, ranks, unranks and randomizes multivariate
monomials in a space of M dimensions, with total degree less than N,
equal to N, or lying within a given range.
-
monomial_test
-
monomial_value,
a library which
evaluates a monomial in M dimensions.
-
monomial_value_test
-
monte_carlo_rule,
a program which
generates a dataset of N random M dimensional points,
regards it as a quadrature rule for the unit hypercube,
and writes out three files of information.
-
monte_carlo_rule_test
-
msm_to_mm,
a program which
writes a MATLAB sparse matrix to a Matrix Market (MM) file;
-
msm_to_mm_test
-
msm_to_st,
a program which
writes a MATLAB sparse matrix to a Sparse Triplet (ST) file;
-
msm_to_st_test
-
multigrid_poisson_1d,
a library which
applies the multigrid method to a discretized version of the
1D Poisson equation.
-
multigrid_poisson_1d_test
-
mxm,
a program which
sets up a matrix multiplication problem A=B*C of arbitrary size,
and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI
orderings of the loops.
-
mxm_test
-
naca,
a library which
can take the parameters of certain NACA airfoils and return the
coordinates of a sequence of points that outline the wing shape.
The shape can be displayed with MATLAB graphics.
-
naca_test
-
nas,
a program which
runs the NASA kernel benchmark.
-
nas_test
-
navier_stokes_2d_exact,
a library which
evaluates an exact solution to the incompressible time-dependent
Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
-
navier_stokes_2d_exact_test
-
navier_stokes_3d_exact,
a library which
evaluates an exact solution to the incompressible time-dependent
Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
-
navier_stokes_3d_exact_test
-
navier_stokes_mesh2d,
data files which
define meshes for several
2D test problems involving the Navier Stokes equations (NSE)
for fluid flow, provided by Leo Rebholz.
-
navier_stokes_mesh2d_test
-
navier_stokes_mesh3d,
data files which
define meshes for several
3D test problems involving the Navier Stokes equations (NSE)
for fluid flow, provided by Leo Rebholz.
-
navier_stokes_mesh3d_test
-
ncm,
programs which
accompany Cleve Moler's textbook "Numerical Computing with MATLAB".
-
nearest_interp_1d,
a library which
interpolates a set of data using a piecewise constant interpolant
defined by the nearest neighbor criterion.
-
nearest_interp_1d_test
-
neighbors_to_metis_graph,
a program which
reads a file describing the neighbor
structure of a triangulation or tet mesh, and writes a metis graph
file suitable for input to one of the family of programs based
on metis.
-
neighbors_to_metis_graph_test
-
nelder_mead,
a program which
implements the Nelder-Mead algorithm for the minimization of a
scalar function of several variables, by Jeff Borggaard.
-
nelder_mead_test
-
nested_sequence_display,
a program which
displays a set of nested sequences.
-
nested_sequence_display_test
-
netcdf_test
-
newton_interp_1d,
a library which
finds a polynomial interpolant to data using Newton divided differences.
-
newton_interp_1d_test
-
niederreiter2,
a library which
computes the Niederreiter M dimensional
Quasi Mont Carlo (QMC) sequence, base 2;
-
niederreiter2_test
-
nint_exactness_mixed,
a program which
measures the polynomial exactness of an M dimensional quadrature rule
based on a mixture of 1D quadrature rule factors.
-
nint_exactness_mixed_test
-
nintlib,
a library which
carries out approximate integration (quadrature) in M dimensions;
-
nintlib_test
-
normal,
a library which
implements normal random number generators (RNG) for
real and complex arithmetic, for scalars, vectors, and matrices.
-
normal_test
-
normal01_multivariate_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected from an isotropic
standard normal distribution in M dimensions.
-
normal01_multivariate_distance_test
-
obj_display,
a program which
displays an OBJ 3D graphics file;
-
obj_display_test
-
obj_io,
a library which
reads and writes the data in an OBJ 3D graphics file;
-
obj_io_test
-
obj_to_tri_surface,
a program which
reads an OBJ 3D graphics file and extracts
the surface mesh data as a TRI_SURFACE dataset.
-
obj_to_tri_surface_test
-
ode_sweep,
a program which
computes a grid of solutions to a parameterized system of
ordinary differential equations (ODE's).
-
ode_sweep_test
-
ornstein_uhlenbeck,
a library which
approximates solutions of the Ornstein-Uhlenbeck
stochastic ordinary differential equation (SODE)
using the Euler method, the Euler-Maruyama method,
and the Milstein method.
-
ornstein_uhlenbeck_test
-
outliers_test
-
owen,
a library which
evaluates Owen's T function;
-
owen_test
-
padua,
a library which
returns the coordinates of the 2D Padua points,
as well as interpolation weights or quadrature weights,
and images of the points in MATLAB graphics files.
-
padua_test
-
pagerank,
a library which
illustrates the eigenvalue (power method) and surfer (Markov chain)
approaches to ranking web pages.
-
pagerank_test
-
paraheat_gaussian,
a MATLAB program which
sets up and solves a parameterized steady heat equation
in a 2D spatial domain, with a gaussian diffusivity.
-
paraheat_gaussian_test
-
paraheat_gaussian_plot,
a MATLAB program which
use radial basis functions (RBF) to reconstruct the finite element
solution sampled by paraheat_gaussian().
-
paraheat_gaussian_sample,
a MATLAB program which
repeatedly calls paraheat_gaussian() to
set up and solve a parameterized steady heat equation
in a 2D spatial domain, with a gaussian diffusivity,
saving values of the finite element solution at selected points,
and writing the saved data to a file.
-
paraheat_pwc,
a MATLAB library which
can set up and solve a parameterized steady heat equation
in a 2D spatial domain, using diffusivity parameterized by vc,
and reporting solution values vs at selected sensor locations.
Options allow for this function to be sampled at many parameter
values, or for the finite element function to be reconstructed from
the sensor values.
-
paraheat_pwc_test
-
paraheat_pwc_1d,
a MATLAB program which
sets up and solves a parameterized steady heat equation
in a 1D spatial domain, with a piecewise constant diffusivity.
-
paraheat_pwc_1d_test
-
paraheat_pwc_plot,
a MATLAB program which
use radial basis functions (RBF) to reconstruct the finite element
solution sampled by paraheat_pwc().
-
paraheat_pwc_sample,
a MATLAB program which
repeatedly calls paraheat_pwc() to
set up and solve a parameterized steady heat equation
in a 2D spatial domain, with a piecewise constant diffusivity,
saving values of the finite element solution at selected points,
and writing the saved data to a file.
-
partial_digest,
a library which
seeks solutions of the partial digest problem.
-
partial_digest_test
-
partition_problem,
a library which
seeks solutions of the partition problem, splitting a set of
integers into two subsets with equal sum.
-
partition_problem_test
-
patterson_rule,
a program which
returns the points and weights of a 1D Gauss-Patterson quadrature
rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
-
patterson_rule_test
-
pbma_io,
a library which
reads or writes an ASCII Portable Bit Map (PBM) graphics file;
-
pbma_io_test
-
pce_ode_hermite,
a program which
sets up a scalar stochastic ordinary differential equation (SODE) for
exponential decay with an uncertain decay rate, using a
polynomial chaos expansion (PCE) in terms of Hermite polynomials.
-
pce_ode_hermite_test
-
pdepe_test
-
pdflib,
a library which
evaluates Probability Density Functions (PDF's)
and produces random samples from them,
including beta, binomial, chi, exponential, gamma, inverse chi,
inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
-
pdflib_test
-
peak_movie,
a program which
creates the pieces of an animation, one frame at a time.
Each frame is independently created and saved as a JPEG file.
-
pendulum_ode,
a library which
looks at some simple topics involving the linear and nonlinear
ordinary differential equations (ODEs) that represent the behavior
of a pendulum of length L under a gravitational force of strength G.
-
pendulum_ode_test
-
pentominoes,
a library which
provides some utilities for manipulating pentominoes.
-
pentominoes_test
-
perceptron,
a MATLAB program which
demonstrates the calculation of a classifier of linearly separable data
using the perceptron algorithm.
-
pgma_io,
a library which
reads or writes an ASCII Portable Gray Map (PGM) image file;
-
pgma_io_test
-
pi_spigot,
a program which
produces N digits of the decimal expansion of pi.
-
pi_spigot_test
-
pic,
a program which
uses the Particle In Cell (PIC) method to simulate the motion of
electrically charged particles past a plate, and is intended as
a starting point for implementing a parallel version.
-
pic_test
-
piecewise_linear_product_integral,
a library which
calculates the exact value of the integral of the product of two
piecewise linear functions f(x) and g(x).
-
piecewise_linear_product_integral_test
-
pink_noise,
a library which
computes a pink noise signal obeying a 1/f power law.
-
pink_noise_test
-
plasma_matrix,
a library which
demonstrates how a large sparse MATLAB matrix can be written to
or read from a Harwell-Boeing sparse matrix file.
-
plasma_matrix_test
-
poisson,
a program which
solves the Poisson equation in a rectangle,
intended as the starting point for the creation of a parallel version.
-
poisson_test
-
poisson_simulation,
a library which
simulates a Poisson process in which events randomly occur with an
average waiting time of Lambda.
-
poisson_simulation_test
-
polpak,
a library which
evaluates a variety of mathematical functions, including
Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre,
Legendre polynomials, and the Collatz sequence.
-
polpak_test
-
polygon_average,
a library which
demonstrates a process of repeatedly averaging and normalizing the
vertices of a polygon, illustrating a property of the power method.
-
polygon_average_test
-
polygon_grid,
a library which
generates a grid of points
over the interior of a polygon in 2D.
-
polygon_grid_test
-
polygon_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of a polygon in 2D.
-
polygon_integrals_test
-
polygon_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
over the interior of a polygon in 2D.
-
polygon_monte_carlo_test
-
polygon_properties,
a library which
computes properties of an arbitrary polygon in the plane, defined
by a sequence of vertices, including interior angles, area, centroid,
containment of a point, convexity, diameter, distance to a point,
inradius, lattice area, nearest point in set, outradius,
uniform sampling.
-
polygon_properties_test
-
polygon_triangulate,
a library which
triangulates a (possibly nonconvex) polygon in 2D,
based on a C program by Joseph ORourke;
-
polygon_triangulate_test
-
polygonal_surface_display,
a program which
displays a surface in 3D described as a set of polygons;
-
polygonal_surface_display_test
-
polynomial,
a library which
adds, multiplies, differentiates, evaluates and prints multivariate
polynomials in a space of M dimensions.
-
polynomial_test
-
polynomials,
a library which
defines multivariate polynomials over rectangular domains, for
which certain information is to be determined, such as the maximum
and minimum values.
-
polynomials_test
-
polyomino_condense,
a program which
cleans up a matrix that represents a polyomino by setting all nonzero
entries to 1, and removing initial and final rows and columns of zeros.
-
polyomino_condense_test
-
polyomino_embed,
a library which
is given matrices defining a region R and a polyomino P, and determines
the number of possible embeddings of the polyomino into the region, and
the translations necessary to achieve them.
-
polyomino_embed_test
-
polyomino_enumerate,
a library which
enumerates chiral, fixed and free polyominoes of moderate order.
-
polyomino_enumerate_test
-
polyomino_index,
a library which
is given a matrix defining a polyomino P, and determines
a correspondingly shaped matrix which contains an index for each
nonzero entry in P.
-
polyomino_index_test
-
polyomino_lp_write,
a program which
writes an LP file describing a (binary) integer programming problem
related to the tiling of a region R by copies of polyomino
shapes, with possible reflections and rotations.
-
polyomino_lp_write_test
-
polyomino_monohedral,
a program which
is given matrices defining a region R and a polyomino P, and seeks
binary solutions x that represent possible tilings of the region R by
the polyomino P.
-
polyomino_monohedral_test
-
polyomino_monohedral_example_reid,
a program which
sets up and solves the Reid example of a monohedral polyomino tiling
problem, using copies of a single polyomino P to cover a region R.
-
polyomino_monohedral_example_reid_test
-
polyomino_monohedral_matrix,
a program which
is given matrices defining a region R and a polyomino P, and returns
the linear system A*x=b that must be solved for binary solutions x,
that represent possible tilings of the region R by the polyomino P.
-
polyomino_monohedral_matrix_test
-
polyomino_monohedral_tiling_plot,
a library which
is given matrices defining a region R and a polyomino P, and a vector
X, computed by POLYOMINO_MONOHEDRAL, which represents a tiling of R
by P, and creates a graphic plot representation of that tiling.
-
polyomino_monohedral_tiling_plot_test
-
polyomino_monohedral_tiling_print,
a library which
is given matrices defining a region R and a polyomino P, and a vector
X, computed by POLYOMINO_MONOHEDRAL, which represents a tiling of R
by P, and prints out a representation of that tiling.
-
polyomino_monohedral_tiling_print_test
-
polyomino_monohedral_variants,
a program which
computes the distinct variants of a polyomino under reflection
and 90 degree rotations.
-
polyomino_monohedral_variants_test
-
polyomino_multihedral,
a library which
is given matrices defining a region R and a set of polyominoes P, and
seeks binary solutions x that represent possible tilings of the
region R by the polyominoes of P.
-
polyomino_multihedral_test
-
polyomino_multihedral_example_2x4_test
-
polyomino_multihedral_example_4x5_test
-
polyomino_multihedral_example_octomino,
a program which
sets up a problem in which an 8x8 square is to be tiled by
8 distinct octominoes.
-
polyomino_multihedral_example_octomino_test
-
polyomino_multihedral_example_pent18x30,
a program which
sets up a problem in which an 18x30 rectangle
is to be tiled by 9 copies of each of the 12 distinct pentominoes,
and plots a solution computed by GUROBI.
-
polyomino_multihedral_example_pentomino,
a program which
sets up a problem in which an 8x8 square with 2x2 hole is to be
tiled by the 12 distinct pentominoes.
-
polyomino_multihedral_matrix,
a library which
is given matrices defining a region R and a set of several polyominoes P,
and returns the linear system A*x=b that must be solved for binary
solutions x, that represent possible tilings of the region R by the
polyominoes in P.
-
polyomino_multihedral_matrix_test
-
polyomino_multihedral_tiling_plot,
a library which
is given matrices defining a region R and a set of polyominoes P,
and a vector X, computed by POLYOMINO_MULTIHEDRAL, which represents
a tiling of R by the elements of P, and creates a graphic plot
representation of that tiling.
-
polyomino_multihedral_tiling_plot_test
-
polyomino_multihedral_tiling_print,
a library which
is given matrices defining a region R and a set of polyominoes P,
and a vector X, computed by POLYOMINO_MULTIHEDRAL, which represent a
tiling of R by the polyominoes in P. The task is to
print out a representation of that tiling.
-
polyomino_multihedral_tiling_print_test
-
polyomino_multihedral_variants,
a program which
computes the distinct variants of one or more polyominoes under reflection
and 90 degree rotations.
-
polyomino_multihedral_variants_test
-
polyomino_plot,
a program which
displays a region which has been tiled by polyominos.
-
polyomino_plot_test
-
polyomino_transform,
a program which
transforms the matrix representing a polyomino by reflection and
rotation.
-
polyomino_transform_test
-
polyominoes,
a library which
defines, solves, and plots a variety of polyomino tiling problems,
which are solved by a direct algebraic approach, instead of the
more typical brute-force or backtracking methods.
-
polyominoes_print,
a program which
prints an array of polyominoes.
-
polyominoes_print_test
-
power_method,
a library which
carries out the power method for finding a dominant eigenvalue
and its eigenvector.
-
power_method_test
-
power_rule,
a program which
constructs a power rule, that is, a product quadrature rule
from identical 1D factor rules.
-
power_rule_test
-
ppma_io,
a library which
reads or writes an ASCII Portable Pixel Map (PPM) image file;
-
ppma_io_test
-
praxis,
a library which
minimizes a scalar function of several variables, without
requiring derivative information,
by Richard Brent.
-
praxis_test
-
predator_prey_ode,
a program which
solves a time-dependent predator-prey system
of ordinary differential equations (ODE's) using MATLAB's ode23()
function.
-
predator_prey_ode_test
-
prime,
a program which
counts the number of primes between 1 and N,
and is intended as a starting point for a parallel version.
-
prime_test
-
prime_plot,
a program which
displays a box plot of the prime and composite numbers.
-
prime_plot_test
-
prob,
a library which
evaluates, samples, inverts, and characterizes a number of
Probability Density Functions (PDF's)
and Cumulative Density Functions (CDF's), including anglit, arcsin,
benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford,
burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged,
dipole, dirichlet mixture, discrete, empirical, english sentence and
word length, error, exponential, extreme values, f, fisk,
folded normal, frechet, gamma, generalized logistic, geometric,
gompertz, gumbel, half normal, hypergeometric, inverse gaussian,
laplace, levy, logistic, log normal, log series, log uniform,
lorentz, maxwell, multinomial, nakagami, negative binomial, normal,
pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal,
runs, sech, semicircular, student t, triangle, uniform, von mises,
weibull, zipf.
-
prob_test
-
product_rule,
a program which
creates an M dimensional quadrature rule
from a product of distinct 1d quadrature rules;
-
product_rule_test
-
profile_test
-
puzzles,
programs which
solve simple puzzles;
-
pwc_plot_1d,
a library which
converts the definition of a piecewise constant function
of a 1D argument into plottable data.
-
pwc_plot_1d_test
-
pwc_plot_2d,
a library which
converts the definition of a piecewise constant function
of a 2D argument into plottable data.
-
pwc_plot_2d_test
-
pwl_approx_1d,
a library which
approximates a set of data using a piecewise linear function.
-
pwl_approx_1d_test
-
pwl_interp_1d,
a library which
interpolates a set of data using a piecewise linear function.
-
pwl_interp_1d_test
-
pwl_interp_2d,
a library which
evaluates a piecewise linear interpolant to data defined on
a regular 2D grid.
-
pwl_interp_2d_test
-
pwl_interp_2d_scattered,
a library which
evaluates a piecewise linear interpolant to data which is available
at an irregularly arranged set of points.
-
pwl_interp_2d_scattered_test
-
pyramid_exactness,
a program which
investigates the polynomial exactness of a quadrature rule
over the interior of the unit pyramid in 3D.
-
pyramid_exactness_test
-
pyramid_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a pyramid in 3D.
-
pyramid_felippa_rule_test
-
pyramid_grid,
a library which
computes a grid of points
over the interior of the unit pyramid in 3D;
-
pyramid_grid_test
-
pyramid_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit pyramid in 3D.
-
pyramid_integrals_test
-
pyramid_monte_carlo,
a library which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the unit pyramid in 3D;
-
pyramid_monte_carlo_test
-
pyramid_rule,
a program which
computes a quadrature rule
over the interior of the unit pyramid in 3D.
-
pyramid_rule_test
-
qr_solve,
a library which
computes the linear least squares (LLS) solution of a system A*x=b
using the QR factorization.
-
qr_solve_test
-
quad_mesh,
a library which
handles meshes of quadrilaterals over a 2D region;
-
quad_mesh_test
-
quad_mesh_order1_display,
a program which
plots piecewise constant data associated
with a mesh of quadrilaterals;
-
quad_mesh_order1_display_test
-
quad_mesh_rcm,
a program which
computes the Reverse Cuthill-McKee (RCM) reordering for nodes
in a mesh of 4-node quadrilaterals.
-
quad_mesh_rcm_test
-
quad,
a program which
applies a quadrature rule to estimate an integral,
intended as a starting point for parallelization exercises.
-
quad_test
-
quad_surface_display,
a program which
plots piecewise bilinear data associated with a quad_surface, that
is, a 3D surface defined by a quadrilateral mesh;
-
quad_surface_display_test
-
quad2d_test
-
quadmom,
a library which
computes a Gaussian quadrature rule for a weight function rho(x)
based on the Golub-Welsch procedure that only requires knowledge
of the moments of rho(x).
-
quadmom_test
-
quadprog_test
-
quadrature_golub_welsch,
a library which
computes the points and weights of a Gaussian quadrature rule using
the Golub-Welsch procedure.
-
quadrature_golub_welsch_test
-
quadrature_least_squares,
a library which
computes weights for sub-interpolatory quadrature rules,
that is, it estimates integrals by integrating a polynomial that
approximates the function data in a least squares sense.
-
quadrature_least_squares_test
-
quadrature_test
-
quadrature_2d_test
-
quadrature_weights_vandermonde,
a library which
computes the weights of a quadrature rule using the Vandermonde
matrix, assuming that the points have been specified.
-
quadrature_weights_vandermonde_test
-
quadrature_weights_vandermonde_2d,
a library which
computes the weights of a 2D quadrature rule using the Vandermonde
matrix, assuming that the points have been specified.
-
quadrature_weights_vandermonde_2d_test
-
quadrule,
a library which
defines quadrature rules for approximating an integral;
-
quadrule_test
-
quadrule_fast,
a library which
rapidly defines certain quadrature rules
for approximating an integral;
-
quadrule_fast_test
-
quality,
a library which
measures the dispersion of pointsets in M dimensions;
-
quality_test
-
quaternions,
a library which
carries out some simple arithmetic operations for quaternions.
-
quaternions_test
-
r8_scale,
a library which
computes the "next" and "previous" real numbers.
-
r8_scale_test
-
r8col,
a library which
contains utility routines for R8COL's, that is,
double precision real MxN arrays, considered as N column vectors,
each of length M. The data may be thought of as a matrix of
multiple columns, and many operations will be carried out columnwise.
-
r8col_test
-
r8ge,
a library which
contains linear algebra routines for R8GE matrices
(real, 64 bit, General format).
-
r8ge_test
-
r8lib,
a library which
contains many utility routines, using
double precision real (R8) arithmetic.
-
r8lib_test
-
r8poly,
a library which
contains a number of utilities for polynomials with R8 coefficients,
that is, using double precision or 64 bit real arithmetic.
-
r8poly_test
-
r8row,
a library which
contains utility routines for R8ROW's, that is,
double precision real MxN arrays, considered as M row vectors,
each of length N. The data may be thought of as a matrix of
multiple rows, and many operations will be carried out rowwise.
-
r8row_test
-
random_data,
a library which
uses a random number generator (RNG) to sample points distributed
according to various probability density functions (PDF's),
spatial dimensions, and geometries, including the M-dimensional cube,
ellipsoid, simplex and sphere.
-
random_data_test
-
random_sorted,
a library which
generates vectors of random values which are already sorted.
-
random_sorted_test
-
random_walk_1d_simulation,
a program which
simulates a random walk in a 1-dimensional region.
-
random_walk_1d_simulation_test
-
random_walk_2d_avoid_simulation,
a program which
simulates a self-avoiding random walk in a 2-dimensional region.
-
random_walk_2d_avoid_simulation_test
-
random_walk_2d_simulation,
a program which
simulates a random walk in a 2-dimensional region.
-
random_walk_2d_simulation_test
-
random_walk_3d_simulation,
a program which
simulates a random walk in a 3-dimensional region.
-
random_walk_3d_simulation_test
-
ranlib,
a library which
produces random samples from Probability Density Functions (PDF's),
including Beta, Chi-square Exponential, F, Gamma, Multivariate normal,
Noncentral chi-square, Noncentral F, Univariate normal,
random permutations, Real uniform, Binomial, Negative Binomial,
Multinomial, Poisson and Integer uniform,
by Barry Brown and James Lovato.
-
ranlib_test
-
rbf_interp_1d,
a library which
defines and evaluates
radial basis function (RBF) interpolants to 1D data.
-
rbf_interp_1d_test
-
rbf_interp_2d,
a library which
defines radial basis function (RBF) interpolants to 2D data.
-
rbf_interp_2d_test
-
rbf_interp_nd,
a library which
defines and evaluates radial basis function (RBF) interpolants
to M dimensional data.
-
rbf_interp_nd_test
-
rcm,
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;
-
rcm_test
-
reactor simulation,
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."
-
readtable_test
-
rejection_sample,
a library which
demonstrates acceptance/rejection sampling.
-
rejection_sample_test
-
ring_data,
a library which
can create, plot, or save data generated by sampling a number of
concentric, possibly overlapping rings.
-
ring_data_test
-
rk4,
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.
-
rk4_test
-
rkf45,
a library which
applies a Runge-Kutta-Fehlberg (RKF) solver to a system of
ordinary differential equations (ODE's);
-
rkf45_test
-
rnglib,
a library which
implements a random number generator (RNG) with splitting facilities,
allowing multiple independent streams to be computed,
by L'Ecuyer and Cote.
-
rnglib_test
-
root_rc,
a library which
seeks a solution of a scalar nonlinear equation f(x)=0,
using reverse communication (RC), by Gaston Gonnet.
-
root_rc_test
-
roots_rc,
a library which
seeks solutions of a system of nonlinear equations,
using reverse communication (RC), by Gaston Gonnet.
-
roots_rc_test
-
rot13,
a library which
can encipher a string using the ROT13 cipher for letters, and the
ROT5 cipher for digits.
-
rot13_test
-
roulette_simulation,
a library which
simulates the spinning of a roulette wheel and the evaluation of
certain common roulette bets.
-
roulette_simulation_test
-
row_echelon_integer,
a library which
carries out the exact computation of the integer row echelon form (IREF)
and integer reduced row echelon form (IRREF) of an integer matrix.
-
row_echelon_integer_test
-
rref_test
-
sammon_data,
a program which
generates six M dimensional datasets for cluster analysis.
-
sammon_data_test
-
satisfy_test
-
scip_solution_read,
a program which
reads a file created by the integer programming package SCIP,
representing the solution of a polyomino tiling problem, and writes
out a simple ASCII file that can be read by load().
-
scip_solution_read_test
-
sde,
a library which
illustrates properties of stochastic differential equations (SODE's),
and common algorithms for their analysis,
by Desmond Higham;
-
sde_test
-
search_test
-
sequence_streak_display,
a program which
displays a streak plot of a numeric sequence;
-
sequence_streak_display_test
-
set_theory,
a library which
demonstrates MATLAB commands that implement various
set theoretic operations.
-
set_theory_test
-
sftpack,
a library which
implements the slow Fourier transform (SFT), intended as a teaching
tool and comparison with the Fast Fourier Transform (FFT).
-
sftpack_test
-
shallow_water_1d,
a program which
simulates the evolution of a 1D fluid governed by the
time-dependent shallow water equations.
-
shallow_water_1d_test
-
shallow_water_1d_display,
a program which
can display a solution of the shallow water equations in 1D,
generally as computed by the program shallow_water_1d.
-
shallow_water_1d_display_test
-
shepard_interp_1d,
a library which
defines and evaluates Shepard interpolants to 1D data,
based on inverse distance weighting.
-
shepard_interp_1d_test
-
shepard_interp_2d,
a library which
defines and evaluates Shepard interpolants to 2D data,
based on inverse distance weighting.
-
shepard_interp_2d_test
-
shepard_interp_nd,
a library which
defines and evaluates Shepard interpolants to M dimensional data,
based on inverse distance weighting.
-
shepard_interp_nd_test
-
shoreline,
a program which
tries to identify and triangulate the 2D domain over which some
function f(x,y) is nonnegative.
-
shoreline_test
-
side_by_side_display_test
-
simplex_coordinates,
a library which
computes the Cartesian coordinates of the vertices of
a regular simplex in M dimensions.
-
simplex_coordinates_test
-
simplex_gm_rule,
a library which
defines Grundmann-Moeller quadrature rules
over the interior of a triangle in 2D, a tetrahedron in 3D, or
over the interior of the simplex in M dimensions.
-
simplex_gm_rule_test
-
simplex_grid,
a library which
generates a regular grid of points
over the interior of an arbitrary simplex in M dimensions.
-
simplex_grid_test
-
simplex_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit simplex in M dimensions.
-
simplex_integrals_test
-
simplex_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit simplex in M dimensions.
-
simplex_monte_carlo_test
-
sine_transform,
a library which
demonstrates simple properties of the discrete sine transform (DST).
-
sine_transform_test
-
single_linkage_test
-
sir,
a program which
simulates the spread of a disease
using the Susceptible/Infected/Recovered (SIR) model.
-
sir_test
-
sir_simulation,
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.
-
sir_simulation_test
-
smolyak_display,
a program which
displays the exactness diagram for a 2D Smolyak sparse grid,
by displaying and summing the exactness diagrams for the
component product rules.
-
smolyak_display_test
-
snakes_and_ladders,
a program which
simulates a one-player version of the game
of Snakes and Ladders, by Mina Aymin.
-
snakes_bar,
a library which
produces bar charts of the count, PDF and CDF estimates for the
length of a one-player game of Snakes and Ladders, produced by
simulating N games.
-
snakes_bar_test
-
snakes_histogram,
a library which
produces histograms of the count, PDF and CDF estimates for the
length of a one-player game of Snakes and Ladders, produced by
simulating N games.
-
snakes_histogram_test
-
snakes_matrix,
a program which
returns the transition matrix for the game of
Snakes and Ladders.
-
snakes_probability,
a program which
computes the game length probabilities for the game of
Snakes and Ladders,
by Desmond Higham and Nicholas Higham.
-
sobol,
a library which
generates elements of the Sobol M dimensional Quasi Mont Carlo (QMC)
sequence, by Bennett Fox.
-
sobol_test
-
solve,
a library which
demonstrates how Gauss elimination can be used to solve a
linear system A*x=b.
-
solve_test
-
sor,
a library which
implements a simple version of the successive over-relaxation (SOR)
method for the iteration solution of a linear system of equations.
-
sor_test
-
sort_rc,
a library which
can sort a list of any kind of objects,
using reverse communication (RC).
-
sort_rc_test
-
sort_test
-
sparse_count,
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, for various growth rules.
-
sparse_count_test
-
sparse_display,
a library which
can read information defining a matrix of numbers and display
the sparsity pattern or location of the nonzero elements using
gnuplot. This operation is already available in the built-in
MATLAB "spy" command.
-
sparse_display_test
-
sparse_grid_cc,
a library which
creates sparse grids based on Clenshaw-Curtis quadrature rules.
-
sparse_grid_cc_test
-
sparse_grid_composite,
a library which
creates sparse grids based on 1D composite rules (currently only
of order 1).
-
sparse_grid_composite_test
-
sparse_grid_gl,
a library which
creates sparse grids based on Gauss-Legendre rules.
-
sparse_grid_gl_test
-
sparse_grid_hermite,
a library which
creates sparse grids based on Gauss-Hermite rules.
-
sparse_grid_hermite_test
-
sparse_grid_hw,
a library which
creates sparse grids based on Gauss-Legendre, Gauss-Hermite,
Gauss-Patterson, or a nested variation of Gauss-Hermite rules,
by Florian Heiss and Viktor Winschel.
-
sparse_grid_hw_test
-
sparse_grid_laguerre,
a library which
creates sparse grids based on Gauss-Laguerre rules.
-
sparse_grid_laguerre_test
-
sparse_grid_total_poly,
a library which
investigates the efficient approximation of all polynomials
up to a given total degree using sparse grids.
-
sparse_grid_total_poly_test
-
sparse_interp_nd,
a library which
can be used to define a sparse interpolant to a function f(x) of a
M dimensional argument.
-
sparse_interp_nd_test
-
sparse_test
-
sphere_cubed_grid,
a library which
uses the projection of a cube to create grids of points,
lines, and quadrilaterals
on the surface of the unit sphere in 3D.
-
sphere_cubed_grid_test
-
sphere_cvt,
a program which
carries out the Centroidal Voronoi Tessellation (CVT) iteration
on the surface of the unit sphere in 3D.
-
sphere_cvt_test
-
sphere_delaunay,
a program which
computes the Delaunay triangulation of points
on the surface of the unit sphere in 3D.
-
sphere_delaunay_test
-
sphere_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected on the unit sphere.
-
sphere_distance_test
-
sphere_exactness,
a program which
tests the polynomial exactness of a quadrature rule
on the surface of the unit sphere in 3D.
-
sphere_exactness_test
-
sphere_fibonacci_grid,
a library which
uses a Fibonacci spiral to create a grid of points
on the surface of the unit sphere in 3D.
-
sphere_fibonacci_grid_test
-
sphere_grid,
a library which
provides a number of ways of generating grids of points, or of
points and lines, or of points and lines and faces,
on the surface of the unit sphere in 3D.
-
sphere_grid_test
-
sphere_integrals,
a library which
returns the exact value of the integral of any monomial
over the surface of the unit sphere in 3D.
-
sphere_integrals_test
-
sphere_lebedev_rule,
a library which
computes Lebedev quadrature rules
on the surface of the unit sphere in 3D.
-
sphere_lebedev_rule_test
-
sphere_lebedev_rule_display,
a program which
reads a file defining a Lebedev quadrature rule
on the surface of the unit sphere in 3D
and displays the point locations.
-
sphere_lebedev_rule_display_test
-
sphere_llq_grid,
a library which
uses longitudes and latitudes to create grids of points,
lines, and quadrilaterals
on the surface of the unit sphere in 3D.
-
sphere_llq_grid_test
-
sphere_llt_grid,
a library which
uses longitudes and latitudes to create grids of points,
lines, and triangles
on the surface of the unit sphere in 3D.
-
sphere_llt_grid_test
-
sphere_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
on the surface of the unit sphere in 3D.
-
sphere_monte_carlo_test
-
sphere_stereograph,
a library which
computes the stereographic mapping between points
on the surface of the unit sphere in 3D
and points on the plane Z = 1; a generalized mapping is
also available.
-
sphere_stereograph_test
-
sphere_stereograph_display,
a library which
computes and displays the results of several stereographic projections
between points
on the surface of the unit sphere in 3D and a plane.
-
sphere_stereograph_display_test
-
sphere_triangle_monte_carlo,
a library which
used the Monte Carlo method to estimate the integral of a function
defined in a triangle
on the surface of the unit sphere in 3D.
-
sphere_triangle_monte_carlo_test
-
sphere_triangle_quad,
a library which
uses quadrature to estimate the integral of a function
in a spherical triangle on the surface of the unit sphere in 3D.
-
sphere_triangle_quad_test
-
sphere_voronoi,
a program which
computes the Voronoi diagram of points
on the surface of the unit sphere in 3D.
-
sphere_voronoi_test
-
spherical_harmonic,
a library which
evaluates spherical harmonic functions.
-
spherical_harmonic_test
-
spinterp,
a library which
carries out piecewise multilinear
hierarchical sparse grid interpolation, quadrature and optimization,
by Andreas Klimke;
an earlier version of this software is ACM TOMS Algorithm 847.
-
spinterp_test
-
spiral_data,
a program which
computes a velocity vector field that satisfies the continuity
equation, writing the data to a file that can be plotted
by gnuplot.
-
spiral_data_test
-
spline,
a library which
interpolates and approximates via splines;
-
spline_test
-
spquad,
a library which
computes the points and weights of a sparse grid quadrature rule
for an M dimensional integral, based on the Clenshaw-Curtis
quadrature rule, by Greg von Winckel.
-
spquad_test
-
spring_ode,
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.
-
square_arbq_rule,
a library which
returns quadrature rules,
with exactness up to total degree 20,
over the interior of the symmetric square in 2D,
by Hong Xiao and Zydrunas Gimbutas.
-
square_arbq_rule_test
-
square_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected in the unit square.
-
square_distance_test
-
square_exactness,
a library which
investigates the polynomial exactness of quadrature rules for f(x,y)
over the interior of a rectangle in 2D.
-
square_exactness_test
-
square_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a square in 2D.
-
square_felippa_rule_test
-
square_grid,
a library which
computes a grid of points
over the interior of a square in 2D.
-
square_grid_test
-
square_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit square or symmetric unit square in 2D.
-
square_integrals_test
-
square_minimal_rule,
a library which
returns "almost minimal" quadrature rules,
with exactness up to total degree 55,
over the interior of the symmetric square in 2D,
by Mattia Festa and Alvise Sommariva.
-
square_minimal_rule_test
-
square_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit square in 2D.
-
square_monte_carlo_test
-
square_symq_rule,
a library which
returns symmetric quadrature rules,
with exactness up to total degree 20,
over the interior of the symmetric square in 2D,
by Hong Xiao and Zydrunas Gimbutas.
-
square_symq_rule_test
-
st_io,
a library which
reads and writes sparse linear systems
stored in the Sparse Triplet (ST) format.
-
st_io_test
-
st_to_cc,
a library which
converts sparse matrix data from Sparse Triplet (ST) format
to Compressed Column (CC) format;
-
st_to_cc_test
-
st_to_mm,
a program which
converts a sparse matrix file from Sparse Triplet (ST) format
to Matrix Market (MM) format;
-
st_to_mm_test
-
st_to_msm,
a program which
reads a Sparse Triplet (ST) file
and creates a corresponding MATLAB Sparse Matrix.
-
st_to_msm_test
-
stla_display,
a program which
displays an ASCII stereolithography (STL) 3D graphics file;
-
stla_display_test
-
stla_io,
a library which
reads and writes an ASCII stereolithography (STL) 3D graphics file;
-
stla_io_test
-
stla_to_tri_surface,
a program which
reads an ASCII stereolithography (STL) 3D graphics file and extracts
the surface mesh data as a tri_surface dataset.
-
stla_to_tri_surface_test
-
stla_to_tri_surface_fast,
a program which
is a faster version of stla_to_tri_surface.
-
stla_to_tri_surface_fast_test
-
stochastic_diffusion,
functions which
implement several versions of a stochastic diffusivity coefficient.
-
stochastic_diffusion_test
-
stochastic_heat2d,
a program which
implements a finite difference method (FDM) for the steady
(time independent) 2D heat equation,
with a stochastic heat diffusivity coefficient.
-
stochastic_heat2d_test
-
stochastic_rk,
a library which
applies a Runge-Kutta (RK) scheme to approximate the solution of a
stochastic ordinary differential equation (SODE).
-
stochastic_rk_test
-
stokes_2d_exact,
a library which
evaluates exact solutions to the incompressible steady
Stokes equations over the unit square in 2D.
-
stokes_2d_exact_test
-
string_simulation,
a program which
simulates the behavior of a vibrating string
by solving the corresponding initial boundary value problem (IBVP).
-
stroud,
a library which
defines quadrature rules for a variety of M-dimensional regions,
including the interior of the square, cube and hypercube, the pyramid,
cone and ellipse, the hexagon, the M-dimensional octahedron,
the circle, sphere and hypersphere, the triangle, tetrahedron
and simplex, and the surface of the circle, sphere and hypersphere.
-
stroud_test
-
subpak,
a library which
includes many utility routines;
-
subpak_test
-
subset,
a library which
enumerates, generates, randomizes, ranks and unranks combinatorial
objects including combinations, compositions, Gray codes, index sets,
partitions, permutations, polynomials, subsets, and Young tables.
Backtracking routines are included to solve some combinatorial problems.
-
subset_test
-
subset_sum,
a program which
seeks solutions of the subset sum problem.
-
subset_sum_test
-
subset_sum_brute,
a program which
seeks solutions of the subset sum problem,
using a brute force approach.
-
subset_sum_brute_test
-
sudoku,
a library which
handles Sudoku puzzles;
-
sudoku_test
-
superlu_test
-
surf_test
-
svd_basis,
a program which
applies the singular value decomposition (SVD)
to a collection of data vectors, extracting dominant modes;
-
svd_basis_test
-
svd_circle,
a MATLAB program which
analyzes a linear map of the unit circle caused by an arbitrary
2x2 matrix A, using the singular value decomposition.
-
svd_circle_test
-
svd_faces,
a MATLAB library which
applies singular value decomposition (SVD) analysis to a set of images.
-
svd_faces_test
-
svd_fingerprint,
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.
-
svd_fingerprint_test
-
svd_gray,
a program which
reads a gray scale image, computes the Singular Value Decomposition (SVD),
and constructs a series of low rank approximations to the image.
-
svd_gray_test
-
svd_lls,
a program which
uses the singular value decomposition (SVD) to construct and
plot the best affine and linear relationships in the sense of
least square, between two vectors of data.
-
svd_lls_test
-
svd_powers,
a MATLAB library which
applies singular value decomposition (SVD) analysis to a set of
powers x(i)^(j-1).
-
svd_powers_test
-
svd_snowfall,
a program which
reads a file containing historical snowfall data and
analyzes the data with the Singular Value Decomposition (SVD).
-
svd_snowfall_test
-
svd_sphere,
a program which
analyzes a linear map of the unit sphere caused by an arbitrary
3x3 matrix A, using the singular value decomposition.
-
svd_sphere_test
-
svd_test
-
svd_truncated_test
-
table_io,
a library which
reads and writes a simple table file;
-
table_io_test
-
task_division,
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.
-
task_division_test
-
tensor_grid_display,
a program which
can display the grid points of a tensor product rule used for
interpolation or quadrature, in 1D, 2D or 3D.
-
tensor_grid_display_test
-
test_approx,
a library which
implements test problems for approximation,
provided as a set of (x,y) data.
-
test_approx_test
-
test_con,
a library which
implements test problems for
numerical continuation.
-
test_con_test
-
test_eigen,
a library which
implements test matrices for eigenvalue analysis.
-
test_eigen_test
-
test_int,
a library which
implements test problems for
approximate integration (quadrature) in one dimension.
-
test_int_test
-
test_int_2d,
a library which
implements test problems for
approximate integration (quadrature) in two dimensions.
-
test_int_2d_test
-
test_interp,
a library which
defines test problems for interpolation,
provided as a set of (x,y(x)) data.
-
test_interp_test
-
test_interp_1d,
a library which
defines test problems for interpolation of data y(x),
which depends on a 1D argument.
-
test_interp_1d_test
-
test_interp_2d,
a library which
defines test problems for interpolation of data z(x,y),
which depends on a 2D argument.
-
test_interp_2d_test
-
test_interp_fun,
a library which
defines test problems for interpolation which are
available in functional form.
-
test_interp_fun_test
-
test_interp_nd,
a library which
defines test problems for interpolation of data z(x),
depending on an M dimensional argument.
-
test_interp_nd_test
-
test_lls,
a library which
implements linear least squares (LLS) test problems of the form A*x=b.
-
test_lls_test
-
test_mat,
a library which
defines test matrices for which some of the determinant, eigenvalues,
inverse, null vectors, P*L*U factorization or linear system solution
are already known, including the Vandermonde and Wathen matrix.
-
test_mat_test
-
test_matrix_exponential,
a library which
defines a set of test cases for computing the matrix exponential.
-
test_matrix_exponential_test
-
test_min,
a library which
implements test problems for
minimization of a scalar function of a scalar variable.
-
test_min_test
-
test_nearest,
a library which
tests the time complexity of various procedures for solving the
nearest neighbor problem.
-
test_nearest_test
-
test_nint,
a library which
implements test problems for
approximate integration (quadrature) in M dimensions.
-
test_nint_test
-
test_ode,
a library which
defines some sample ordinary differential equations (ODE's) for
testing initial value problem solvers;
-
test_ode_test
-
test_opt,
a library which
implements test problems for optimization
of a scalar function of several variables.
-
test_opt_test
-
test_opt_con,
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.
-
test_opt_con_test
-
test_optimization,
a library which
implements test problems for optimization
of a scalar function of several variables,
as described by Molga and Smutnicki.
-
test_optimization_test
-
test_partial_digest,
a library which
can generate example cases of the partial digest problem.
-
test_partial_digest_test
-
test_triangle_integrals,
a library which
defines tests involving the integration of an integrand function
over some specific triangle, not necessarily the unit triangle.
-
test_triangle_integrals_test
-
test_triangulation,
a library which
defines test problems for triangulation;
-
test_triangulation_test
-
test_values,
a library which
returns selected values of some special functions;
-
test_values_test
-
test_zero,
a library which
defines some functions f(x) suitable for testing
software that solves f(x)=0;
-
test_zero_test
-
tet_mesh,
a library which
works with tetrahedral meshes in 3D;
-
tet_mesh_test
-
tet_mesh_boundary,
a program which
reads information defining
a tetrahedral mesh of points in 3D, and determines the triangular
faces that form the boundary of the mesh; it writes out files
containing the nodes and elements defining this TRI_SURFACE data.
-
tet_mesh_boundary_test
-
tet_mesh_display,
a program which
reads data defining a (small) tetrahedral mesh,
and displays a wireframe image of the nodes and edges;
-
tet_mesh_display_test
-
tet_mesh_l2q,
a program which
reads information about a 4-node (linear) tetrahedral mesh and
creates data defining a corresponding 10-node (quadratic)
tetrahedral mesh;
-
tet_mesh_l2q_test
-
tet_mesh_q2l,
a program which
reads information about a 10-node (quadratic) tet mesh and
creates data defining a corresponding 4-node (linear)
tetrahedral mesh;
-
tet_mesh_q2l_test
-
tet_mesh_quad,
a program which
estimates the integral of a function over a region defined by
a tetrahedral mesh.
-
tet_mesh_quad_test
-
tet_mesh_quality,
a program which
computes various quality measures for a
tetrahedral mesh of a set of nodes in 3D;
-
tet_mesh_quality_test
-
tet_mesh_rcm,
a program which
computes the Reverse Cuthill McKee (RCM) reordering for the nodes
of a tetrahedral mesh that uses 4-node or 10-node tetrahedrons;
-
tet_mesh_rcm_test
-
tet_mesh_refine,
a program which
refines a tetrahedral mesh;
-
tet_mesh_refine_test
-
tet_mesh_tet_neighbors,
a program which
reads information about a tetrahedral mesh and writes out a list of
the tetrahedrons adjacent to a given tetrahedron;
-
tet_mesh_tet_neighbors_test
-
tet_mesh_to_gmsh,
a program which
write a Gmsh file describing a tetrahedral mesh;
-
tet_mesh_to_gmsh_test
-
tet_mesh_to_xml,
a program which
write an XML file describing a tetrahedral mesh;
-
tet_mesh_to_xml_test
-
tet_mesh_volumes,
a program which
computes the volume of each tetrahedron in a tetrahedral mesh;
-
tet_mesh_volumes_test
-
tetrahedron_arbq_rule,
a library which
returns quadrature rules,
with exactness up to total degree 15,
over the interior of a tetrahedron in 3D,
by Hong Xiao and Zydrunas Gimbutas.
-
tetrahedron_arbq_rule_test
-
tetrahedron_exactness,
a program which
tests the polynomial exactness of a quadrature rule
over the interior of a tetrahedron in 3D.
-
tetrahedron_exactness_test
-
tetrahedron_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a tetrahedron in 3D.
-
tetrahedron_felippa_rule_test
-
tetrahedron_grid,
a library which
computes a grid of points
over the interior of a tetrahedron in 3D.
-
tetrahedron_grid_test
-
tetrahedron_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit tetrahedron in 3D.
-
tetrahedron_integrals_test
-
tetrahedron_keast_rule,
a library which
defines ten quadrature rules, of degree of exactness 0 through 8,
over the interior of the tetrahedron in 3D.
-
tetrahedron_keast_rule_test
-
tetrahedron_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of a general tetrahedron in 3D.
-
tetrahedron_monte_carlo_test
-
tetrahedron_ncc_rule,
a library which
defines Newton-Cotes closed (NCC) quadrature rules
over the interior of a tetrahedron in 3D.
-
tetrahedron_ncc_rule_test
-
tetrahedron_nco_rule,
a library which
defines Newton-Cotes open (NCO) quadrature rules
over the interior of a tetrahedron in 3D.
-
tetrahedron_nco_rule_test
-
tetrahedron_properties,
a program which
computes properties, including the centroid,
circumsphere, dihedral angles, edge lengths, face angles, face areas,
insphere, quality, solid angles, and volume
for a tetrahedron in 3D.
-
tetrahedron_properties_test
-
tetrahedron_slice_animate,
a program which
is given a tetrahedron and a vector, and displays an evenly spaced
sequence of planes that intersect the tetrahedron
and are normal to the vector.
-
tetrahedron_slice_display,
a program which
determines the intersection between a tetrahedron and a plane and
displays the result.
-
tetrahedron_slice_display_test
-
tetrahedron01_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit tetrahedron in 3D.
-
tetrahedron01_monte_carlo_test
-
theodolite,
a library which
presents the problem of estimating the location of an event
which occurs in the sky, atmosphere, or the heavens, using nothing
but the reported angle of observation from several stations;
a nonlinear least squares (NLS) solver is needed.
-
theodolite_test
-
three_body_simulation,
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.
-
tic_toc_test
-
timer_test
-
timestamp,
a library which
prints the current YMDHMS date as a timestamp;
-
timestamp_test
-
toeplitz_cholesky,
a library which
computes the Cholesky factorization of a nonnegative definite
symmetric Toeplitz matrix.
-
toeplitz_cholesky_test
-
toms097,
a library which
computes the distance between all pairs of nodes in a directed graph
with weighted edges, using Floyd's algorithm.
This is a version of ACM TOMS algorithm 97.
-
toms097_test
-
toms112,
a library which
determines whether a point is contained in a polygon,
by Moshe Shimrat.
This is a version of ACM TOMS algorithm 112.
-
toms112_test
-
toms178,
a library which
seeks the minimizer of a scalar function of several variables
using the Hooke-Jeeves method, by Arthur Kaupe.
This is a version of ACM TOMS algorithm 178.
-
toms178_test
-
toms179,
a library which
calculates the incomplete Beta ratio,
by Oliver Ludwig.
This is a version of ACM TOMS algorithm 179.
-
toms179_test
-
toms243,
a library which
evaluates the logarithm of a complex value,
by David Collens.
This is a version of ACM TOMS algorithm 243.
-
toms243_test
-
toms291,
a library which
approximates the logarithm of the Gamma function.
This is a version of ACM TOMS algorithm 291.
-
toms291_test
-
toms443,
a library which
evaluates Lambert's W function.
This is a version of ACM TOMS algorithm 443.
-
toms443_test
-
toms446,
a library which
manipulates Chebyshev series for interpolation and approximation,
by Roger Broucke.
This is a version of ACM TOMS algorithm 446.
-
toms446_test
-
toms462,
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 version of ACM TOMS algorithm 462.
-
toms462_test
-
toms515,
a library which
can select subsets of size K from a set of size N,
This is a version of ACM TOMS Algorithm 515,
by Bill Buckles, Matthew Lybanon.
-
toms515_test
-
toms577,
a library which
evaluates Carlson's elliptic integral functions RC, RD, RF and RJ.
This is a version of ACM TOMS algorithm 577.
-
toms577_test
-
toms655,
a library which
computes the weights for interpolatory quadrature rule;
this library is commonly called IQPACK,
by Sylvan Elhay and Jaroslav Kautsky.
This is a version of ACM TOMS algorithm 655.
-
toms655_test
-
toms743,
a library which
evaluates Lambert's W function.
This is a version of ACM TOMS algorithm 743,
by Barry, Barry and Culligan-Hensley.
-
toms743_test
-
toms847,
a library which
carries out piecewise multilinear
hierarchical sparse grid interpolation, commonly known as
SPINTERP, by Andreas Klimke.
This is a version of ACM TOMS Algorithm 847.
-
toms847_test
-
toms886,
a library which
defines the Padua points for interpolation in a 2D region,
including the rectangle, triangle, and ellipse,
by Marco Caliari, Stefano de Marchi, Marco Vianello.
This is a version of ACM TOMS algorithm 886.
-
toms886_test
-
traffic_simulation,
a program which
simulates the cars waiting to get through a traffic light.
-
traffic_simulation_test
-
tri_surface_display,
a program which
displays a triangulated surface;
-
tri_surface_display_test
-
tri_surface_io,
a library which
reads and writes the 3D graphics information
in a tri_surface file;
-
tri_surface_io_test
-
tri_surface_to_obj,
a program which
reads a tri_surface dataset and extracts
the surface mesh data as an OBJ file.
-
tri_surface_to_obj_test
-
tri_surface_to_stla,
a program which
reads a tri_surface dataset and extracts
the surface mesh data as an ASCII stereolithography (STL) file.
-
tri_surface_to_stla_test
-
triangle_analyze,
a program which
reads a triangle defined in a file, and uses the TRIANGLE_PROPERTIES
library to compute angles, area, centroid, circumcircle, edge lengths,
incircle, orientation, orthocenter, and quality.
-
triangle_analyze_test
-
triangle_display,
a program which
displays the nodes and elements of a triangulation
on the MATLAB graphics screen, assuming the data has been
stored in NODE and ELE files by the triangle() program.
-
triangle_display_test
-
triangle_distance,
a library which
considers the problem of describing the typical value of the distance
between a pair of points randomly selected in a triangle.
-
triangle_distance_test
-
triangle_dunavant_rule,
a library which
defines Dunavant quadrature rules
over the interior of a triangle in 2D.
-
triangle_dunavant_rule_test
-
triangle_exactness,
a program which
tests the polynomial exactness of a quadrature rule
over the interior of a triangle in 2D.
-
triangle_exactness_test
-
triangle_fekete_rule,
a library which
sets up one of seven Fekete rules
for interpolation or quadrature
over the interior of a triangle in 2D.
-
triangle_fekete_rule_test
-
triangle_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a triangle in 2D.
-
triangle_felippa_rule_test
-
triangle_grid,
a library which
computes a grid of points
over the interior of a triangle in 2D.
-
triangle_grid_test
-
triangle_histogram,
a program which
computes histograms of data
over the interior of a unit triangle in 2D.
-
triangle_histogram_test
-
triangle_integrals,
a library which
returns the exact value of the integral of any polynomial
over the interior of an arbitrary triangle in 2D.
-
triangle_integrals_test
-
triangle_interpolate,
a library which
shows how vertex data can be interpolated at any point
in the interior of a triangle.
-
triangle_interpolate_test
-
triangle_io,
a library which
can read or write some of the files created by Jonathan Shewchuk's
triangle program.
-
triangle_io_test
-
triangle_lyness_rule,
a library which
returns Lyness-Jespersen quadrature rules
over the interior of a triangle in 2D;
-
triangle_lyness_rule_test
-
triangle_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of a general triangle in 2D.
-
triangle_monte_carlo_test
-
triangle_ncc_rule,
a library which
defines Newton-Cotes closed (NCC) quadrature rules
over the interior of a triangle in 2D.
-
triangle_ncc_rule_test
-
triangle_nco_rule,
a library which
defines Newton-Cotes open (NCO) quadrature rules
over the interior of a triangle in 2D.
-
triangle_nco_rule_test
-
triangle_properties,
a program which
computes properties, including angles, area, centroid, circumcircle,
edge lengths, incircle, orientation, orthocenter, and quality,
of a triangle in 2D.
-
triangle_properties_test
-
triangle_svg,
a library which
uses Scalable Vector Graphics (SVG) to plot a triangle and
any number of points, to illustrate quadrature rules and
sampling techniques.
-
triangle_svg_test
-
triangle_symq_rule,
a library which
returns efficient symmetric quadrature rules,
with exactness up to total degree 50,
over the interior of a triangle in 2D,
by Hong Xiao and Zydrunas Gimbutas.
-
triangle_symq_rule_test
-
triangle_to_fem,
a program which reads the NODE and ELE files
created by the triangle program to
describe a triangular mesh, and writes a corresponding pair of
node and element files in the 2D FEM format.
-
triangle_to_fem_test
-
triangle_to_xml,
a program which reads the NODE and ELE files created by triangle() to
describe a triangular mesh in 2D, and writes out a corresponding XML mesh
file for use by DOLFIN or FENICS.
-
triangle_to_xml_test
-
triangle_twb_rule,
a MATLAB library which
generates the points and weights of quadrature rules
over the interior of a triangle in 2D,
determined by Taylor, Wingate, and Bos.
-
triangle_twb_rule_test
-
triangle_wandzura_rule,
a library which
returns quadrature rules of exactness 5, 10, 15, 20, 25 and 30
over the interior of the triangle in 2D.
-
triangle_wandzura_rule_test
-
triangle01_integrals,
a library which
returns the integral of any monomial
over the interior of the unit triangle in 2D.
-
triangle01_integrals_test
-
triangle01_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit triangle in 2D.
-
triangle01_monte_carlo_test-
-
triangulate,
a program which
triangulates a polygonal region,
based on a C program by Joseph ORourke;
-
triangulate_test
-
triangulate_rectangle,
a program which
sets up a grid of triangles in a rectangular region.
-
triangulate_rectangle_test
-
triangulation,
a library which
computes the triangulation of a set of points in the plane,
and performs various operations using a triangulation, including
searching a Delaunay triangulation to find
which triangle contains a given point.
-
triangulation_test
-
triangulation_boundary_edges,
a program which
reads data defining a triangulation, determines which edges
lie on the boundary, organizes them into connected components,
and writes this information to a file.
-
triangulation_boundary_edges_test
-
triangulation_boundary_nodes,
a program which
reads data defining a triangulation, determines which nodes
lie on the boundary, and writes their coordinates to a file;
-
triangulation_boundary_nodes_test
-
triangulation_corner,
a program which
modifies triangulations in which one or more triangles have more
than one boundary edge.
-
triangulation_corner_test
-
triangulation_delaunay_discrepancy,
a program which
measures the amount by which a triangulation fails
the local Delaunay test;
-
triangulation_delaunay_discrepancy_test
triangulation_display,
a program which
displays the nodes and elements of a triangulation on the MATLAB
graphics screen;
-
triangulation_display_test
-
triangulation_histogram,
a program which
computes histograms of data over a triangulation.
-
triangulation_histogram_test
-
triangulation_l2q,
a program which
reads information about a 3-node (linear) triangulation and creates
data defining a corresponding 6-node (quadratic) triangulation;
-
triangulation_l2q_test
-
triangulation_mask,
a program which
reads a triangulation and calls
a user-supplied routine to consider each triangle for deletion;
-
triangulation_mask_test
-
triangulation_node_to_element,
a program which
reads files describing a set of nodes, their triangulation, and the
value of one or more quantities at each node, and outputs a file
that averages the quantities for each element. This operation
in effect creates an order1 finite element model of the data.
-
triangulation_node_to_element_test
-
triangulation_order1_display,
a program which
plots piecewise constant data associated with a triangulation;
-
triangulation_order1_display_test
-
triangulation_order3_contour,
a program which
plots color contours of a scalar
quantity evaluated at the nodes of a 3-node triangle triangulation.
-
triangulation_order3_contour_test
-
triangulation_order6_contour,
a program which
plots color contours of a scalar
quantity evaluated at the nodes of a 6-node triangle triangulation.
-
triangulation_order6_contour_test
-
triangulation_orient,
a program which
ensures that the triangles in
an order 3 or order 6 triangulation have positive orientation;
-
triangulation_orient_test
-
triangulation_plot,
a program which
plots the nodes and elements of a triangulation as a PostScript file;
-
triangulation_plot_test
-
triangulation_q2l,
a program which
reads information about a 6-node triangulation and creates data
defining a corresponding 3-node triangulation;
-
triangulation_q2l_test
-
triangulation_quad,
a program which
reads information about a triangulation and the value of a function at
the nodes and estimates the integral of the function
over the triangulated region.
-
triangulation_quad_test
-
triangulation_quality,
a program which
reads information about a triangulation and computes various
quality measures;
-
triangulation_quality_test
-
triangulation_rcm,
a program which
computes the Reverse Cuthill McKee (RCM) reordering for the nodes
of a triangulation that uses 3-node or 6-node triangles;
-
triangulation_rcm_test
-
triangulation_refine,
a program which
refines a triangulation;
-
triangulation_refine_test
-
triangulation_refine_local,
a program which
refines a triangulation locally; a single triangular element is
replaced by four smaller triangles, and neighboring information
is updated.
-
triangulation_refine_local_test
-
triangulation_svg,
a program which
creates an SVG image of a triangulation, which can be displayed
by a web browser.
-
triangulation_svg_test
-
triangulation_t3_to_t4,
a program which
reads information about a 3-node T3 triangulation and creates data
defining a corresponding 4-node T4 triangulation;
-
triangulation_t3_to_t4_test
-
triangulation_triangle_neighbors,
a program which
reads data defining a triangulation, finds the three neighbor
triangles for each triangle, and writes them to a file;
-
triangulation_triangle_neighbors_test
-
truel_simulation,
a program which
simulates N repetitions of a duel between three players, each of
whom has a known firing accuracy.
-
truel_simulation_test
-
truncated_normal,
a library which
works with the truncated normal distribution over [A,B], or
[A,+oo) or (-oo,B], returning the probability density function (PDF),
the cumulative density function (CDF), the inverse CDF, the mean,
the variance, and sample values.
-
truncated_normal_test
-
truncated_normal_rule,
a program which
computes a quadrature rule for a
normal probability density function (PDF), sometimes called a
Gaussian distribution, that has been truncated to [A,+oo), (-oo,B]
or [A,B].
-
truncated_normal_rule_test
-
truncated_normal_sparse_grid,
a program which
computes a sparse grid based on a normal probability density function
(PDF), also called a Gaussian distribution, that has been
truncated to [A,+oo), (-oo,B] or [A,B].
-
truncated_normal_sparse_grid_test
-
tsp_brute,
a program which
reads a file of city-to-city distances and solves a (small!)
traveling salesperson problem (TSP), using brute force.
-
tsp_brute_test
-
tsp_descent,
a program which
reads a file of city-to-city distances, choose an initial tour
at random, and then tries some simple variations to quickly find
a tour of lower length.
-
tsp_descent_test
-
tsp_greedy,
a program which
reads a file of city-to-city distances, picks a starting city, and
then successively visits the nearest unvisited city.
-
tsp_greedy_test
-
tsp_random,
a program which
reads a file of city-to-city distances, and then randomly samples
a number of possible tours, to quickly seek a tour of lower length.
-
tsp_random_test
-
two_body_simulation,
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.
-
two_body_simulation_test
-
ubvec,
a library which
demonstrates how nonnegative integers can be stored as
unsigned binary vectors, and arithmetic can be performed on them.
-
ubvec_test
-
unicycle,
a library which
considers permutations containing a single cycle,
sometimes called cyclic permutations.
-
unicycle_test
-
uniform,
a library which
implements a uniform random number generator (RNG) for a variety
of arithmetic types.
-
uniform_test
-
upc,
is a library which
can compute the check digit associated with a uniform product code (UPC),
or it can report whether a 12-digit UPC is actually valid.
-
upc_test
-
urn_simulation,
a program which
simulates the experiment of sampling K balls from an urn containing
N balls of various colors.
-
urn_simulation_test
-
usa_cvt_geo,
programs which
explore the creation of a centroidal Voronoi Tessellation (CVT) of
the continental United States, based solely on geometric considerations.
-
usa_cvt_geo_test
-
van_der_corput,
a library which
computes elements of the van der Corput
1-dimensional Quasi Mont Carlo (QMC) sequence,
using a simple interface.
-
van_der_corput_test
-
vandermonde,
a library which
implements the Bjork-Pereyra algorithm for accurate solution of
linear systems involving the Vandermonde matrix.
-
vandermonde_test
-
vandermonde_approx_1d,
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.
-
vandermonde_approx_1d_test
-
vandermonde_approx_2d,
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.
-
vandermonde_approx_2d_test
-
vandermonde_interp_1d,
a library which
finds a polynomial interpolant to data y(x) of a 1D argument
by solving a linear system for the polynomial coefficients
involving the Vandermonde matrix.
-
vandermonde_interp_1d_test
-
vandermonde_interp_2d,
a library which
finds a polynomial interpolant to data z(x,y) of a 2D argument
by solving a linear system for the polynomial coefficients
involving the Vandermonde matrix.
-
vandermonde_interp_2d_test
-
voronoi_city,
a program which
displays the steps involved in computing the Voronoi diagram
of 3 points, which we think of as cities connected by roads.
-
voronoi_city_test
-
voronoi_display,
a program which
computes the exact Voronoi diagram using geompack, and displays it.
-
voronoi_display_test
-
voronoi_mountains,
a program which
makes a mountain plot of a Voronoi
diagram, that is, a surface plot of the distance from each
point to its nearest Voronoi generator.
-
voronoi_mountains_test
-
voronoi_neighbors,
a program which
is given a set of points in the plane and determines the
Voronoi adjacency structure, that is, which points share an
edge of the Voronoi diagram.
-
voronoi_neighbors_test
-
voronoi_plot,
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;
-
voronoi_plot_test
-
voronoi_test
-
vpa_test
-
walker_sample,
a library which
efficiently samples a discrete probability vector using
Walker sampling.
-
walker_sample_test
-
walsh,
a library which
implements versions of the Walsh and Haar transforms.
-
walsh_test
-
wathen,
a library which
compares storage schemes (full, banded, sparse triplet, sparse) and
solution strategies (A\x, Linpack, conjugate gradient) for linear
systems involving the Wathen matrix, which can arise when solving a
problem using the finite element method (FEM).
-
wathen_test
-
wavelet,
a library which
does some simple wavelet calculations;
-
wavelet_test
-
wedge_exactness,
a program which
investigates the polynomial exactness of a quadrature rule
over the interior of the unit wedge in 3D.
-
wedge_exactness_test
-
wedge_felippa_rule,
a library which
returns quadrature rules for approximating integrals
over the interior of the unit wedge in 3D.
-
wedge_felippa_rule_test
-
wedge_grid,
a library which
computes a grid of points
over the interior of the unit wedge in 3D.
-
wedge_grid_test
-
wedge_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of the unit wedge in 3D.
-
wedge_integrals_test
-
wedge_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit wedge in 3D.
-
wedge_monte_carlo_test
-
weekday,
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.
-
weekday_test
-
will_you_be_alive,
a library which
contains the scripts used to carry out the probability simulations
described in Paul Nahin's "Will You Be Alive 10 Years From Now?";
-
will_you_be_alive_test
-
wishart,
a library which
produces sample matrices from the Wishart or Bartlett distributions,
useful for sampling random covariance matrices.
-
wishart_test
-
wtime,
a library which
returns a reading of the wall clock time in seconds.
-
wtime_test
-
xml2struct,
a program which
reads a file containing XML data, and produces a corresponding
MATLAB struct.
-
xml2struct_test
-
zero_rc,
a library which
seeks a solution of a scalar nonlinear equation f(x)=0,
using reverse communication (RC), by Richard Brent.
-
zero_rc_test
-
ziggurat,
a library which
implements uniform, normal and exponential
random number generators (RNG's) using the ziggurat method,
by Marsaglia and Tsang.
-
ziggurat_test
-
zombies,
a library which
uses a generalized Susceptible-Infected-Recovered (SIR) disease
model to simulate a zombie attack, developed by Philip Munz.
-
zombies_test
Last revised on 07 May 2019.