C Source Codes
-
allocatable_array,
a program which
demonstrates how a C function can declare a pointer to an array,
pass it to a function, which can then allocate it and fill it with
data, and then return the allocated and initialized array to the
calling function through the argument list.
-
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,
creating data files that can be plotted with gnuplot,
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
-
args,
a program which
reports the command line arguments with which it was invoked;
-
args_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 K-means 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;
-
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;
-
asa103,
a library which
evaluates the digamma or psi function,
by Jose Bernardo;
this is a version of Applied Statistics Algorithm 103;
-
asa109,
a library which
inverts the incomplete Beta function,
by Cran, Martin and Thomas;
this is a version of Applied Statistics Algorithm 109;
-
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;
-
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;
-
asa121,
a library which
evaluates the trigamma function,
by BE Schneider;
this is a version of Applied Statistics Algorithm 121;
-
asa136,
a library which
implements a clustering algorithm,
by Hartigan and Wong;
this is a version of Applied Statistics Algorithm 136;
-
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;
-
asa147,
a library which
evaluates the incomplete Gamma function,
by Chi Leung Lau;
this is a version of Applied Statistics Algorithm 147;
-
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;
-
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;
-
asa172,
a library which
generates all multidimensional indices in a given range,
simulating the behavior of an arbitrary number of nested loops,
by OFlaherty and MacKenzie.
this is a version of Applied Statistics Algorithm 172;
-
asa183,
a library which
implements a random number generator (RNG),
by Wichman and Hill;
this is a version of Applied Statistics Algorithm 183;
-
asa226,
a library which
evaluates the noncentral incomplete Beta function,
by Russell Lenth;
this is a version of Applied Statistics Algorithm 226;
-
asa239,
a library which
evaluates the incomplete Gamma function,
by Shea;
this is a version of Applied Statistics Algorithm 239;
-
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;
-
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;
-
asa245,
a library which
evaluates the logarithm of the Gamma function,
by Allan Mcleod;
this is a version of Applied Statistics Algorithm 245;
-
asa266,
a library which
evaluates various properties of the
Dirichlet probability density function (PDF);
this is a version of Applied Statistics Algorithm 266;
-
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;
-
asa310,
a library which
evaluates the noncentral incomplete Beta function,
by Chattamvelli and Shanmugam;
this is a version of Applied Statistics Algorithm 310;
-
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.
-
ascii_to_mri,
a program which
restores MRI data to its original binary format, having been
previously converted to an ASCII text file.
-
ascii_to_mri_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.
-
ball_grid,
a library which
computes a grid of points
over the interior of the unit ball in 3D.
-
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_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;
-
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.
-
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.
-
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.
-
bernstein_polynomial,
a library which
evaluates the Bernstein polynomials;
-
besselj,
a library which
evaluates Bessel J functions of noninteger order;
-
beta_nc,
a library which
evaluates the cumulative density function (CDF)
of the noncentral Beta distribution;
-
bicycle_lock,
a library which
simulates the process of determining the secret combination of
a bicycle lock, an integer between 000 and 999.
-
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_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.
-
black_scholes,
a library which
implements some simple approaches to
the Black-Scholes option valuation theory,
by Desmond Higham.
-
blas,
a library which
contains the Basic Linear Algebra Subprograms (BLAS)
for level 1, 2 and 3, for single and double precision,
and for real and complex arithmetic.
-
blas_osx,
a program which demonstrates how to access the BLAS library
on a Macintosh that is running the OSX operating system.
-
blas0,
a library which
contains auxilliary functions for the Basic Linear Algebra Subprograms
(BLAS).
-
blas1,
a library which
contains the Basic Linear Algebra Subprograms (BLAS)
for level 1 (vector-vector operations),
for single and double precision,
and for real and complex arithmetic.
-
blas1_c,
a library of the Level 1 Basic Linear Algebra Subprograms (BLAS),
using single precision complex arithmetic;
-
blas1_d,
a library of the Level 1 Basic Linear Algebra Subprograms (BLAS),
using double precision real arithmetic;
-
blas1_s,
a library of the Level 1 Basic Linear Algebra Subprograms (BLAS),
using single precision real arithmetic;
-
blas1_z,
a library of the Level 1 Basic Linear Algebra Subprograms (BLAS),
using double precision complex arithmetic;
-
blas2_d,
a library which
constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS),
using double precision real arithmetic.
-
blas2_s,
a library which
constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS),
using single precision real arithmetic.
-
blas3_d,
a library which
constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS)
for matrix-matrix operations,
using double precision real arithmetic.
-
blas3_s,
a library which
constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS)
for matrix-matrix operations,
using single precision real arithmetic.
-
blend,
a library which
carries out 1D/2D/3D blending interpolation;
-
box_behnken,
a library which
computes a Box-Behnken design,
that is, a set of arguments to sample the behavior
of a function of multiple parameters;
-
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 option,
by Richard Brent.
-
brownian_motion_simulation,
a library which
simulates Brownian motion in an M-dimensional region,
creating graphics files for processing by gnuplot.
-
burgers_solution,
a library which
evaluates exact solutions of
the time-dependent 1D viscous Burgers equation.
-
bvec,
a library which
demonstrates how signed integers can be stored as
binary vectors, and arithmetic can be performed on them.
-
c,
programs which
illustrate some of the features of the C programming language.
-
c_arrays,
programs which
illustrate the use of vectors, matrices and tensors.
-
c_calls_f77,
programs which
illustrate a C program calling a FORTRAN77 subroutine.
-
c_calls_f90,
programs which
illustrate a C program calling a FORTRAN90 subroutine.
-
c_condor,
programs which
illustrate how a C program can be run in batch mode
using the condor queueing system.
-
c_files,
programs which
illustrate the use of files.
-
c_intrinsics,
a program which
illustrates the use of intrinsic functions supplied by the C language.
-
c_mistake,
programs which
illustrate some simple but devious programming mistakes in C.
-
c_operators,
a program which
illustrates the use of the operators supplied by the C language.
-
c_random,
programs which
illustrate the use of the C random number generator (RNG) functions.
-
c4_complex_lib,
a library which
defines a single precision complex (C4) variable as a structure,
and implements certain corresponding elementary functions.
-
c4lib,
a library which
implements certain elementary functions for
single precision complex (C4) variables
using the C99 "float complex" datatype.
-
c8_complex_lib,
a library which
defines a double precision complex (C8) variable as a structure,
and implements certain corresponding elementary functions.
-
c8lib,
a library which
implements certain elementary functions for
double precision complex (C8) variables
using the C99 standard "double complex" datatype.
-
caesar,
a library which
can apply a Caesar Shift Cipher to a string of text.
-
calpak,
a library which
makes various calendar calculations;
-
cauchy_principal_value,
a library which
uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value
(CPV) of certain singular integrals.
-
cblas
a program which
illustrates the use of the CBLAS, a C translation of the FORTRAN77
Basic Linear Algebra Subprograms (BLAS) which are used by clapack,
the C translation of the FORTRAN77 LAPACK linear algebra library.
-
cc_io
a library which
reads and writes sparse linear systems
stored in the Compressed Column (CC) format.
-
cc_to_st
a library which
converts a sparse matrix from compressed column (CC) to
sparse triplet (ST) format.
-
ccn_rule,
a program which
defines a one of a sequence of Clenshaw Curtis Nested (CCN)
quadrature rules of any order.
-
cdflib,
a library which
evaluates the cumulative density function (CDF), inverse CDF,
and certain other inverse functions, for distributions including
beta, binomial, chi-square, noncentral chi-square, F, noncentral F,
gamma, negative binomial, normal, Poisson, and students T,
by Barry Brown, James Lovato, Kathy Russell.
-
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.
-
cellular_automaton,
a program which
demonstrates the 1D Cellular Automaton known as rule #30.
-
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_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).
-
change_making,
a library which
considers the change making problem,
in which a given sum is to be formed using coins of various denominations.
-
chebyshev,
a library which
computes the Chebyshev interpolant or approximant to a given function
over an interval.
-
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_polynomial,
a library which
considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x).
Functions are provided to evaluate the polynomials, determine their
zeros, produce their polynomial coefficients, produce related
quadrature rules, project other functions onto these polynomial bases,
and integrate double and triple products of the polynomials.
-
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.
-
chrpak,
a library which
can manipulate characters and strings;
-
circle_arc_grid,
a library which
computes grid points along a circular arc.
-
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_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_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_segment,
a library which
carries out computations associated with a circle segment, including
height, angle, area, centroid, sampling, and quadrature,
creating some graphics images using gnuplot.
-
clapack_test,
C programs which
illustrate the use of CLAPACK,
a translation of the FORTRAN77 BLAS and LAPACK
linear algebra libraries, including single and double precision,
real and complex arithmetic.
-
clausen,
a library which
evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
-
clenshaw_curtis_rule,
a program which
implements a Clenshaw Curtis quadrature rule;
-
cnoise,
a library which
generates samples of noise obeying a 1/f^alpha power law,
by Miroslav Stoyanov.
-
collatz_recursive,
a library which
demonstrates recursive programming by considering
the simple Collatz 3n+1 problem.
-
colored_noise,
a library which
generates samples of noise obeying a 1/f^alpha power law.
-
combination_lock,
a library which
simulates the process of determining the secret combination of a lock.
-
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.
-
communicator_mpi,
a program which
creates new communicators involving a subset of initial
set of MPI processes in the default communicator MPI_COMM_WORLD.
-
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.
-
complex_numbers,
a program which
demonstrates some simple features involved in the use of
complex numbers in C programming.
-
condition,
a library which
implements methods of computing or estimating
the condition number of a matrix.
-
continued_fraction
a library which
implements some simple algorithms for dealing with simple and
generalized continued fractions.
-
cordic,
a library which
computes a few special functions using the CORDIC algorithm.
-
correlation,
a library which
contains statistical correlation functions.
-
cosine_transform,
a library which
demonstrates some simple properties of the discrete cosine transform
(DCT).
-
csparse,
a library which
carries out the direct solution of sparse
linear systems, by Timothy Davis.
-
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_exactness,
a library which
investigates the polynomial exactness of quadrature rules
over the interior of a cube in 3D.
-
cube_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a cube in 3D.
-
cube_grid,
a library which
computes a grid of points
over the interior of a cube in 3D.
-
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_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.
-
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.
-
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_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.
-
cyclic_reduction,
a library which
solves a tridiagonal linear system using cyclic reduction;
-
diaphony,
a program which
reads a file of N points in M dimensions and computes its diaphony,
a measure of point dispersion.
-
differ,
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.
-
dijkstra,
a library which
implements a simple version of Dijkstra's minimum distance algorithm
for graphs.
-
dijkstra_openmp,
a program which
uses OpenMP to parallelize a simple example of Dijkstra's
minimum distance algorithm for graphs.
-
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_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_rule,
a library which
computes quadrature rules for the general disk in 2D.
-
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_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_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_rule,
a library which
computes quadrature rules for the unit disk in 2D, that is, the
interior of the circle of radius 1 and center (0,0).
-
dislin_test,
C programs which
illustrate the use of dislin, a scientific graphics package,
by Helmut Michels.
-
divdif,
a library which
uses divided differences to compute the polynomial interpolant
to a given set of data.
-
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.
-
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.
-
duel_simulation,
a program which
simulates N repetitions of a duel between two players, each of
whom has a known firing accuracy.
-
edge,
a library which
defines some test functions in 1D, 2D and 3D
for the detection of edges or discontinuities,
and using gnuplot to display the curves or surfaces.
-
eispack,
a library which
carries out eigenvalue computations. It includes a function
to compute the singular value decomposition (SVD)
of a rectangular matrix.
This library was superseded by LAPACK;
-
ellipse_grid,
a library which
computes grid points
over the interior of an ellipse in 2D.
-
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.
-
ellipsoid_grid,
a library which
computes a grid of points
over the interior of an ellipsoid in 3D.
-
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.
-
elliptic_integral,
a library which
evaluates complete elliptic integrals of first, second and third kind,
using Carlson's elliptic integral functions.
-
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).
-
f77split,
a program which
splits a file containing
multiple FORTRAN77 routines into separate files;
-
f90split,
a program which
splits a file containing multiple FORTRAN90 routines
into separate files;
-
fair_dice_simulation,
a program which
simulates N tosses of 2 dice, making a histogram of the results.
-
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.
-
fd_predator_prey,
a program which
solves a pair of predator prey ordinary differential equations (ODE's)
using a finite difference method (FDM) approximation.
-
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,
writing graphics files for processing by gnuplot.
-
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 method, writing graphics files for processing by gnuplot.
-
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, writing graphics files for processing by gnuplot.
-
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,
writing graphics files for processing by gnuplot.
-
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_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_bvp,
a program which
applies the finite difference method (FDM)
to a two point boundary value problem (BVP) in one spatial dimension.
-
fd1d_heat_explicit,
a library which
implements a finite difference method (FDM), explicit in time, of the
time dependent 1D heat equation;
-
fd1d_heat_implicit,
a program which
implements a finite difference method (FDM), implicit in time, of the
time dependent 1D heat equation;
-
fd1d_heat_steady,
a program which
implements a finite difference method (FDM) for the steady
(time independent) 1D heat equation;
-
fd1d_wave,
a program which
applies the finite difference method (FDM) to solve the time-dependent
wave equation in one spatial dimension.
-
fd2d_heat_steady,
a program which
implements a finite difference method (FDM) for the steady
(time independent) 2D heat equation;
-
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_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_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_medit,
a program which
reads a pair of FEM files defining node coordinates and elements,
of a 2D mesh, namely
a file of node coordinates and a file of elements defined by
node indices, and creates a corresponding MEDIT mesh file.
-
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_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.
-
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_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_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_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_heat_steady,
a program which
implements the finite element method (FEM) for the steady
(time independent) 1D heat equation;
-
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_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_pack,
a library which
contains utilities for 1D finite element method (FEM) calculations.
-
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_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 method (FEM) solution from one mesh to another.
-
fem1d_sample,
a program which
samples a scalar or vector finite element function of one variable,
defined by FEM files,
returning interpolated values at the sample points.
-
fem2d_bvp_linear,
a program which
applies the finite element method (FEM), with piecewise linear 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,
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_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_pack,
a library which
implements various 2D finite element method (FEM) calculations;
-
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.
-
fern_opengl,
a program which
uses OpenGL to display the Barnsley fractal fern.
-
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_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_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.
-
fft_openmp,
a program which
demonstrates the computation of a Fast Fourier Transform (FFT)
in parallel, using OpenMP.
-
fft_serial,
a program which
computes a Fast Fourier Transform (FFT), and is intended as
a starting point for implementing an OpenMP parallel version.
-
fftpack4,
a library which
implements the Fast Fourier Transform (FFT)
by Paul Swarztrauber and Dick Valent, translated by Andrew Fernandes;
-
fftw,
C programs which
illustrate the use of FFTW, a library of routines
for the Fast Fourier Transform (FFT),
by Matteo Frigo and Steven Johnson.
-
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.
-
files_multiple,
a program which
demonstrates how a program can open multiple output files at one time,
and write data to any one specific file it chooses.
-
filon,
a library which
can approximate integrals in which the integrand includes an
oscillatory factor of sin(k*x) or cos(k*x).
-
filum,
a library which
performs various operations with files;
-
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.
-
flood_opengl,
a program which
uses OpenGL to allow the user to select regions of an image
and flood them with color,
by Art Wetzel.
-
floyd,
a library which
implements Floyd's algorithm for finding the shortest distance
between pairs of nodes on a directed graph.
-
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.
-
forest_fire_simulation,
a program which
models the occurrence of fires in a forest, and displays the status
of the forest using X Windows, by Michael Creutz.
-
freefem++_msh_io,
a library which
can read and write files used by the FreeFem++ finite element program
to store mesh information.
-
functions_openmp,
a program which
demonstrates the behavior of a few of the OpenMP library functions.
-
gcc_intrinsics,
a program which
demonstrates or tests some of the intrinsic functions made available
by the Gnu gcc compiler for C.
-
gcc_quadmath,
a program which
illustrates the use of quadruple precision real arithmetic,
as provided on some systems by the gcc compiler for C.
-
gegenbauer_cc,
a library which
computes the Gegenbauer weighted integral of a function f(x)
using a Clenshaw-Curtis approach.
-
gegenbauer_polynomial,
a library which
evaluates the Gegenbauer polynomial and associated functions.
-
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.
-
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_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.
-
gnuplot_i,
a library which
allows an executing C, C++ or FORTRAN program to interact with the
gnuplot graphics program,
by Nicholas Devillard.
-
gnuplot_i_examples,
programs which
demonstrate the use of the gnuplot_i library for interactive
runtime gnuplot graphics.
-
gnuplot_test,
C programs which
illustrate how a program can write data and command files
so that gnuplot can create plots of the program results.
-
gprof,
programs which
illustrate the use of the gprof program performance monitor;
-
graphics_examples,
programs which
illustrate how various kinds of data can be displayed
and analyzed graphically.
-
grid,
a library which
randomly selects N distinct points from a uniform grid
in the unit hypercube in M-dimensional space.
-
haar,
a library which
computes the Haar transform of data.
-
halton,
a library which
computes elements of a Halton Quasi Monte Carlo (QMC) sequence,
using a simple interface.
-
hammersley,
a library which
computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence,
using a simple interface.
-
hankel_cholesky,
a library which
computes the upper Cholesky factor R of a nonnegative definite
symmetric H matrix so that H = R' * R.
-
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'.
-
hb_io,
a library which
reads and writes files
in the Harwell Boeing (HB) sparse matrix format;
-
hdf5,
functions which
demonstrate the use of the HDF5 library and file format.
-
heat_mpi,
a program which
demonstrates the use of the Message Passing Interface (MPI),
by solving the 1D time dependent heat equation.
-
heated_plate,
a program which
solves the steady state heat equation in a 2D
rectangular region, and is intended as
a starting point for implementing an OpenMP parallel version.
-
heated_plate_openmp,
a program which
solves the steady (time independent) heat equation in a 2D
rectangular region, using OpenMP to run in parallel.
-
hello,
a program which
prints out "Hello, world!".
-
hello_mpi,
a program which
prints out "Hello, world!" using MPI for parallel programming.
-
hello_openmp,
a program which
prints out "Hello, world!" within the OpenMP parallel programming
environment.
-
hermite,
a library which
computes the Hermite interpolant, a polynomial that matches
function values and derivatives.
-
hermite_cubic,
a library which
can compute the value, derivatives or integral
of a Hermite cubic polynomial, or manipulate an interpolant
made up of piecewise Hermite cubic polynomials.
-
hermite_exactness,
a program which
tests the polynomial exactness of Gauss-Hermite quadrature rules
for approximating the integral of a function with density exp(-x^2)
over the interval (-oo,+oo).
-
hermite_polynomial,
a library which
evaluates the physicist's Hermite polynomial,
the probabilist's Hermite polynomial,
the Hermite function, and related functions.
-
hermite_product_polynomial,
a library which
defines Hermite product polynomials, creating a multivariate
polynomial as the product of univariate Hermite polynomials.
-
hermite_rule,
a program which
computes and writes out a Gauss-Hermite quadrature rule
for approximating the integral of a function with density exp(-x^2)
over the interval (-oo,+oo).
-
hermite_test_int,
a library which
defines test integrands for Hermite integrals
with density exp(-x^2) over the interval (-oo,+oo).
-
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;
the program uses gnuplot to create a graph of the results.
-
hilbert_curve,
a library which
computes the sequence of discrete Hilbert curves whose limit
is a space-filling curve.
-
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.
-
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_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_volume_monte_carlo,
a program which
applies a Monte Carlo procedure to estimate the volume of the
unit ball in M dimensions;
-
hypercube_exactness,
a program which
tests the polynomial exactness of a quadrature rule
over the interior of the unit hypercube in M dimensions.
-
hypercube_grid,
a library which
computes a grid of points
over the interior of a hypercube in M dimensions.
-
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_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.
-
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_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_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.
-
i4lib,
a library which
contains many utility routines, using single precision integer (I4)
arithmetic.
-
i8lib,
a library which
contains many utility routines, using double precision integer (I8)
arithmetic.
-
ice_io,
a library which can
read or write an ICE dataset, which defines a 3D grid,
using the NETCDF file format.
-
ice_to_mesh,
a C program which
reads a NETCDF file containing an ICE dataset and rewrites the
information as a MESH file.
-
image_components,
a library which
seeks the connected nonzero or nonblack components of an image
or integer array.
-
image_denoise,
a library which
applies simple filtering operations to a noisy image.
-
image_denoise_openmp,
a library which
applies simple filtering operations to a noisy image,
carrying out the operation in parallel using OpenMP.
-
image_edge,
a library which
demonstrates a simple procedure for edge detection in images.
-
index,
a library which
converts a multidimensional vector index
to a one-dimensional vector index;
it can handle zero and one based indexing schemes,
as well as column major and row major conventions.
-
interp,
a library which
can be used for parameterizing and interpolating data;
-
is_serial,
a program which
is a serial version of the NAS Parallel Benchmark Integer Sort (IS).
-
isbn,
a library which
can determine the check digit for an International Standard Book Number
or report whether a given ISBN is valid.
-
ising_2d_simulation,
a program which
simulates evolution of a 2D array of positive and negative charges,
each of which is likely to flip to be in agreement with neighbors,
using gnuplot to display the initial and final configurations.
-
jacobi,
a program which
implements the Jacobi iteration for the iterative solution of
linear systems.
-
jacobi_eigenvalue,
a library which
implements the Jacobi iteration for the iterative determination
of the eigenvalues and eigenvectors of a real symmetric matrix.
-
jacobi_openmp,
a program which
illustrates the use of the OpenMP application program interface
to parallelize a Jacobi iteration solving A*x=b.
-
jacobi_polynomial,
a library which
evaluates the Jacobi polynomial and associated functions.
-
julia_openmp,
a program which
produces an image of a Julia set, using OpenMP to carry out the
computation in parallel.
-
julia_set,
a program which
generates a TGA or TARGA graphics file of a Julia set.
-
kmeans,
a library which
handles the K-Means problem,
which organizes a set of N points in M dimensions into K clusters;
-
knapsack_01,
a library which
uses brute force to solve small versions of the 0/1 knapsack problem;
-
kronrod,
a library which
can compute a Gauss and Gauss-Kronrod pair of quadrature rules
of arbitrary order,
by Robert Piessens, Maria Branders.
-
l4lib,
a library which
contains many utility routines, using one byte logical (L4)
variables.
-
ladders,
a program which
seeks to transform one five letter word into another, by changing
one letter at a time, using only legitimate English words. This
puzzle was invented by Lewis Carroll, who called it "Doublets", but
it is also known as "Word Ladders" or "Word Golf". The program
is by Donald Knuth.
-
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_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_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_nd,
a library which
defines and evaluates the Lagrange polynomial p(x) which
interpolates a set of data depending on a multidimensional argument
that was evaluated on a product grid,
so that p(x(i)) = z(i).
-
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_polynomial,
a library which
evaluates the Laguerre polynomial,
the generalized Laguerre polynomials,
and the Laguerre function.
-
laguerre_rule,
a program which
computes and writes out a
Gauss-Laguerre quadrature rule for approximating the integral
of a function with density exp(-x) over the interval [0,+oo).
-
laguerre_test_int,
a library which
implements test problems for
approximate integration over a semi-infinite interval,
often carried out using Gauss-Laguerre quadrature.
-
laplace_mpi,
a program which
solves Laplace's equation on a rectangle,
using the Message Passing Interface (MPI) for parallel execution.
-
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.
-
latin_cover,
a library which
produces N Latin squares which cover an NxN square, or NxN Latin cubes
which cover an NxNxN cube.
-
latin_random,
a library which
computes Latin Random Squares of N points in M dimensions;
-
latin_random_dataset,
a program which
creates a Latin Random Hypercube dataset;
-
latinize,
a library which
adjusts N points in M dimensions to form a Latin Hypercube;
-
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.
-
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_polynomial,
a library which
evaluates the Legendre polynomial and associated functions.
-
legendre_product_polynomial,
a library which
defines Legendre product polynomials, creating a multivariate
polynomial as the product of univariate Legendre polynomials.
-
legendre_rule,
a program which
writes out a Gauss-Legendre quadrature rule of given order to
integrate a function with density 1
over the interval [-1,+1].
-
legendre_rule_fast,
a program which
uses a fast (order N) algorithm to compute
a Gauss-Legendre quadrature rule of given order to
integrate a function with density 1
over the interval [-1,+1].
-
legendre_shifted_polynomial,
a library which
evaluates the shifted Legendre polynomial, with the domain [0,1].
-
levenshtein,
a library which
returns the Levenshtein distance between two strings.
-
life_opengl,
a program which
uses OpenGL to display the evolution of John Conway's Game of Life,
by Simon Green.
-
life_serial,
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.
-
lights_out_opengl,
a program which
sets up a Lights Out game and allows the user to solve it,
using the OpenGL graphics window.
-
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_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_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a line segment in 1D.
-
line_grid,
a library which
computes a grid of points
over the interior of a line segment in 1D.
-
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_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_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_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.
-
linpack,
a library which
solves linear systems for a variety of matrix storage schemes,
real or complex arithmetic, and single or double precision.
The original version of this library is
by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
-
linpack_bench,
a program which
is a version of the LINPACK benchmark program;
-
linpack_d,
a library which
factors matrices in a variety of formats, and solving the
associated linear systems, using double precision real arithmetic;
it includes a function to compute
the singular value decomposition (SVD) of a rectangular matrix.
The original version of this library is
by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
-
linpack_s,
a library which
factors matrices in a variety of formats, and solving the
associated linear systems, using single precision real arithmetic;
it includes a function to compute
the singular value decomposition (SVD) of a rectangular matrix.
The original version of this library is
by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
-
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.
-
lobatto_polynomial,
a library which
evaluates Lobatto polynomials similar to Legendre polynomials
except that they are 0 at both endpoints.
-
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.
-
log_normal,
a library which
returns quantities related to the log normal Probability
Distribution Function (PDF).
-
log_normal_truncated_ab,
a library which
returns quantities related to the log normal Probability
Distribution Function (PDF) truncated to the interval [A,B].
-
lorenz_ode,
a program which
approximates solutions to the Lorenz system of ordinary differential
equations (ODEs), creating output files that can be displayed
by gnuplot.
-
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.
-
machar,
a library which
dynamically computes the values of various machine characteristic
constants by William Cody;
-
machine,
a library which
returns tabulated values of the constants associated
with computer arithmetic;
-
makefiles,
programs which
illustrate the use of makefiles for maintaining a software project;
-
mandelbrot,
a program which
generates an ASCII Portable Pixel Map (PPM) image of
the Mandelbrot set;
-
mandelbrot_ascii,
a program which
generates an ASCII text image of the Mandelbrot set,
using just two lines of C code.
-
mandelbrot_openmp,
a program which
generates an ASCII Portable Pixel Map (PPM) image of the
Mandelbrot fractal set, using OpenMP for parallel execution;
-
mandelbrot_ppm,
a program which
generates a binary Portable Pixel Map (PPM) image
of the Mandelbrot set, by Eric Weeks.
-
mario,
a program which
creates a sort of "needlepoint" image of Mario, as an array of
colored squares.
-
matmul,
a program which
carries out a matrix multiplication benchmark;
-
matrix_exponential,
a library which
demonstrates some simple approaches to the problem of computing the
exponential of a matrix.
-
matt_message,
a program which
simulates the operation of a satellite warning system which communicates
by a series of formatted messages indicating the location and type of
various threats.
-
md,
a program which
carries out a molecular dynamics (MD) simulation, and is intended as
a starting point for implementing an OpenMP parallel version.
-
md_openmp,
a program which
carries out a molecular dynamics (MD) simulation
in parallel using OpenMP.
-
medit_io,
a library which
can read or write files used by the MEDIT program, which can be used
to define the a mesh associated with the finite element method (FEM)
in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.
-
medit_to_fem,
a program which
reads a mesh file created by the MEDIT program
and writes a corresponding pair of node and element files that correspond
to the FEM format.
-
memory_test,
a program which
tests the memory available on the computer by declaring
and using big vectors.
-
mesh_bandwidth,
a program which
returns the geometric bandwidth associated with a mesh of
elements of any order and in a space of M dimensions.
-
mesh_io,
a library which
reads or writes MESH files defining a finite element mesh.
-
mesh_to_ice,
a program which
reads a MESH file containing an ICE dataset and rewrites the
information as a NETCDF file.
-
metis_test,
C programs which
call metis to partition unstructured graphs or meshes, and compute fill-reducing
reorderings of sparse matrices.
-
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.
-
mgs,
a library which
is an example of legacy code, which the student is encouraged to
study, understand, and document.
This example is due to Diane O'Leary.
-
mixed,
programs which
illustrate the use of mixed language programming in which the main
routine is written in C;
-
mm_io,
a library which
reads and writes a Matrix Market (MM) Sparse Matrix File;
-
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_value,
a library which
evaluates a monomial in M dimensions.
-
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.
-
mpi,
programs which
illustrate the use of the Message Passing Interface (MPI)
library, for parallel programming;
-
mpi_stubs,
a library which
may be used if a parallel program is to be compiled, loaded
and run in a serial machine.
-
mri_to_ascii,
a program which
converts the binary data in a Magnetic Resonance Imaging (MRI) file
to ASCII text.
-
mri_to_pgm,
a program which
converts the binary data in a Magnetic Resonance Imaging (MRI) file
to a sequence of Portable Gray Map (PGM) image files.
-
multigrid_poisson_1d,
a library which
applies the multigrid method to a discretized version of the
1D Poisson equation.
-
multitask_mpi,
a program which
demonstrates how to multitask, that is, to execute several unrelated
and distinct tasks simultaneously, using MPI for parallel execution.
-
multitask_openmp,
a program which
demonstrates how to multitask, that is, to execute several unrelated
and distinct tasks simultaneously,
using OpenMP for parallel execution.
-
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_openmp,
a program which
computes a dense matrix product C=A*B,
using OpenMP for parallel execution.
-
mxm_serial,
a program which
sets up a matrix multiplication problem A=B*C,
intended as a starting point for implementing a parallel version.
-
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 points can be plotted with gnuplot.
-
nas,
a program which
runs the NASA kernel benchmark.
-
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_3d_exact,
a library which
evaluates an exact solution to the incompressible time-dependent
Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
-
nearest_interp_1d,
a library which
interpolates a set of data using a piecewise constant interpolant
defined by the nearest neighbor criterion,
creating graphics files for processing by gnuplot.
-
netcdf_test,
C programs which
read and write netcdf files.
-
newton_interp_1d,
a library which
finds a polynomial interpolant to data using Newton divided differences.
-
nintlib,
a library which
implements approximate integration (quadrature) in M dimensions;
-
normal,
a library which
implements random number generators (RNG's)
for normally distributed values.
-
nsasm,
a library which
computes the jacobian matrix associated
with a finite element method (FEM) approximation of the incompressible
steady Navier-Stokes equations (NSE) in 2D, and to store these as
a sparse matrix, by Per-Olof Persson.
-
obj_to_ply,
a program which
converts a 3D graphics file from OBJ format to
PLY format format, by Greg Turk.
-
ode,
a library which
solves a system of ordinary differential equations (ODEs),
by Shampine and Gordon;
-
ode_moshier,
a library which
implements the Adams-Bashforth-Moulton and Runge-Kutta (RK) methods of
solving systems of ordinary differential equations (ODE's),
by Steven Moshier.
-
opengl,
programs which
illustrate the use of the OpenGL graphics library;
-
openmp,
programs which
illustrate the use of the OpenMP interface for
parallel programming shared memory system;
-
openmp_stubs,
a library which
is a dummy implementation of the OpenMP routines,
and can be used to compile, load, and run a program using OpenMP on a
system which does not have OpenMP installed.
-
optimize,
a program which
looks at the use of automatic optimization by the compiler
to make the executable code run faster.
-
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,
and creating graphics files for processing by gnuplot.
-
owens,
a library which
evaluates Owen's T function;
-
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 gnuplot graphics files.
-
partial_digest,
a library which
solves the partial digest problem;
-
partition_problem,
a library which
seeks solutions of the partition problem, splitting a set of integers
into two subsets with equal sum.
-
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.
-
pbma_io,
a library which
reads or writes an ASCII Portable Bit Map (PBM) bit map graphics file;
-
pbmb_io,
a library which
reads or writes a binary Portable Bit Map (PBM) graphics file;
-
pbmlib,
a library which
reads or writes graphics files in the Portable Bit Map (PBM) format;
-
pce_burgers,
a program which
solves a version of the time-dependent viscous Burgers equation,
with uncertain viscosity,
using a polynomial chaos expansion in terms of Hermite polynomials,
by Gianluca Iaccarino.
-
pce_ode_hermite,
a program which
sets up a simple scalar ordinary differential equation (ODE)
for exponential decay with an uncertain decay rate,
using a polynomial chaos expansion in terms of Hermite polynomials.
-
pcl_read,
a program which
reads a PCL file and extracts the numeric data;
-
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.
-
pentominoes,
a library which
provides some utilities for manipulating pentominoes.
-
peri1d,
a program which
sets up and solves a 1D time-dependent peridynamics problem,
by Miroslav Stoyanov;
-
peri2d,
a program which
sets up and solves a 2D time-dependent peridynamics problem,
by Miroslav Stoyanov;
petsc_test,
C programs which
illustrate the use of PETSC, a suite of data structures and routines
for the scalable parallel solution of scientific applications modeled
by partial differential equations.
-
pgma_io,
a library which
reads or writes ASCII Portable Gray Map (PGM) 2D graphics files;
-
pgmb_io,
a library which
reads or writes a binary Portable Gray Map (PGM) 2D graphics file;
-
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).
-
pig_latin,
a program which
converts its input to Pig Latin; a winner of the International
Obfuscated C Code Competition in the Most Humorous category,
by Don Dodson;
-
pink_noise,
a library which
computes a pink noise signal obeying a 1/f power law.
-
plato_ply,
a program which
writes a PLY graphics file for any platonic solid,
by Greg Turk.
-
ply_io,
a library which
reads or writes a 3D graphics file in PLY format,
by Greg Turk;
-
ply_to_iv,
a program which
converts a 3D graphics file from PLY format to Inventor (IV) format,
by Greg Turk.
-
ply_to_obj,
a program which
converts a 3D graphics file from PLY format to OBJ format,
by Greg Turk.
-
png_io,
a library which
reads and writes files in the Portable Network Graphics (PNG) format.
-
point_merge,
a library which
considers N points in M dimensional space, and counts or indexes
the unique or tolerably unique items.
-
poisson_mpi,
a program which
computes a solution to the Poisson equation in a rectangle,
using the Jacobi iteration to solve the linear system, and MPI to
carry out the Jacobi iteration in parallel.
-
poisson_openmp,
a program which
computes a solution to the Poisson equation in a rectangle,
using the Jacobi iteration to solve the linear system, and OpenMP to
carry out the Jacobi iteration in parallel.
-
poisson_serial,
a program which
computes a solution to the Poisson equation in a rectangle,
and is intended as the starting point for the creation of a
parallel version.
-
poisson_simulation,
a library which
simulates a Poisson process in which events randomly occur with an
average waiting time of Lambda,
creating graphics files for processing by gnuplot.
-
polpak,
a library which
evaluates a variety of mathematical functions, including
Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre,
Legendre polynomials, and the Collatz sequence.
-
polygon_grid,
a library which
generates a grid of points
over the interior of a polygon in 2D.
-
polygon_integrals,
a library which
returns the exact value of the integral of any monomial
over the interior of a polygon in 2D.
-
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_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_triangulate,
a library which
triangulates a possibly nonconvex polygon in 2D,
and which can use gnuplot to display the external edges and
internal diagonals of the triangulation.
-
polynomial,
a library which
adds, multiplies, differentiates, evaluates and prints multivariate
polynomials in a space of M dimensions.
-
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_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_enumerate,
a library which
enumerates chiral, fixed and free polyominoes of moderate order.
-
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_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_transform,
a program which
transforms the matrix representing a polyomino by reflection and
rotation.
-
power_method,
a library which
carries out the power method for finding a dominant eigenvalue
and its eigenvector.
-
power_rule,
a program which
constructs a power rule, that is, a product quadrature rule
from identical 1D factor rules.
-
ppc_xmalloc,
a library which
manages the allocation of memory, from
Rostamian's "Programming Projects in C";
-
ppma_io,
a library which
reads or writes an ASCII Portable Pixel Map (PPM) 2D graphics file;
-
ppmb_io,
a library which
reads or writes a binary Portable Pixel Map (PPM) 2D graphics file;
-
praxis,
a library which
minimizes a scalar function of several variables, without
requiring derivative information,
by Richard Brent.
-
prime_mpi,
a program which
counts the number of primes between 1 and N,
using MPI for parallel execution.
-
prime_openmp,
a program which
counts the number of primes between 1 and N,
using OpenMP for parallel execution.
-
prime_serial,
a program which
counts the number of primes between 1 and N,
and is intended as a starting point for a parallel version.
-
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.
-
product_rule,
a program which
creates an M-dimensional quadrature rule
from a product of distinct 1d quadrature rules;
-
pthreads,
programs which
illustrate the use of the POSIX thread library to carry out
parallel program execution.
-
pwl_approx_1d,
a library which
approximates a set of data using a piecewise linear function.
-
pwl_interp_1d,
a library which
interpolates a set of data using a piecewise linear function.
creating graphics files for processing by gnuplot.
-
pwl_interp_2d,
a library which
evaluates a piecewise linear interpolant to data defined on
a regular 2D grid.
-
pwl_interp_2d_scattered,
a library which
evaluates a piecewise linear interpolant to data which is available
at an irregularly arranged set of points.
-
pyramid_exactness,
a program which
investigates the polynomial exactness of a quadrature rule
over the interior of the unit pyramid in 3D.
-
pyramid_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a pyramid in 3D.
-
pyramid_grid,
a library which
computes a grid of points
over the interior of the unit pyramid in 3D;
-
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_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_rule,
a program which
computes a quadrature rule
over the interior of the unit pyramid in 3D.
-
qr_solve,
a library which
computes the linear least squares (LLS) solution of a system A*x=b.
-
quad_mpi,
a program which
applies a quadrature rule to estimate an
integral, working in parallel by using MPI;
-
quad_openmp,
a program which
applies a quadrature rule to estimate an integral over a 1D interval,
using OpenMP for parallel execution;
-
quad_serial,
a program which
applies a quadrature rule to estimate an integral,
intended as a starting point for parallelization exercises.
-
quad2d_openmp,
a program which
applies a product quadrature rule to estimate an integral
over a 2D rectangle, using OpenMP for parallel execution;
-
quad2d_serial,
a program which
applies a product quadrature rule to estimate an integral
over a 2D rectangle, intended as a starting point
for parallelization exercises.
-
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).
-
quadrature_golub_welsch,
a library which
computes the points and weights of a Gaussian quadrature rule using
the Golub-Welsch procedure.
-
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_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_2d,
a library which
computes the weights of a 2D quadrature rule using the Vandermonde
matrix, assuming that the points have been specified.
-
quadrule,
a library which
defines quadrature rules for approximating integrals;
-
quaternions,
a library which
carries out some simple arithmetic operations for quaternions.
-
r4lib,
a library which
contains many utility routines,
using single precision real (R4) arithmetic.
-
r83,
a library which
contains linear algebra routines for R83 matrices
(real, 64 bit, tridiagonal 3xN format).
-
r83_np,
a library which
contains linear algebra routines for R83_NP matrices
(real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
-
r83p,
a library which
contains linear algebra routines for R83P matrices
(real, 64 bit, tridiagonal periodic format).
-
r83s,
a library which
contains linear algebra routines for R83S matrices
(real, 64 bit, tridiagonal scalar format).
-
r83t,
a library which
contains linear algebra routines for R83t matrices
(real, 64 bit, tridiagonal Mx3 format).
-
r83v,
a library which
contains linear algebra routines for R83V matrices
(real, 64 bit, tridiagonal three vector format).
-
r85,
a library which
contains linear algebra routines for R85 matrices
(real, 64 bit, pentadiagonal format).
-
r8bb,
a library which
contains linear algebra routines for R8BB matrices
(real, 64 bit, border banded format).
-
r8blt,
a library which
contains linear algebra routines for R8BLT matrices
(real, 64 bit, band lower triangular format).
-
r8bto,
a library which
contains linear algebra routines for R8BTO matrices
(real, 64 bit, block Toeplitz format).
-
r8but,
a library which
contains linear algebra routines for R8BUT matrices
(real, 64 bit, band upper triangular format).
-
r8cb,
a library which
contains linear algebra routines for R8CB matrices
(real, 64 bit, Compressed Band format).
-
r8cbb,
a library which
contains linear algebra routines for R8CBB matrices
(real, 64 bit, Compressed Border Banded format).
-
r8cc,
a library which
contains linear algebra routines for R8CC matrices
(real, 64 bit, Compressed Column (Colptr,Row,Value) format).
-
r8ci,
a library which
contains linear algebra routines for R8CI matrices
(real, 64 bit, circulant format).
-
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.
-
r8gb,
a library which
contains linear algebra routines for R8GB matrices
(real, 64 bit, General Banded format).
-
r8gd,
a library which
contains linear algebra routines for R8GD matrices
(real, 64 bit, general diagonal format).
-
r8ge,
a library which
contains linear algebra routines for R8GE matrices
(real, 64 bit, General format).
-
r8ge_np,
a library which
contains nonpivoting linear algebra routines for R8GE_NP matrices
(real, 64 bit, General nonpivoting format).
-
r8lib,
a library which
contains many utility routines,
using double precision real (R8) arithmetic.
-
r8lt,
a library which
contains linear algebra routines for R8LT matrices
(real, 64 bit, lower triangular format).
-
r8ltt,
a library which
contains linear algebra routines for R8LTT matrices
(real, 64 bit, lower triangular Toeplitz format).
-
r8ncf,
a library which
contains linear algebra routines for R8NCF matrices
(real, 64 bit, nonsymmetric coordinate format).
-
r8pbl,
a library which
contains linear algebra routines for R8PBL matrices
(real, 64 bit, positive definite symmetric band lower format).
-
r8pbu,
a library which
contains linear algebra routines for R8PBU matrices
(real, 64 bit, positive definite symmetric band upper format).
-
r8po,
a library which
contains linear algebra routines for R8PO matrices
(real, 64 bit, positive definite symmetric format).
-
r8poly,
a library which
contains a number of utilities for polynomials with R8 coefficients,
that is, using double precision or 64 bit real arithmetic.
-
r8pp,
a library which
contains linear algebra routines for R8PP matrices
(real, 64 bit, positive definite symmetric packed format).
-
r8ri,
a library which
contains linear algebra routines for R8RI matrices
(real, 64 bit, row-indexed format).
-
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.
-
r8s3,
a library which
contains linear algebra routines for R8S3 matrices
(real, 64 bit, SLAP triad (I,J,AIJ) format).
-
r8sd,
a library which
contains linear algebra routines for R8SD matrices
(real, 64 bit, symmetric diagonal format).
-
r8sm,
a library which
contains linear algebra routines for R8SM matrices
(real, 64 bit, Sherman-Morrison A-u*v' format).
-
r8sp,
a library which
contains linear algebra routines for R8SP matrices
(real, 64 bit, SLAP triad (I,J,AIJ) format).
-
r8sr,
a library which
carries out linear algebra operations for R8SR matrices
(real, 64 bit, diagonal + compressed row offdiagonal format).
-
r8ss,
a library which
carries out linear algebra operations for R8SS matrices
(real, 64 bit, symmetric skyline format).
-
r8sto,
a library which
contains linear algebra routines for R8STO matrices
(real, 64 bit, symmetric Toeplitz N format).
-
r8to,
a library which
contains linear algebra routines for R8TO matrices
(real, 64 bit, Toeplitz 2*N-1 format).
-
r8ut,
a library which
contains linear algebra routines for R8UT matrices
(real, 64 bit, upper triangular format).
-
r8vm,
a library which
contains linear algebra routines for R8VM matrices
(real, 64 bit, Vandermonde format).
-
rand48,
a program which
demonstrates the rand48 family of random number generators (RNG's)
available in the C/C++ standard library.
-
randlc,
a library which
implements a random number generator (RNG)
used by the NAS Benchmark programs.
-
random_data,
a library which
uses a random number generator (RNG) to sample points for
various probability distributions, spatial dimensions, and geometries,
including the M-dimensional cube, ellipsoid, simplex and sphere.
-
random_mpi,
a program which
demonstrates one way to generate the same sequence of random numbers
for both sequential execution and parallel execution under MPI.
-
random_openmp,
a program which
illustrates how a parallel program using OpenMP can generate multiple
distinct streams of random numbers.
-
random_sorted,
a library which
generates vectors of random values which are already sorted.
-
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.
-
rbf_interp_1d,
a library which
defines and evaluates radial basis function (RBF) interpolants
to 1D data.
-
rbf_interp_2d,
a library which
defines and evaluates radial basis function (RBF) interpolants
to 2D data.
-
rbf_interp_nd,
a library which
defines and evaluates radial basis function (RBF) interpolants
to M-dimensional data.
-
rbox,
a program which
generates random sets of points
for testing computational geometry algorithms;
-
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."
-
ring_mpi,
a program which
uses the MPI parallel programming environment, and measures the time
necessary to copy a set of data around a ring of processes.
-
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.
-
rkf45,
a library which
applies the Runge-Kutta-Fehlberg (RKF)
algorithm to solve a system of ordinary differential equations (ODE's);
-
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.
-
root_rc,
a library which
seeks a solution of a scalar nonlinear equation f(x)=0,
using reverse communication (RC), by Gaston Gonnet.
-
roots_rc,
a library which
seeks solutions of a system of nonlinear equations,
using reverse communication (RC), by Gaston Gonnet.
-
rot13,
a program which
makes a copy of a file which has
been encoded using the ROT13 coding and a ROT5 coding for digits.
-
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.
-
sandia_rules,
a library which
can produce a standard 1D Gauss quadrature rule of
Chebyshev, Gegenbauer, generalized Hermite, generalized Laguerre,
Hermite, Jacobi, Laguerre, and Legendre types.
-
satisfy,
a program which
demonstrates, for a particular circuit, an exhaustive search
for solutions of the circuit satisfy problem.
-
satisfy_mpi,
a program which
demonstrates, for a particular circuit, an exhaustive search
for solutions of the circuit satisfy problem,
using MPI to perform the calculation in parallel.
-
satisfy_openmp,
a program which
demonstrates, for a particular circuit, an exhaustive search
for solutions of the circuit satisfy problem,
using OpenMP for parallel execution.
-
schedule_openmp,
a program which
demonstrates the default, static, and dynamic methods of scheduling
loop iterations in OpenMP to avoid work imbalance.
-
screenshot_opengl,
a program which
shows how a program using the OpenGL graphics library can save a
screenshot of the graphics being displayed.
-
sde,
a library which
illustrates properties of
stochastic ordinary differential equations (SODE's), and
common algorithms for their analysis, including the Euler method,
the Euler-Maruyama method, and the Milstein method,
making graphics files for processing and display by gnuplot,
by Desmond Higham;
-
search_mpi,
a program which
searches integers between A and B for a solution J such that F(J)=C,
carried out in parallel using MPI.
-
search_serial,
a program which
searches the integers from A to B for a value J such that F(J) = C.
this version of the program is intended as a starting point for
a parallel approach.
-
set_theory,
a library which
demonstrates various set theoretic operations
using several models of a set.
-
sftpack,
a library which
implements the slow Fourier transform, intended as a teaching
tool and comparison with the Fast Fourier Transform (FFT).
-
sgefa_openmp,
a program which
compares a standard linear algebra solver against a revised version
which can be run in parallel with OpenMP.
-
sgmga,
a library which
creates sparse grids using a mixture of 1D quadrature rule families,
allowing user specified growth rates for each family,
allowing anisotropic weights for each dimension.
-
shallow_water_1d,
a program which
simulates the evolution of a 1D fluid governed by the
time-dependent shallow water equations.
-
shepard_interp_1d,
a library which
defines and evaluates Shepard interpolants to 1D data,
based on inverse distance weighting.
-
shepard_interp_2d,
a library which
defines and evaluates Shepard interpolants to 2D data,
based on inverse distance weighting.
-
shepard_interp_nd,
a library which
defines and evaluates Shepard interpolants to M-dimensional data,
based on inverse distance weighting.
-
showme,
a program which
displays triangulations and meshes,
by Jonathan Shewchuk;
-
simplex_coordinates,
a library which
computes the Cartesian coordinates of the vertices of a regular
simplex in M dimensions.
-
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_grid,
a library which
generates a regular grid of points
over the interior of an arbitrary simplex in M dimensions.
-
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_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit simplex in M dimensions.
-
sine_transform,
a library which
demonstrates some simple properties of the discrete sine transform.
-
smolpack,
a library which
estimates the integral of a function
over an M-dimensional hypercube using a sparse grid,
by Knut Petras;
-
snakes_and_ladders,
programs which
simulate and investigate a one-player version of the game
of Snakes and Ladders.
-
solve,
a library which
implements a linear solver which makes it easy to create
doubly-dimensioned arrays and solve associated linear systems.
-
sort_rc,
a library which
can sort a list of any kind of objects,
using reverse communication (RC).
-
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_grid_cc,
a library which
creates sparse grids based on Clenshaw-Curtis rules.
-
sparse_grid_cc_dataset,
a program which
creates a sparse grid dataset based on Clenshaw-Curtis rules.
-
sparse_grid_hw,
a library which
creates sparse grids based on Gauss-Legendre, Gauss-Hermite,
Gauss-Patterson, or a nested variation of Gauss-Hermite rules,
by Florian Heiss and Viktor Winschel.
-
sparse_interp_nd,
a library which
can be used to define a sparse interpolant to a function f(x) of a
multidimensional argument.
-
sphere_exactness,
a program which
tests the polynomial exactness of a quadrature rule
over the surface of the unit sphere in 3D;
-
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_grid,
a library which
provides a number of ways of generating grids of points, or of
points and lines, or of points and lines and faces,
over the surface of the unit sphere in 3D.
-
sphere_integrals,
a library which
defines test functions for integration
over the surface of the unit sphere in 3D.
-
sphere_lebedev_rule,
a library which
computes Lebedev quadrature rules
over the surface of the unit sphere in 3D;
-
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_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_monte_carlo,
a library which
applies a Monte Carlo method to estimate the integral of a function
over the surface of the unit sphere in 3D;
-
sphere_quad,
a library which
used triangulation to approximate an integral
over the surface of the unit sphere in 3D;
-
sphere_stereograph,
a library which
computes the stereographic mapping between points on the
unit sphere in 3D
and points on the plane Z = 1; a generalized mapping is
also available.
-
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_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.
-
spiral_data,
a library which
computes a velocity vector field that satisfies the continuity
equation, writing the data to a file that can be plotted
by gnuplot.
-
spline,
a library which
interpolates or approximates data by piecewise polynomial functions;
-
spring_ode,
a program which
shows how line printer graphics can be used to illustrate
a solution of the ordinary differential equation (ODE) that describes
the motion of a weight attached to a spring.
-
spring_ode2,
a program which
shows how gnuplot graphics can be used to illustrate
a solution of the ordinary differential equation (ODE) that describes
the motion of a weight attached to a spring.
-
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_exactness,
a library which
investigates the polynomial exactness of quadrature rules for f(x,y)
over the interior of a rectangle in 2D.
-
square_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a square in 2D.
-
square_grid,
a library which
computes a grid of points
over the interior of a square in 2D.
-
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_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_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_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.
-
st_io
a library which
reads and writes sparse linear systems
stored in the Sparse Triplet (ST) format.
-
st_to_cc,
a library which
converts sparse matrix data from Sparse Triplet (ST) format
to Compressed Column (CC) format;
-
star_discrepancy,
a program which
computes bounds on the star discrepancy of a set of N points
in M dimensions,
by Eric Thiemard.
-
stochastic_diffusion,
functions which
implement several versions of a stochastic diffusivity coefficient.
-
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,
using gnuplot to illustrate the results.
-
stochastic_rk,
a library which
applies a Runge-Kutta (RK) scheme to a
stochastic ordinary differential equation (SODE).
-
stokes_2d_exact,
a library which
evaluates exact solutions to the incompressible steady
Stokes equations over the unit square in 2D.
-
string_simulation,
a program which
simulates the behavior of a vibrating string
by solving the corresponding initial boundary value problem (IBVP),
creating files that can be displayed by gnuplot.
-
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.
-
subpak,
a library which
contains many utility routines;
-
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_sum,
a program which
seeks solutions of the subset sum problem.
-
subset_sum_serial,
a program which
seeks solutions of the subset sum problem,
intended as a starting point for a parallel computing approach.
-
super_blas,
a library which
implements some of the BLAS routines, for
particular use by superlu;
-
superlu_openmp,
programs which
illustrate how to use the superlu library with the
OpenMP parallel programming interface,
which applies a fast direct solution method to solve
sparse linear systems,
by James Demmel, John Gilbert, and Xiaoye Li.
-
superlu_test,
C programs which
illustrate how to use the superlu library,
which applies a fast direct solution method to solve
sparse linear systems,
by James Demmel, John Gilbert, and Xiaoye Li.
-
svd_demo,
a program which
demonstrates the calculation of the
singular value decomposition (SVD) and some of its properties;
-
svd_snowfall,
a program which
reads a file containing historical snowfall data and
analyzes the data with the Singular Value Decomposition (SVD).
-
svd_truncated,
a program which
demonstrates the computation of the reduced or truncated
Singular Value Decomposition (SVD) that is useful for cases when
one dimension of the matrix is much smaller than the other.
-
sweep2,
a program which
computes Voronoi Diagrams or Delaunay triangulations,
by Steve Fortune;
-
table_io,
a library which
reads and writes a simple dataset stored as a table file;
-
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.
-
test_approx,
a library which
implements test problems for approximation,
provided as a set of (x,y) data.
-
test_eigen,
a library which
implements test matrices for eigenvalue analysis.
-
test_int,
a library which
implements test problems for
approximate integration (quadrature) in one dimension.
-
test_int_2d,
a library which
implements test problems for
approximate integration (quadrature) in two dimensions.
-
test_interp,
a library which
defines test problems for interpolation,
provided as a set of (x,y) data.
-
test_interp_1d,
a library which
defines test problems for interpolation of data y(x),
which depends on a 1D argument.
-
test_interp_2d,
a library which
defines test problems for interpolation of data z(x,y),
which depends on a 2D argument.
-
test_interp_nd,
a library which
defines test problems for interpolation of data z(x),
depending on an M-dimensional argument.
-
test_lls,
a library which
implements linear least squares (LLS) test problems of the form A*x=b.
-
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_matrix_exponential,
a library which
defines a set of test cases for computing the matrix exponential.
-
test_min,
a library which
implements test problems for
minimization of a scalar function of a scalar variable.
-
test_nearest,
a library which
tests the time complexity of various procedures for solving the
nearest neighbor problem.
-
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_optimization,
a library which
implements test problems for optimization
of a scalar function of several variables,
as described by Molga and Smutnicki.
-
test_partial_digest,
a library which
can generate example cases of the partial digest problem.
-
test_values,
a library which
returns a small set of values
for a variety of mathematical functions,
suitable for a rough test of accuracy for algorithms;
-
test_zero,
a library which
implements test problems for the solution
of a single nonlinear equation in one variable.
-
testpack,
a program which
demonstrates the use of
a set of test integrand functions chosen by Alan Genz.
-
tet_mesh,
a library which
carries out various tasks associated with tetrahedral meshes in 3D;
-
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_exactness,
a program which
tests the polynomial exactness of a quadrature rule
over the interior of a tetrahedron in 3D.
-
tetrahedron_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a tetrahedron in 3D.
-
tetrahedron_grid,
a library which
computes a grid of points
over the interior of a tetrahedron in 3D.
-
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_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_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of a general tetrahedron in 3D.
-
tetrahedron_ncc_rule,
a library which
defines Newton-Cotes closed (NCC) quadrature rules
over the interior of a tetrahedron in 3D.
-
tetrahedron_nco_rule,
a library which
defines Newton-Cotes open (NCO) quadrature rules
over the interior of a tetrahedron in 3D.
-
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,
of a tetrahedron in 3D.
-
tetrahedron01_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit tetrahedron in 3D.
-
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.
-
timer,
programs which
illustrate how to estimate the CPU time taken
by a portion of a program;
-
timestamp,
a library which
returns the current YMDHMS date as a timestamp,
and performs other timing chores;
-
toeplitz_cholesky,
a library which
computes the Cholesky factorization of
a nonnegative definite symmetric Toeplitz matrix.
-
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.
-
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.
-
toms178,
a library which
seeks the minimizer of a function of several variables, using the
Hooke-Jeeves direct search method, by Arthur Kaupe.
This is a version of ACM TOMS algorithm 178.
-
toms179,
a library which
calculates the incomplete Beta ratio,
by Oliver Ludwig;
this is a version of ACM TOMS algorithm 179.
-
toms291
a library which
approximates the logarithm of the Gamma function;
This is a version of ACM TOMS algorithm 291.
-
toms322,
a library which
evaluates the F and Student's T Cumulative Density Function (CDF);
This is a version of ACM TOMS algorithm 322.
-
toms443,
a library which
evaluates Lambert's W function.
This is a version of ACM TOMS algorithm 443.
-
toms446,
a library which
manipulates Chebyshev series for interpolation and approximation.
This is a version of ACM TOMS algorithm 446,
by Roger Broucke.
-
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.
-
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.
-
toms577,
a library which
evaluates Carlson's elliptic integral functions RC, RD, RF and RJ.
This is a version of ACM TOMS algorithm 577.
-
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.
-
toms722,
a library which
supports IEEE arithmetic.
This is a version of ACM TOMS algorithm 722.
-
toms743,
a library which
evaluates Lambert's W function.
This is a version of ACM TOMS algorithm 743,
by Barry, Barry and Culligan-Hensley.
-
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.
-
toms917,
a library which
evaluates the Wright Omega function,
by Piers Lawrence, Robert Corless, David Jeffrey.
This is a version of ACM TOMS algorithm 917.
-
treepack,
a library which
carries out computations on trees,
a simple kind of graph that is minimally connected.
-
triangle,
a program which
generates meshes, Delaunay triangulations, and Voronoi diagrams,
by Jonathan Shewchuk;
-
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_bench,
a script which
times the execution of the triangle() program on a sequence of
sets of randomly generated nodes in the unit square.
-
triangle_exactness,
a program which
tests the polynomial exactness of a quadrature rule
over the interior of a triangle in 2D.
-
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_felippa_rule,
a library which
returns Felippa's quadratures rules for approximating integrals
over the interior of a triangle in 2D.
-
triangle_grid,
a library which
computes a grid of points
over the interior of a triangle in 2D.
-
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_interpolate,
a library which
shows how vertex data can be interpolated at any point
in the interior of a triangle.
-
triangle_io,
a library which
can read or write some of the files created by Jonathan Shewchuk's
triangle program.
-
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_ncc_rule,
a library which
defines Newton-Cotes closed (NCC) quadrature rules
over the interior of a triangle in 2D.
-
triangle_nco_rule,
a library which
defines Newton-Cotes open (NCO) quadrature rules
over the interior of a triangle in 2D.
-
triangle_properties,
a library which
computes properties, including angles, area, centroid, circumcircle,
edge lengths, incircle, orientation, orthocenter, and quality,
of a triangle in 2D.
-
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_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_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_medit,
a program which reads the NODE and ELE files
created by the triangle() program to
describe a triangular mesh, and writes a corresponding MESH file
for input to medit().
-
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.
-
triangle01_integrals,
a library which
returns the integral of any monomial
over the interior of the unit triangle in 2D.
-
triangle01_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit triangle in 2D.
-
triangulate,
a program which
triangulates a polygonal region,
by Joseph ORourke;
-
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_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_svg,
a program which
creates an SVG image of a triangulation, which can be displayed
by a web browser.
-
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;
-
trig_to_neib,
a program which
reads node and ele files,
a format prescribed by Shewchuk's triangle program,
describing a triangulation, and produces a file defining the
neighbor triangles of each element; the program can also produce
information about the Voronoi diagram. The program is by Lili Ju.
-
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_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].
-
tsp_brute,
a program which
reads a file of city-to-city distances and solves a (small!)
traveling salesperson problem (TSP), using brute force.
-
ubvec,
a library which
demonstrates how nonnegative integers can be stored as
unsigned binary vectors, and arithmetic can be performed on them.
-
umfpack,
examples which
illustrate how to solve a sparse linear system by calling
the C library UMFPACK, by Timothy Davis.
-
unicycle,
a library which
considers permutations containing a single cycle,
sometimes called cyclic permutations.
-
uniform,
a library which
contains uniform random number generators (RNG's) for several
arithmetic types.
-
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.
-
valgrind_test,
C programs which
illustrate the use of the valgrind suite of programs which includes
a memory leak detector.
-
van_der_corput,
a library which
computes elements of
the van der Corput one-dimensional Quasi Monte Carlo (QMC) sequence,
using a simple interface.
-
vandermonde,
a library which
implements the Bjork-Pereyra algorithm for accurate solution of
linear systems involving the Vandermonde matrix.
-
vandermonde_approx_1d,
a library which
finds a polynomial approximant to data y(x) of a 1D argument
by solving an overdetermined linear system
for the polynomial coefficients involving the Vandermonde matrix.
-
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_interp_1d,
a library which
finds a polynomial interpolant to data y(x) of a 1D argument
by setting up and solving a linear system
for the polynomial coefficients involving the Vandermonde matrix,
creating graphics files for processing by gnuplot.
-
vandermonde_interp_2d,
a library which
finds a polynomial interpolant to data z(x,y) of a 2D argument
by setting up and
solving a linear system for the polynomial coefficients
involving the Vandermonde matrix.
-
walker_sample,
a library which
efficiently samples a discrete probability vector using
Walker sampling.
-
walsh,
a library which
implements versions of the Walsh and Haar transforms.
-
wathen,
a library which
compares storage schemes (full, banded, sparse triplet ) and
solution strategies (Linpack full, Linpack banded,
conjugate gradient (CG)) for linear systems involving the Wathen
matrix, which can arise when solving a problem using the
finite element method (FEM).
-
wave_mpi,
a program which
uses the finite difference method (FDM) and MPI
to estimate a solution to the wave equation.
-
wavelet,
a library which
does some simple wavelet calculations;
-
wedge_exactness,
a program which
investigates the polynomial exactness of a quadrature rule
over the interior of the unit wedge in 3D.
-
wedge_felippa_rule,
a library which
returns quadrature rules for approximating integrals
over the interior of the unit wedge in 3D.
-
wedge_grid,
a library which
computes a grid of points
over the interior of the unit wedge in 3D.
-
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_monte_carlo,
a library which
uses the Monte Carlo method to estimate an integral
over the interior of the unit wedge in 3D.
-
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.
-
wishart,
a library which
produces sample matrices from the Wishart or Bartlett distributions,
useful for sampling random covariance matrices.
-
wtime,
a library which
returns a reading of the wall clock time in seconds.
-
xdr,
a library which
allows a user to transfer
data between computers which have different data storage conventions.
-
zero_rc,
a library which
seeks a solution of a scalar nonlinear equation f(x)=0,
using reverse communication (RC), by Richard Brent.
-
ziggurat,
a library which
samples the uniform, normal or exponential distributions,
using the ziggurat method, by Marsaglia and Tsang.
-
ziggurat_inline,
a library which
samples the uniform, normal or exponential distributions,
using the ziggurat method, by Marsaglia and Tsang.
In this original version, the random number generators are
implemented inline, for increased speed.
-
ziggurat_openmp,
a program which
demonstrates how the ziggurat library can be used as a
random number generator (RNG) in an OpenMP parallel program.
You can go up one level to
the main web page.
Last revised on 03 June 2017.