Fortran77 Source Codes
-
analemma,
a Fortran77 code 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
-
args,
a Fortran77 code which
reports the command line arguments of a Fortran77 program;
-
args_test
-
asa005,
a Fortran77 code which
evaluates the Cumulative Density Function (CDF) of the noncentral T
Probability Density Function (PDF), by BE Cooper.
This is a version of Applied Statistics Algorithm 5;
-
asa005_test
-
asa006,
a Fortran77 code which
computes the Cholesky factorization of a symmetric positive
definite (SPD) matrix, by Michael Healy.
This is a version of Applied Statistics Algorithm 6;
-
asa006_test
-
asa007,
a Fortran77 code which
computes the inverse of a symmetric positive definite (SPD) matrix,
by Michael Healy.
This is a version of Applied Statistics Algorithm 7.
-
asa007_test
-
asa032,
a Fortran77 code which
evaluates the incomplete Gamma function,
by G Bhattacharjee.
This is a version of Applied Statistics Algorithm 32.
-
asa032_test
-
asa047,
a Fortran77 code 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 Fortran77 code 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 Fortran77 code which
implements the K-means data clustering algorithm,
by David Sparks.
This is a version of Applied Statistics Algorithm 58.
-
asa058_test
-
asa063,
a Fortran77 code 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 Fortran77 code which
evaluates the Cumulative Density Function (CDF) of the normal
probability distribution, by David Hill.
This is a version of Applied Statistics Algorithm 66.
-
asa066_test
-
asa076,
a Fortran77 code which
evaluates the Owen T function, needed to compute the
Cumulative Density Function (CDF) of the
noncentral T distribution,
by Young and Minder.
This is a version of Applied Statistics Algorithm 76.
-
asa076_test
-
asa082,
a Fortran77 code which
computes the determinant of an orthogonal matrix;
this is a version of Applied Statistics Algorithm 82,
by J C Gower.
-
asa082_test
-
asa091,
a Fortran77 code which
evaluates the percentage points of the Chi-Squared distribution,
by Best and Roberts.
This is a version of Applied Statistics Algorithm 91.
-
asa091_test
-
asa103,
a Fortran77 code which
evaluates the digamma or psi function,
by Jose Bernardo.
This is a version of Applied Statistics Algorithm 103.
-
asa103_test
-
asa109,
a Fortran77 code which
inverts the incomplete Beta function,
by Cran, Martin and Thomas.
This is a version of Applied Statistics Algorithm 109.
-
asa109_test
-
asa111,
a Fortran77 code which
evaluates the percentage points of the normal distribution,
by Beasley and Springer.
This is a version of Applied Statistics Algorithm 111.
-
asa111_test
-
asa113,
a Fortran77 code which
implements a clustering algorithm using transfers and swaps,
by Banfield and Bassill.
This is a version of Applied Statistics Algorithm 113.
-
asa113_test
-
asa121,
a Fortran77 code which
evaluates the trigamma function,
by BE Schneider.
This is a version of Applied Statistics Algorithm 121.
-
asa121_test
-
asa136,
a Fortran77 code which
implements a clustering algorithm,
by Hartigan and Wong.
This is a version of Applied Statistics Algorithm 136.
-
asa136_test
-
asa144,
a Fortran77 code which
randomly generates an RxC contingency table,
by James Boyett.
This is a version of Applied Statistics Algorithm 144.
-
asa144_test
-
asa147,
a Fortran77 code which
evaluates the incomplete Gamma function,
by Chi Leung Lau.
This is a version of Applied Statistics Algorithm 147.
-
asa147_test
-
asa152,
a Fortran77 code which
evaluates the Probability Density Function (PDF)
and Cumulative Density Function
(CDF) associated with the hypergeometric distribution,
by Richard Lund;
this is a version of Applied Statistics Algorithm 152.
-
asa152_test
-
asa159,
a Fortran77 code which
randomly generates an RxC contingency table,
by Michael Patefield;
This is a version of Applied Statistics Algorithm 159.
-
asa159_test
-
asa172,
a Fortran77 code which
generates all M-dimensional indices in a given range,
simulating the behavior of an arbitrary number of nested loops,
by OFlaherty and MacKenzie.
this is a version of Applied Statistics Algorithm 172;
-
asa172_test
-
asa183,
a Fortran77 code which
implements a random number generator (RNG),
by Wichman and Hill.
This is a version of Applied Statistics Algorithm 183.
-
asa183_test
-
asa189,
a Fortran77 code which
estimates the parameters of a beta binomial distribution based on a
sample of values generated by the distribution, by D Smith;
this is a version of Applied Statistics Algorithm 189;
-
asa189_test
-
asa205,
a Fortran77 code which
generates all the contingency
tables corresponding to a given set of row and column sums.
This is a version of Applied Statistics Algorithm 205;
-
asa205_test
-
asa226,
a Fortran77 code which
evaluates the Cumulative Density Function (CDF)
of the noncentral Beta distribution,
by Russell Lenth.
This is a version of Applied Statistics Algorithm 226.
-
asa226_test
-
asa239,
a Fortran77 code which
evaluates the incomplete Gamma function,
by Shea.
This is a version of Applied Statistics Algorithm 239.
-
asa239_test
-
asa241,
a Fortran77 code which
evaluates the percentage points of the normal distribution,
by Michael Wichura.
This is a version of Applied Statistics Algorithm 241.
-
asa241_test
-
asa243,
a Fortran77 code which
evaluates the Cumulative Density Function (CDF)
of the noncentral T distribution,
by Russell Lenth;
this is a version of Applied Statistics Algorithm 243.
-
asa243_test
-
asa245,
a Fortran77 code which
evaluates the logarithm of the Gamma function,
by Allan Mcleod;
this is a version of Applied Statistics Algorithm 245.
-
asa245_test
-
asa266,
a Fortran77 code which
evaluates various properties of
the Dirichlet Probability Density Function (PDF);
This is a version of Applied Statistics Algorithm 266.
-
asa266_test
-
asa299,
a Fortran77 code which
computes the lattice points in an M-dimensional simplex,
by Chasalow and Brand;
this is a version of Applied Statistics Algorithm 299;
-
asa299_test
-
asa310,
a Fortran77 code which
computes the Cumulative Density Function (CDF)
of the noncentral Beta distribution, by Chattamvelli and Shanmugam;
this is a version of Applied Statistics Algorithm 310.
-
asa310_test
-
asa314,
a Fortran77 code which
computes the inverse of a matrix whose elements are subject to
modulo arithmetic,
by Roger Payne.
This is a version of Applied Statistics Algorithm 314;
-
asa314_test
-
atkinson,
a Fortran77 code which
contains examples from Atkinson's Elementary Numerical Analysis text.
-
atkinson_test
-
backtrack_binary_rc,
a Fortran77 code which
carries out a backtrack search for a set of binary decisions, using
reverse communication (RC).
-
backtrack_binary_rc_test
-
backward_euler,
a Fortran77 code which
solves one or more ordinary differential equations (ODE)
using the (implicit) backward Euler method, using a version
of fsolve() for the implicit equation.
-
backward_euler_test
-
ball_grid,
a Fortran77 code which
computes grid points inside a 3D ball.
-
ball_grid_test
-
ball_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit ball in 3D.
-
ball_integrals_test
-
ball_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the unit ball in 3D;
-
ball_monte_carlo_test
-
band_qr,
a Fortran77 code which
computes the QR factorization of a banded matrix, and can solve
related linear systems,
by Alfredo Remon, Enrique Quintana-Orti, Gregorio Quintana-Orti.
-
band_qr_test
-
barycentric_interp_1d,
a Fortran77 code which
defines and evaluates the barycentric Lagrange polynomial p(x)
which interpolates a set of data, so that p(x(i)) = y(i).
The barycentric approach means that very high degree polynomials can
safely be used.
-
barycentric_interp_1d_test
-
bdf2,
a Fortran77 code which
solves one or more ordinary differential equations (ODE)
using the (implicit) backward difference formula of order 2 (BDF2),
using fsolve() to solve the implicit equation.
-
bdf2_test
-
bdmlib,
a Fortran77 code which
estimates the weights in a Dirichlet mixtured based on sample data;
-
bdmlib_test
-
bellman_ford,
a Fortran77 code which
implements the Bellman-Ford algorithm for finding the shortest distance
from a given node to all other nodes in a directed graph whose
edges have been assigned real-valued lengths.
-
bellman_ford_test
-
bernstein_polynomial,
a Fortran77 code which
evaluates the Bernstein polynomials;
-
bernstein_polynomial_test
-
beta_nc,
a Fortran77 code which
evaluates the cumulative density function (CDF)
of the noncentral Beta distribution;
-
beta_nc_test
-
biharmonic_fd2d,
a Fortran77 library which
solves a version of the biharmonic equation in two dimensions,
by Petter Bjorstad.
I could not get this code to run a simple test case!
-
biharmonic_fd2d_test
-
bins,
a Fortran77 code which
orders, sorts and searches data using bins;
-
bins_test
-
bisection_integer,
a Fortran77 code which
seeks an integer solution to the equation F(X)=0,
using bisection within a user-supplied change of sign interval [A,B].
-
bisection_integer_test
-
bisection_rc,
a Fortran77 code 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.
-
bisection_rc_test
-
black_scholes,
a Fortran77 code which
implements some simple approaches to
the Black-Scholes option valuation theory,
creating graphics files for processing by gnuplot(),
by Desmond Higham.
-
black_scholes_test
-
blas,
a Fortran77 code 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_test
-
blas1_c,
a Fortran77 code which
constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS),
for vector-vector operations
using single precision complex arithmetic,
by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
-
blas1_c_test
-
blas1_d,
a Fortran77 code which
constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS),
for vector-vector operations
using double precision real arithmetic,
by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
-
blas1_d_test
-
blas1_s,
a Fortran77 code which
constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS),
for vector-vector operations
using single precision real arithmetic,
by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
-
blas1_s_test
-
blas1_z,
a Fortran77 code which
constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS),
for vector-vector operations
using double precision complex arithmetic,
by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
-
blas1_z_test
-
blas2_c,
a Fortran77 code which
constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS),
for matrix-vector operations
using single precision complex arithmetic.
-
blas2_c_test
-
blas2_d,
a Fortran77 code which
constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS),
for matrix-vector operations
using double precision real arithmetic.
-
blas2_d_test
-
blas2_s,
a Fortran77 code which
constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS),
for matrix-vector operations
using single precision real arithmetic.
-
blas2_s_test
-
blas2_z,
a Fortran77 code which
constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS),
for matrix-vector operations
using double precision complex arithmetic.
-
blas2_z_test
-
blas3_c,
a Fortran77 code which
constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS),
for matrix-matrix operations
using single precision complex arithmetic.
-
blas3_c_test
-
blas3_d,
a Fortran77 code which
constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS),
for matrix-matrix operations
using double precision real arithmetic.
-
blas3_d_test
-
blas3_s,
a Fortran77 code which
constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS),
for matrix-matrix operations
using single precision real arithmetic.
-
blas3_s_test
-
blas3_z,
a Fortran77 code which
constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS),
for matrix-matrix operations
using double precision complex arithmetic.
-
blas3_z_test
-
blend,
a Fortran77 code which
carries out 1D/2D/3D blending interpolation;
-
blend_test
-
box_behnken,
a Fortran77 code which
computes a Box-Behnken design,
that is, a set of arguments to sample the behavior
of a function of multiple parameters;
-
box_behnken_test
-
brent,
a Fortran77 code which
contains routines for finding zeroes or minima of a scalar
function of a scalar variable,
without the use of derivative information, in the original
format,
by Richard Brent.
-
brent_test
-
brownian_motion_simulation,
a Fortran77 code which
simulates Brownian motion in an M-dimensional region,
creating graphics files for processing by gnuplot().
-
brownian_motion_simulation_test
-
bt_serial,
a Fortran77 code which
a serial version of the nas Block Tridiagonal (BT) Parallel Benchmark.
-
bt_serial_test
-
bufpak,
a Fortran77 code which
reads and writes data to an
unformatted, direct access file.
-
bufpak_test
-
burgers_exact,
a Fortran77 code which
evaluates an exact solution of the
time-dependent 1D viscous Burgers equation.
-
burgers_exact_test
-
bvec,
a Fortran77 code which
demonstrates how signed integers can be stored as
binary vectors, and arithmetic can be performed on them.
-
bvec_test
-
bvls,
a Fortran77 code which
applies least squares methods to solve a linear system for which
lower and upper constraints may have been placed on every variable,
by Charles Lawson and Richard Hanson.
-
bvls_test
-
bvpsol,
a Fortran77 code which
solves a highly nonlinear two point boundary value problem (BVP)
using a local linear solver condensing algorithm or a
global sparse linear solver for the solution of the arising
linear subproblems,
by Peter Deuflhard, Georg Bader, Lutz Weimann.
-
bvpsol_test
-
c4lib,
a Fortran77 code which
implements certain elementary functions for
single precision complex variables;
-
c4lib_test
-
c8lib,
a Fortran77 code which
implements certain elementary functions for
double precision complex variables;
-
c8lib_test
-
calcomp,
a Fortran77 code which
accepts several
calls to Calcomp pen plotter routines, and tries to create a
PostScript file corresponding to the desired image.
-
candy_count,
a Fortran77 code which
counts the types of candy in a rectangular container, which might be
a vector, matrix, or 3D box. The candy is assumed to have C possible
types, and to have been entered into the container in a cycle that
begins with type 1. While the vector case is easy, it is already
difficult to come up with a general formula for the MxN matrix case.
-
candy_count_test
-
calcomp_test
-
cauchy_principal_value,
a Fortran77 code which
uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value
(CPV) of certain singular integrals.
-
cauchy_principal_value_test
-
ccn_rule,
a Fortran77 code which
defines a one of a sequence of nested Clenshaw Curtis
quadrature rules of any order.
-
ccn_rule_test
-
ccs_io,
a Fortran77 code which
reads and writes sparse linear systems
stored in the Compressed Column Storage (CCS) format.
-
ccs_io_test
-
ccs_to_st,
a Fortran77 code which
converts a sparse matrix from Compressed Column Storage (CCS) to
sparse triplet (ST) format.
-
ccs_to_st_test
-
cell,
a Fortran77 code which
defines a cell array, a generalization of an array which
can compactly store and retrieve vector or matrix data of
varying size, such as the rows of a triangular matrix.
-
cell_test
-
cellular_automaton,
a Fortran77 code which
demonstrates the 1D Cellular Automaton known as rule #30.
-
cellular_automaton_test
-
cg,
a Fortran77 code which
implements a simple version of the conjugate gradient (CG) method
for solving a system of linear equations of the form A*x=b,
suitable for situations in which the matrix A is positive definite,
only real, positive eigenvalues and symmetric.
-
cg_test
-
cg_plus,
a Fortran77 code which
implements the conjugate gradient method for the
minimization of a scalar functional;
-
cg_plus_test
-
cg_rc,
a Fortran77 code which
implements the conjugate gradient method for solving
a positive definite sparse linear system A*x=b,
using reverse communication.
-
cg_rc_test
-
change_dynamic,
a Fortran77 code which
uses dynamic programming to solve the change making problem,
in which a given sum is to be formed using coins of various
denominations.
-
change_dynamic_test
-
chebyshev,
a Fortran77 code which
computes the Chebyshev interpolant/approximant to a given function
over an interval.
-
chebyshev_test
-
chebyshev_interp_1d,
a Fortran77 code which
determines the combination of Chebyshev polynomials which
interpolates a set of data, so that p(x(i)) = y(i).
-
chebyshev_interp_1d_test
-
chebyshev_polynomial,
a Fortran77 code 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_polynomial_test
-
chebyshev_series,
a Fortran77 code which
can evaluate a Chebyshev series approximating a function f(x),
while efficiently computing one, two or three derivatives of the
series, which approximate f'(x), f''(x), and f'''(x),
by Manfred Zimmer.
-
chebyshev_series_test
-
chrpak,
a Fortran77 code which
analyzes and manipulates character strings;
-
chrpak_test
-
circle_arc_grid,
a Fortran77 code which
computes grid points along a circular arc.
-
circle_arc_grid_test
-
circle_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the circumference of the unit circle in 2D.
-
circle_integrals_test
-
circle_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
along the circumference of the unit circle in 2D;
-
circle_monte_carlo_test
-
circle_rule,
a Fortran77 code which
computes quadrature rules for the unit circle in 2D, that is, the
circumference of the circle of radius 1 and center (0,0).
-
circle_rule_test
-
circle_segment,
a Fortran77 code which
carries out computations associated with a circle segment, including
height, angle, area, centroid, sampling, and quadrature,
creating some graphics images using gnuplot().
-
circle_segment_test
-
clebsch_gordan,
a Fortran77 code which
evaluates Clebsch-Gordan coefficients involved in
angular momentum coupling in quantum mechanics;
-
clebsch_gordan_test
-
clenshaw_curtis_rule,
a Fortran77 code which
implements a Clenshaw Curtis quadrature rule;
-
clenshaw_curtis_rule_test
-
closest_point_brute,
a Fortran77 code which
uses brute force to find the nearest of a set of N points in D
dimensions to a given test point. This is sometimes called a
nearest neighbor calculation.
-
closest_point_brute_test
-
cnf_io,
a Fortran77 code which
reads or writes DIMACS Conjunctive Normal Form (CNF) files
defining satisfiability problems in terms of a boolean formula.
-
cnf_io_test
-
colnew,
a Fortran77 code which
solves a system of boundary value problems (BVP),
a mixed-order system of ordinary differential equations (ODE)
subject to separated, multipoint boundary conditions, using
collocation at Gaussian points, by Uri Ascher and Georg Bader.
-
colnew_test
-
colored_noise,
a Fortran77 code which
generates samples of noise obeying a 1/f^alpha power law.
-
colored_noise_test
-
combination_lock,
a Fortran77 code which
simulates the process of determining the secret combination of a lock.
-
combination_lock_test
-
combo,
a Fortran77 code which
ranks, unranks, enumerates, lists and
randomly selects balanced sequences, cycles, graphs, Gray codes,
subsets, partitions, permutations, restricted growth functions,
Pruefer codes and trees.
-
combo_test
-
communicator_mpi,
a Fortran77 code which
creates new communicators involving a subset of initial
set of MPI processes in the default communicator MPI_COMM_WORLD.
-
communicator_mpi_test
-
companion_matrix,
a Fortran77 code which
computes the companion matrix for a polynomial.
The polynomial may be represented in the standard monomial basis,
or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange
basis polynomials. All the roots of the polynomial can be determined as
the eigenvalues of the corresponding companion matrix.
-
companion_matrix_test
-
compass_search,
a Fortran77 code which
seeks the minimizer of a scalar function of several variables
using compass search,
a direct search algorithm that does not use derivatives.
-
compass_search_test
-
complex_numbers_test,
a Fortran77 code which
demonstrates some simple features involved in the use of
complex numbers in Fortran77 programming.
-
components,
a Fortran77 code which
organizes contiguous cells into labeled clusters, for a
1D, 2D, or 3D array. This code has uses in image analysis
and percolation simulation.
-
components_test
-
condition,
a Fortran77 code which
implements methods of computing or estimating
the condition number of a matrix.
-
condition_test
-
conte_deboor,
a Fortran77 code which
contains examples from Conte and deBoor's Elementary Numerical
Analysis text.
-
conte_deboor_test
-
cordic,
a Fortran77 code which
computes a few special functions using the CORDIC algorithm.
-
cordic_test
-
correlation,
a Fortran77 code which
contains examples of statistical correlation functions.
-
correlation_test
-
cube_arbq_rule,
a Fortran77 code which
returns quadrature rules,
with exactness up to total degree 15,
over the interior of the symmetric cube in 3D,
by Hong Xiao and Zydrunas Gimbutas.
-
cube_arbq_rule_test
-
cube_exactness,
a Fortran77 code which
investigates the polynomial exactness of quadrature rules
over the interior of a cube in 3D.
-
cube_exactness_test
-
cube_felippa_rule,
a Fortran77 code which
returns Felippa's quadratures rules for approximating integrals
over the interior of a cube in 3D.
-
cube_felippa_rule_test
-
cube_grid,
a Fortran77 code which
computes a grid of points
over the interior of a cube in 3D.
-
cube_grid_test
-
cube_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit cube in 3D.
-
cube_integrals_test
-
cube_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit cube in 3D.
-
cube_monte_carlo_test
-
cwg_ode,
a Fortran77 code which
contains three ODE solvers by William Gear.
-
cwg_ode_test
-
cycle_brent,
a Fortran77 code which
carries out an iterated function evaluation,
and seeks to determine the nearest element of a cycle,
and the cycle's length, using Brent's method.
-
cycle_brent_test
-
cycle_floyd,
a Fortran77 code which
carries out an iterated function evaluation,
and seeks to determine the nearest element of a cycle,
and the cycle's length, using Floyd's method.
-
cycle_floyd_test
-
cyclic_reduction,
a Fortran77 code which
solves a tridiagonal linear system using cyclic reduction;
-
cyclic_reduction_test
-
diaphony,
a Fortran77 code which
reads a file of N points in M dimensions and computes its diaphony,
a measure of point dispersion.
-
diaphony_test
-
differ,
a Fortran77 code which
is given function values at equally spaced locations, and the
order of a derivative, and uses the finite difference method (FDM)
to compute a linear combination of these function values which
approximated that derivative.
-
differ_test
-
dijkstra,
a Fortran77 code which
implements a simple version of Dijkstra's minimum distance algorithm
for graphs.
-
dijkstra_test
-
dijkstra_openmp,
a Fortran77 code which
uses OpenMP to parallelize a simple example of Dijkstra's
minimum distance algorithm for graphs.
-
dijkstra_openmp_test
-
discrete_pdf_sample_2d,
a Fortran77 code which
demonstrates how to construct a Probability Density Function (PDF)
from a table of sample data, and then to use that PDF to create
new samples.
-
discrete_pdf_sample_2d_test
-
disk_grid,
a Fortran77 code which
computes grid points within the interior of
a disk of user specified radius and center in 2D,
using gnuplot() to create an image of the grid.
-
disk_grid_test
-
disk_rule,
a Fortran77 code which
computes quadrature rules
over the interior of a disk of radius R centered at the origin.
-
disk_rule_test
-
disk01_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit disk in 2D.
-
disk01_integrals_test
-
disk01_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the unit disk in 2D;
-
disk01_monte_carlo_test
-
disk01_rule,
a Fortran77 code which
computes quadrature rules for the unit disk in 2D, that is,
the interior of the circle of radius 1 and center (0,0).
-
disk01_rule_test
-
dislin_test,
a Fortran77 code which
calls dislin(), which
is an extensive scientific graphics package.
-
divdif,
a Fortran77 code which
creates, prints and manipulates divided difference polynomials from
a table of values (x,f(x)). The code can compute the coefficients of
the Newton and power sum forms of the interpolating polynomial. It
can compute the derivative or antiderivate polynomial. It can compute
the form of the Lagrange basis polynomials. It can compute the
points and weights for Newton Cotes quadrature rules. It can compute
the weights for a Lagrange interpolation scheme.
-
divdif_test
-
doomsday,
a Fortran77 code which
is given the year, month and day of a date, and uses
John Conway's doomsday algorithm to determine the corresponding
day of the week.
-
doomsday_test
-
driv,
a Fortran77 code which
includes solvers for systems of real or complex ordinary differential
equations (ODE),
by Kahaner and Sutherland.
-
driv_test
-
duel_simulation,
a Fortran77 code which
simulates N repetitions of a duel between two players, each of
whom has a known firing accuracy.
-
duel_simulation_test
-
edge,
a Fortran77 code 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.
-
edge_test
-
eigs,
a Fortran77 code which
computes the eigenvalues and
eigenvectors of a matrix.
-
eigs_test
-
eispack,
a Fortran77 code which
carries out eigenvalue computations;
superseded by LAPACK;
-
eispack_test
-
element_data,
a Fortran77 code which
preprocesses
simple element-based data on a grid into a form that the display4()
code can handle.
-
element_data_test
-
ellipse_grid,
a Fortran77 code which
computes a grid of points
over the interior of an ellipse in 2D.
-
ellipse_grid_test
-
ellipse_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate the value of integrals
over the interior of an ellipse in 2D.
-
ellipse_monte_carlo_test
-
ellipsoid_grid,
a Fortran77 code which
computes a grid points
over the interior of an ellipsoid in 3D.
-
ellipsoid_grid_test
-
ellipsoid_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate the value of integrals
over the interior of an ellipsoid in M dimensions.
-
ellipsoid_monte_carlo_test
-
elliptic_integral,
a Fortran77 code which
evaluates complete elliptic integrals of first, second and third kind,
using Carlson's elliptic integral functions.
-
elliptic_integral_test
-
euler,
a Fortran77 code which
solves one or more ordinary differential equations (ODE)
using the forward Euler method.
-
euler_test
-
exactness,
a Fortran77 code which
investigates the exactness of quadrature rules that estimate the
integral of a function with a density, such as 1, exp(-x) or
exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).
-
exactness_test
-
expokit,
a Fortran77 code which
solves various forms of the matrix exponential problem,
by Roger Sidje.
-
expokit_test
-
f77,
a Fortran77 code which
illustrates features of Fortran77;
-
f77_test
-
f77_calls_c,
a Fortran77 code which
illustrates how a Fortran77 program calls a C function.
-
f77_calls_c++,
a Fortran77 code which
illustrates how a Fortran77 program calls a C++ function.
-
f77_calls_matlab,
a Fortran77 code which
illustrates how a Fortran77 program interacts with MATLAB;
-
f77_combinatorics,
a Fortran77 code which
considers a variety of problems in combinatorics involving
counting, combinations, permutations, and so on.
-
f77_condor,
a Fortran77 code which
illustrates how a Fortran77 program runs in batch mode
using the condor queueing system.
-
f77_exact,
a Fortran77 code which
evaluates exact solutions to a few selected examples of
ordinary differential equations (ODE) and partial differential
equations (PDE).
-
f77_intrinsics_test,
a Fortran77 code which
illustrates the use of some of the intrinsic functions
included with the F77 standard language;
-
f77_mistake,
a Fortran77 code which
illustrates some simple but devious programming mistakes.
-
f77_return,
a Fortran77 code which
illustrates how a program returns a program status value
to the calling environment.
-
f77_rule,
a Fortran77 code which
computes a quadrature rule which
estimates the integral of a function f(x), which might be defined over
a one dimensional region (a line) or more complex shapes such as
a circle, a triangle, a quadrilateral, a polygon, or a higher
dimensional region, and which might include an associated weight
function w(x).
-
fair_dice_simulation,
a Fortran77 code which
simulates N tosses of 2 dice,
writing graphics files for processing by gnuplot().
-
fair_dice_simulation_test
-
fd_predator_prey,
a Fortran77 code which
solves a pair of predator prey ordinary differential
equations (ODE) using a finite difference approximation.
-
fd_predator_prey_test
-
fd1d_advection_diffusion_steady,
a Fortran77 code 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_diffusion_steady_test
-
fd1d_advection_ftcs,
a Fortran77 code 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 FTCS method, forward time difference,
centered space difference,
writing graphics files for processing by gnuplot().
-
fd1d_advection_ftcs_test
-
fd1d_advection_lax,
a Fortran77 code 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_test
-
fd1d_advection_lax_wendroff,
a Fortran77 code 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_advection_lax_wendroff_test
-
fd1d_burgers_lax,
a Fortran77 code which
applies the finite difference method (FDM)
and the Lax Wendroff method
to solve the non-viscous time-dependent Burgers equation
in one spatial dimension.
-
fd1d_burgers_lax_test
-
fd1d_burgers_leap,
a Fortran77 code which
applies the finite difference method (FDM) and the leapfrog approach
to solve the non-viscous time-dependent Burgers equation
in one spatial dimension.
-
fd1d_burgers_leap_test
-
fd1d_bvp,
a Fortran77 code which
applies the finite difference method (FDM)
to a two point boundary value problem (BVP) in one spatial dimension.
-
fd1d_bvp_test
-
fd1d_heat_explicit,
a Fortran77 code which
implements a finite difference method (FDM), explicit in time, of the
time dependent 1D heat equation;
-
fd1d_heat_explicit_test
-
fd1d_heat_implicit,
a Fortran77 code which
implements a finite difference method (FDM), implicit in time, of the
time dependent 1D heat equation;
-
fd1d_heat_implicit_test
-
fd1d_heat_steady,
a Fortran77 code which
implements a finite difference method (FDM) for the steady
time-independent 1D heat equation;
-
fd1d_heat_steady_test
-
fd1d_predator_prey,
a Fortran77 code which
implements the finite difference method (FDM) for a predator-prey
system with time and 1D spatial dependence, by Marcus Garvie.
-
fd1d_predator_prey_test
-
fd1d_wave,
a Fortran77 code which
applies the finite difference method (FDM) to solve the time-dependent
wave equation utt = c * uxx in one spatial dimension.
-
fd1d_wave_test
-
fd2d_heat_steady,
a Fortran77 code which
implements a finite difference method (FDM) for the steady
time-independent 2D heat equation;
-
fd2d_heat_steady_test
-
fem_basis,
a Fortran77 code which
defines and evaluates basis functions associated with
the finite element method (FEM) for any degree
in an M-dimensional simplex: 1D interval, 2D triangle,
3D tetrahedron, and higher dimensional generalizations.
-
fem_basis_test
-
fem_io,
a Fortran77 code which
reads or writes FEM files,
which describe the nodes, elements, and function values
associated with a finite element method (FEM) model;
-
fem_io_test
-
fem_to_gmsh,
a Fortran77 code which
reads a pair of FEM files defining node coordinates and elements,
of a 1D, 2D or 3D mesh, namely
a file of node coordinates and a file of elements defined by
node indices, and creates a gmsh() mesh file.
-
fem_to_gmsh_test
-
fem_to_triangle,
a Fortran77 code which
reads FEM files defining a 2D mesh of triangles, namely
a file of node coordinates and a file of elements defined by
node indices, and creates a corresponding pair of node
and element files for use by Jonathan Shewchuk's triangle() program.
-
fem_to_triangle_test
-
fem_to_xml,
reads a pair of FEM files defining node coordinates and elements,
of a 1D, 2D or 3D mesh, namely
a file of node coordinates and a file of elements defined by
node indices, and creates a corresponding XML file for input
to dolfin() or fenics().
-
fem_to_xml_test
-
fem1d,
a Fortran77 code which
applies the finite element method (FEM),
with piecewise linear (PWL) basis functions, to a linear
two point boundary value problem (BVP) in 1D;
-
fem1d_test
-
fem1d_adaptive,
a Fortran77 code which
uses an adaptive mesh when applying the finite element method (FEM),
with piecewise linear (PWL) basis functions, to a linear
two point boundary value problem (BVP) in 1D;
-
fem1d_adaptive_test
-
fem1d_bvp_linear,
a Fortran77 code which
applies the finite element method (FEM),
with piecewise linear (PWL) elements,
to a two point boundary value problem (BVP) in one spatial dimension.
-
fem1d_bvp_linear_test
-
fem1d_bvp_quadratic,
a Fortran77 code which
applies the finite element method (FEM),
with piecewise quadratic (PWQ) elements,
to a two point boundary value problem (BVP) in one spatial dimension,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem1d_bvp_quadratic_test
-
fem1d_heat_steady,
a Fortran77 code which
implements the finite element method (FEM) for the steady
time-independent 1D heat equation;
-
fem1d_heat_steady_test
-
fem1d_lagrange,
a Fortran77 code which
sets up the matrices and vectors associated with the finite element
method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x),
using Lagrange basis polynomials.
-
fem1d_lagrange_test
-
fem1d_nonlinear,
a Fortran77 code which
applies the finite element method (FEM),
with piecewise linear (PWL) basis functions, to a nonlinear
two point boundary value problem (BVP) in 1D;
-
fem1d_nonlinear_test
-
fem1d_oden,
a Fortran77 code which
applies the finite element method (FEM) to a linear two point
boundary value problem (BVP) in one spatial dimension;
this code is an example for the Texas Finite Element Series,
by Eric Becker, Graham Carey and J Tinsley Oden.
-
fem1d_oden_test
-
fem1d_pack,
a Fortran77 code which
contains utilities for 1D finite element method (FEM) calculations.
-
fem1d_pack_test
-
fem1d_pmethod,
a Fortran77 code which
applies the p-method version of
the finite element method (FEM) to a linear
two point boundary value problem (BVP) in 1D;
-
fem1d_pmethod_test
-
fem1d_project,
a Fortran77 code which
projects data into a finite element space,
including the least squares approximation of data,
or the projection of a finite element solution
from one mesh to another.
-
fem1d_project_test
-
fem1d_sample,
a Fortran77 code which
samples a scalar or vector finite element function of one variable,
defined by a set of files in FEM format,
returning interpolated values at the sample points.
-
fem1d_sample_test
-
fem2d_bvp_linear,
a Fortran77 code which
applies the finite element method (FEM),
with piecewise linear (PWL) elements,
to a 2D boundary value problem (BVP) in a rectangle,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem2d_bvp_linear_test
-
fem2d_bvp_quadratic,
a Fortran77 code which
applies the finite element method (FEM),
with piecewise quadratic (PWQ) elements,
to a 2D boundary value problem (BVP) in a rectangle,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem2d_bvp_quadratic_test
-
fem2d_bvp_serene,
a Fortran77 code which
applies the finite element method (FEM), with serendipity elements,
to a 2D boundary value problem (BVP) in a rectangle,
and compares the computed and exact solutions
with the L2 and seminorm errors.
-
fem2d_bvp_serene_test
-
fem2d_oden,
a Fortran77 code which
implements a 2D calculations for
the finite element method (FEM);
-
fem2d_oden_test
-
fem2d_pack,
a Fortran77 code which
implements simple 2D calculations for
the finite element method (FEM);
-
fem2d_pack_test
-
fem2d_poisson_rectangle,
a Fortran77 code which
solves the 2D Poisson equation on a rectangle,
using the finite element method (FEM),
and piecewise quadratic (PWQ) triangular elements.
-
fem2d_poisson_rectangle_test
-
fem2d_poisson_rectangle_linear,
a Fortran77 code which
solves the 2D Poisson equation on a rectangle,
using the finite element method (FEM),
and piecewise linear (PWL) triangular elements.
-
fem2d_poisson_rectangle_linear_test
-
fem2d_sample,
a Fortran77 code which
samples a finite element
function, defined by FEM files,
three text files describing the nodes, triangles, and coefficients,
at arbitrary points.
-
fem2d_sample_test
-
feynman_kac_1d,
a Fortran77 code which
demonstrates the use of the Feynman-Kac algorithm
to solve Poisson's equation in a 1D interval by averaging
stochastic paths to the boundary.
-
feynman_kac_1d_test
-
feynman_kac_2d,
a Fortran77 code which
demonstrates the use of the Feynman-Kac algorithm
to solve Poisson's equation in a 2D ellipse by averaging
stochastic paths to the boundary.
-
feynman_kac_2d_test
-
feynman_kac_3d,
a Fortran77 code which
demonstrates the use of the Feynman-Kac algorithm
to solve Poisson's equation in a 3D ellipsoid by averaging
stochastic paths to the boundary.
-
feynman_kac_3d_test
-
fft_openmp,
a Fortran77 code which
demonstrates the computation of a Fast Fourier Transform (FFT)
in parallel, using OpenMP.
-
fft_openmp_test
-
fft_serial,
a Fortran77 code which
computes a Fast Fourier Transform (FFT), and is intended as
a starting point for implementing an OpenMP parallel version.
-
fft_serial_test
-
fftpack5.1,
a Fortran77 code which
contains version 5.1 of the FFTPACK
Fast Fourier Transform (FFT) package
by Paul Swarztrauber and Dick Valent;
-
fftpack5.1_test
-
fftw_test,
a Fortran77 code which
uses the fftw() Fast Fourier Transform (FFT) package,
by Matteo Frigo and Steven Johnson.
-
file_name_sequence,
a Fortran77 code which
demonstrates ways to generate a sequence of filenames, which can
be useful when generating a sequence of still snapshots
to be animated later.
-
file_name_sequence_test
-
files_multiple,
a Fortran77 code which
demonstrates how a program opens multiple output files at one time,
and write data to any one specific file it chooses.
-
files_multiple_test
-
filon_rule,
a Fortran77 code which
uses Filon's method to approximate integrals with an
oscillatory factor of sin(k*x) or cos(k*x).
-
filon_rule_test
-
filum,
a Fortran77 code which
performs various operations on files;
-
filum_test
-
fire_simulation,
a Fortran77 code which
simulates a forest fire over a rectangular array of trees,
starting at a single random location. It is intended as a starting
point for the development of a parallel version.
-
fire_simulation_test
-
fishpack,
a Fortran77 code which
solves the Poisson, Laplace, or Helmholtz
equation in 2D or 3D on a variety of geometries,
by Paul Swarztrauber and Roland Sweet.
-
fishpack_test
-
floyd,
a Fortran77 code which
implements Floyd's algorithm for finding the shortest distance
between pairs of nodes on a directed graph.
-
floyd_test
-
fn,
a Fortran77 code which
evaluates elementary and special functions,
by Wayne Fullerton.
-
fn_test
-
freefem++_msh_io,
a Fortran77 code which
reads and writes files used by the FreeFem++ finite element program
to store mesh information.
-
freefem++_msh_io_test
-
fsolve,
a Fortran77 code which
solves systems of nonlinear equations,
inspired by the fsolve() function in minpack(),
with special interfaces fsolve_bdf2(), fsolve_be() and
fsolve_tr() for handling systems associated
with implicit ODE solvers of type bdf2, backward Euler,
midpoint, or trapezoidal.
-
fsolve_test
-
gdb_test,
a Fortran77 code which
calls gdb(), which
is the gnu debugger;
-
gegenbauer_polynomial,
a Fortran77 code which
evaluates the Gegenbauer polynomial and associated functions.
-
gegenbauer_polynomial_test
-
geometry,
a Fortran77 code which
carries out a number of 2D/3D geometric calculations;
-
geometry_test
-
geompack,
a Fortran77 code which
computes the Delaunay triangulation of a set of points
in the plane, by Barry Joe.
-
geompack_test
-
geqp3,
a Fortran77 code which
contains the portion of the lapack() library that carries out the
QR factorization, with column pivoting, of an M by N rectangular
matrix, with N <= M.
-
geqp3_test
-
gfortran_test,
a Fortran77 code which
calls gfortran(), which
is the gnu compiler for Fortran77.
-
gfortran_intrinsics_test,
a Fortran77 code which
illustrates the use of some of the intrinsic functions
included by the Gnu gfortran() compiler, above and beyond those
specified in the Fortran77 language standards.
-
gfortran_quadmath_test,
a Fortran77 code which
illustrates the use of quadruple precision real arithmetic,
as provided on some systems by the Gnu gfortran() compiler
for Fortran77.
-
glomin,
a Fortran77 code which
finds a global minimum of a scalar function of a scalar variable,
without the use of derivative information,
by Richard Brent.
-
glomin_test
-
gmsh_io,
a Fortran77 code which
reads or writes some of the files created by the gmsh()
program for 1D, 2D or 3D meshes
used by the finite element method (FEM).
-
gmsh_io_test
-
gmsh_to_fem,
a Fortran77 code which
reads a mesh data file created by the gmsh() program
and writes a pair of node and element files that correspond
to the FEM format.
-
gmsh_to_fem_test
-
gnuplot_test,
Fortran77 codes which
use gnuplot() to create various kinds of plots.
-
gprof_test,
Fortran77 codes which
illustrate the use of the GPROF program performance monitor;
-
graphics_test,
a Fortran77 code which
displays data graphically.
-
haar_transform,
a Fortran77 code which
computes the Haar transform of 1d or 2d data.
-
haar_transform_test
-
hb_read,
a Fortran77 code which
reads files
in the Harwell Boeing (HB) sparse matrix format;
This is a simplified interface intended to handle only the
most common format, complex unsymmetric assembled (CUA)
or real unsymmetric assembled (RUA).
-
hb_read_test
-
hb_to_st,
a Fortran77 code which
reads a sparse matrix in a Harwell-Boeing (HB) file and
writes an equivalent Sparse Triplet (ST) file.
-
hb_to_st_test
-
heat_mpi,
a Fortran77 code which
solves the 1D time dependent heat equation using MPI.
-
heat_mpi_test
-
heated_plate,
a Fortran77 code 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_test
-
heated_plate_openmp,
a Fortran77 code which
solves the steady time-independent heat equation in a 2D
rectangular region, using OpenMP to run in parallel.
-
heated_plate_openmp_test
-
hello,
a Fortran77 code which
prints out "Hello, world!".
-
hello_test
-
hello_mpi,
a Fortran77 code which
prints out "Hello, world!" using MPI for parallel programming.
-
hello_mpi_test
-
hello_openmp,
a Fortran77 code which
prints out "Hello, world!" within the OpenMP parallel programming
environment.
-
hello_openmp_test
-
helmholtz_openmp,
a Fortran77 code which
solves the discretized Helmholtz equation in 2D
using the OpenMP application program interface
for carrying out parallel computations in a shared memory environment.
-
helmholtz_openmp_test
-
hermite_cubic,
a Fortran77 code which
computes the value, derivatives or integral of
a Hermite cubic polynomial, or manipulates an interpolating function
made up of piecewise cubic Hermite (PWH) polynomials.
-
hermite_cubic_test
-
hermite_exactness,
a Fortran77 code which
tests the polynomial exactness of Gauss-Hermite quadrature rules
to estimate the integral of f(x) with density exp(-x^2)
over the interval (-oo,+oo).
-
hermite_exactness_test
-
hermite_integrands,
a Fortran77 code which
defines test integrands for Hermite integrals
with density exp(-x^2) over the interval (-oo,+oo).
-
hermite_integrands_test
-
hermite_interpolant,
a Fortran77 code which
computes the Hermite interpolant,
a polynomial that matches function values
and derivatives.
-
hermite_interpolant_test
-
hermite_polynomial,
a Fortran77 code which
evaluates the physicist's Hermite polynomial,
the probabilist's Hermite polynomial,
the Hermite function, and related functions.
-
hermite_polynomial_test
-
hermite_product_polynomial,
a Fortran77 code which
defines Hermite product polynomials, creating a multivariate
polynomial as the product of univariate Hermite polynomials.
-
hermite_product_polynomial_test
-
hermite_rule,
a Fortran77 code which
computes and writes out a Gauss-Hermite quadrature rule
of given order.
-
hermite_rule_test
-
high_card_simulation,
a Fortran77 code 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.
-
high_card_simulation_test
-
histogram_data_2d_sample,
a Fortran77 code which
demonstrates how to construct a Probability Density Function (PDF)
from sample data over a 2D domain,
and then to use that PDF to create new samples.
-
histogram_data_2d_sample_test
-
hyper_2f1,
a Fortran77 code which
evaluates the hypergeometric functions 2F1(a,b,c;x) for real
parameters a, b, c, and real or complex argument x,
by Shanjie Zhang, Jianming Jin;
-
hyper_2f1_test
-
hyperball_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit hyperball in M dimensions.
-
hyperball_integrals_test
-
hyperball_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit ball in M dimensions;
-
hyperball_monte_carlo_test
-
hypercube_exactness,
a Fortran77 code which
tests the polynomial exactness of a quadrature rule
over the interior of the unit hypercube in M dimensions.
-
hypercube_exactness_test
-
hypercube_grid,
a Fortran77 code which
computes a grid of points
over the interior of a hypercube in M dimensions.
-
hypercube_grid_test
-
hypercube_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit hypercube in M dimensions.
-
hypercube_integrals_test
-
hypercube_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit hypercube in M dimensions.
-
hypercube_monte_carlo_test
-
hypersphere,
a Fortran77 code which
carries out various operations for an M dimensional hypersphere,
including converting between Cartesian and spherical coordinates,
stereographic projection, sampling the surface of the sphere, and
computing the surface area and volume.
-
hypersphere_test
-
hypersphere_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the surface of the unit hypersphere in M dimensions.
-
hypersphere_integrals_test
-
hypersphere_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
on the surface of the unit sphere in M dimensions;
-
hypersphere_monte_carlo_test
-
i4lib,
a Fortran77 code which
contains many utility routines, using I4 or
single precision integer arithmetic.
-
i4lib_test
-
i8lib,
a Fortran77 code which
contains many utility routines, using I8 or
double precision integer arithmetic.
-
i8lib_test
-
image_denoise,
a Fortran77 code which
applies simple filtering operations to a noisy image.
-
image_denoise_test
-
image_edge,
a Fortran77 code which
demonstrates a simple procedure for edge detection in images.
-
image_edge_test
-
index,
a Fortran77 code which
converts a multidimensional vector index
to a one-dimensional vector index; it handles
zero and one based indexing schemes, as well as column major
and row major conventions.
-
index_test
-
inout,
a Fortran77 code which
computes the pressure and velocity for a flow governed by the
time-dependent Navier Stokes Equations (NSE) in a square 1D
region with an inlet and an outlet,
by Hyung-Chun Lee.
-
inout_test
-
interp,
a Fortran77 code which
parameterizes and interpolates data;
-
interp_test
-
ising_2d_simulation,
a Fortran77 code which
simulates the evolution of a 2D array of positive and negative
charges, each of which is likely to "flip" to be in agreement
with neighbors.
-
ising_2d_simulation_test
-
jacobi,
a Fortran77 code which
implements the Jacobi iteration for the iterative solution of
linear systems.
-
jacobi_test
-
jacobi_eigenvalue,
a Fortran77 code which
implements the Jacobi iteration for the iterative determination
of the eigenvalues and eigenvectors of a real symmetric matrix.
-
jacobi_eigenvalue_test
-
jacobi_polynomial,
a Fortran77 code which
evaluates the Jacobi polynomial and associated functions.
-
jacobi_polynomial_test
-
knapsack,
a Fortran77 code which
implements algorithms for a variety of combinatorial problems,
including bin packing, the subset sum problem, the generalized assignment
problem, the change making problem, the 01 knapsack problem, and the
multiple knapsack problem.
by Silvano Martelo and Paolo Toth.
-
knapsack_test
-
knapsack_01_brute,
a Fortran77 code which
uses brute force to solve small versions of the 0/1 knapsack problem;
-
knapsack_01_brute_test
-
kronrod_rule,
a Fortran77 code which
computes a Gauss and Gauss-Kronrod pair of quadrature rules
of arbitrary order,
by Robert Piessens, Maria Branders.
-
kronrod_rule_test
-
lagrange_approx_1d,
a Fortran77 code which
defines and evaluates the Lagrange polynomial p(x) of degree m
which approximates a set of nd data points (x(i),y(i)).
-
lagrange_approx_1d_test
-
lagrange_interp_1d,
a Fortran77 code which
defines and evaluates the Lagrange polynomial p(x)
which interpolates a set of data depending on a 1D argument,
so that p(x(i)) = y(i).
-
lagrange_interp_1d_test
-
lagrange_interp_2d,
a Fortran77 code which
defines and evaluates the Lagrange polynomial p(x,y)
which interpolates a set of data depending on a 2D argument
that was evaluated on a product grid,
so that p(x(i),y(j)) = z(i,j).
-
lagrange_interp_2d_test
-
lagrange_interp_nd,
a Fortran77 code 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).
-
lagrange_interp_nd_test
-
laguerre_exactness,
a Fortran77 code which
tests the polynomial exactness of Gauss-Hermite quadrature rules
for estimating the integral of a function with density exp(-x)
over the interval [0,+oo).
-
laguerre_exactness_test
-
laguerre_integrands,
a Fortran77 code which
implements test problems for quadrature rules
for estimating the integral of a function with density exp(-x)
over the interval [0,+oo).
-
laguerre_integrands_test
-
laguerre_polynomial,
a Fortran77 code which
evaluates the Laguerre polynomial,
the generalized Laguerre polynomials,
and the Laguerre function.
-
laguerre_polynomial_test
-
laguerre_rule,
a Fortran77 code which
computes and writes out a Gauss-Laguerre quadrature rule
for estimating the integral of a function with density exp(-x)
over the interval [0,+oo).
-
laguerre_rule_test
-
lamp,
a Fortran77 code which
implements algorithms for linear assignment and matching problems,
including the linear sum assignment problem, the linear bottleneck
assignment problem, the cardinality matching problem, the sum matching
problem, the bottleneck matching problem, the Chinese postman problem,
and the quadratic assignment problem,
by Rainer Burkard, Ulrich Derigs.
-
lamp_test
-
lapack,
a Fortran77 code which
is a linear algebra library.
-
lapack_test
-
lapack_eigen_test,
a Fortran77 code which
calls eigenvalue functions in lapack(), which
is a linear algebra library.
-
laplacian_matrix,
a Fortran77 code which
carries out computations related to the discrete
Laplacian operator, including full or sparse evaluation,
evaluation for unequally spaced data sampling points,
application to a set of data samples, solution of associated
linear systems, eigenvalues and eigenvectors, and extension
to 2D and 3D geometry.
-
laplacian_matrix_test
-
latin_cover,
a Fortran77 code which
produces N Latin squares which cover an NxN square, or NxN Latin cubes
which cover an NxNxN cube.
-
latin_cover_test
-
latin_random,
a Fortran77 code which
produces N points in an M-dimensional Latin Random Hypercube.
-
latin_random_test
-
latinize,
a Fortran77 code which
adjusts N points in M dimensions to form a Latin hypercube.
-
latinize_test
-
lawson,
a Fortran77 code which
contains routines for solving least squares problems
and the singular value decomposition (SVD),
by Lawson and Hanson.
-
lawson_test
-
lebesgue,
a Fortran77 code which
is given a set of nodes in 1D, and
plots the Lebesgue function, and estimates the Lebesgue constant,
which measures the maximum magnitude of the potential error
of Lagrange polynomial interpolation.
-
lebesgue_test
-
legendre_exactness,
a Fortran77 code which
tests the monomial exactness of quadrature rules for the Legendre
problem of integrating a function with density 1
over the interval [-1,+1].
-
legendre_exactness_test
-
legendre_fast_rule,
a Fortran77 code which
uses a fast order N algorithm to compute
a Gauss-Legendre quadrature rule of given order.
-
legendre_fast_rule_test
-
legendre_polynomial,
a Fortran77 code which
evaluates the Legendre polynomial and associated functions.
-
legendre_polynomial_test
-
legendre_product_polynomial,
a Fortran77 code which
defines Legendre product polynomials, creating a multivariate
polynomial as the product of univariate Legendre polynomials.
-
legendre_product_polynomial_test
-
legendre_rule,
a Fortran77 code which
writes out a Gauss-Legendre quadrature rule of given order.
-
legendre_rule_test
-
life_serial,
a Fortran77 code which
computes a few steps of the evolution of John Conway's Game of Life,
intended as a starting point for implementing a parallel version.
-
life_serial_test
-
line_cvt_lloyd,
a Fortran77 code which
applies Lloyd's iteration repeatedly to a set of N points,
to compute a Centroidal Voronoi Tessellation (CVT)
over the interior of a line segment in 1D.
-
line_cvt_lloyd_test
-
line_fekete_rule,
a Fortran77 code which
estimates the location of N Fekete points, for polynomial
interpolation or quadrature,
over the interior of a line segment in 1D.
-
line_fekete_rule_test
-
line_felippa_rule,
a Fortran77 code which
returns Felippa's quadratures rules for approximating integrals
over the interior of a line segment in 1D.
-
line_felippa_rule_test
-
line_grid,
a Fortran77 code which
computes a grid of points
over the interior of a line segment in 1D.
-
line_grid_test
-
line_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the length of the unit line in 1D.
-
line_integrals_test
-
line_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
over the length of the unit line in 1D.
-
line_monte_carlo_test
-
line_ncc_rule,
a Fortran77 code which
computes a Newton Cotes Closed (NCC) quadrature rule,
using equally spaced points,
over the interior of a line segment in 1D.
-
line_ncc_rule_test
-
line_nco_rule,
a Fortran77 code which
computes a Newton Cotes Open (NCO) quadrature rule,
using equally spaced points,
over the interior of a line segment in 1D.
-
line_nco_rule_test
-
linpack_bench,
a Fortran77 code which
carries out the linpack() benchmark;
-
linpack_bench_test
-
linpack_c,
a Fortran77 code which
constitutes a linear algebra library
for single precision complex arithmetic;
it includes a function for the singular value decomposition (SVD)
of a rectangular matrix.
The original version of this library is
by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
-
linpack_c_test
-
linpack_d,
a Fortran77 code which
constitutes a linear algebra library
for double precision real arithmetic;
it includes a function for the singular value decomposition (SVD)
of a rectangular matrix.
The original version of this library is
by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
-
linpack_d_test
-
linpack_s,
a Fortran77 code which
constitutes a linear algebra library;
for single precision real arithmetic;
it includes a function for the singular value decomposition (SVD)
of a rectangular matrix.
The original version of this library is
by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
-
linpack_s_test
-
linpack_z,
a Fortran77 code which
constitutes a linear algebra library
for double precision complex arithmetic;
it includes a function for the singular value decomposition (SVD)
of a rectangular matrix.
The original version of this library is
by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
-
linpack_z_test
-
linplus,
a Fortran77 code which
carries out operations such as matrix-vector products,
matrix factorization, direct and iterative linear solvers
for matrices in a variety of formats, including banded,
border-banded, circulant, lower triangular, pentadiagonal,
sparse, symmetric, toeplitz, tridiagonal, upper triangular
and vandermonde formats.
-
linplus_test
-
llsq,
a Fortran77 code which
solves the simple linear least squares problem of finding the formula
of a straight line y=a*x+b which minimizes the root-mean-square error
to a set of N data points.
-
llsq_test
-
lobatto_polynomial,
a Fortran77 code which
evaluates Lobatto polynomials similar to Legendre polynomials
except that they are 0 at both endpoints.
-
lobatto_polynomial_test
-
local_min,
a Fortran77 code which
finds a local minimum of a scalar function of a scalar variable,
without the use of derivative information,
by Richard Brent.
-
local_min_test
-
local_min_rc,
a Fortran77 code which
finds a local minimum of a scalar function of a scalar variable,
without the use of derivative information,
using reverse communication (RC),
by Richard Brent.
-
local_min_rc_test
-
lorenz_ode,
a Fortran77 code which
approximates solutions to the Lorenz system,
creating output files to be displayed by gnuplot().
-
lorenz_ode_test
-
machar,
a Fortran77 code which
computes the values of various machine characteristic constants;
-
machar_test
-
machine,
a Fortran77 code which
returns tabulated values of machine constants;
-
machine_test
-
mandelbrot,
a Fortran77 code which
generates an ASCII Portable Pixel Map (PPM) image
of the Mandelbrot set;
-
mandelbrot_test
-
mandelbrot_openmp,
a Fortran77 code which
generates an ASCII Portable Pixel Map (PPM) image of the
Mandelbrot fractal set, using OpenMP for parallel execution;
-
mandelbrot_openmp_test
-
matman,
a Fortran77 code which
allows a user to interactively define and manipulate matrices
using integer, real, or rational arithmetic, and to perform
various operations in linear algebra or linear programming modes.
-
matman_test
-
matmul,
a Fortran77 code which
carries out a matrix multiplication benchmark;
-
matmul_test
-
matrix_exponential,
a Fortran77 code which
computes the exponential function of a matrix.
-
matrix_exponential_test
-
md,
a Fortran77 code which
carries out a molecular dynamics simulation, and is intended as
a starting point for implementing an OpenMP parallel version.
-
md_test
-
md_openmp,
a Fortran77 code which
carries out a molecular dynamics simulation in parallel using OpenMP.
-
md_openmp_test
-
medit_mesh_io,
a Fortran77 code which
reads or writes files used by the MEDIT program, which
define a mesh associated with the finite element method (FEM)
in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.
-
medit_mesh_io_test
-
medit_to_fem,
a Fortran77 code 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.
-
medit_to_fem_test
-
mesh_bandwidth,
a Fortran77 code which
returns the geometric bandwidth associated with a mesh of
elements of any order and in a space of M dimensions.
-
mesh_bandwidth_test
-
mg_serial,
a Fortran77 code which
a serial version of the nas Multigrid (MG) Parallel Benchmark.
-
mg_serial_test
-
mgmres,
a Fortran77 code which
applies the restarted Generalized Minimum Residual (GMRES) algorithm
to solve a sparse linear system, using Compressed Row Storage (CRS) or
sparse triplet (ST) format, by Lili Ju.
-
mgmres_test
-
mgs,
a Fortran77 code 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.
-
mgs_test
-
midpoint,
a Fortran77 code which
solves one or more ordinary differential equations (ODE)
using the (implicit) midpoint method, with a version of
fsolve() handling the associated nonlinear equation,
and using a fixed time step.
-
midpoint_test
-
midpoint_explicit,
a Fortran77 code which
solves one or more ordinary differential equations (ODE)
using the (explicit) midpoint method, also called the
modified Euler method.
-
midpoint_explicit_test
-
midpoint_fixed,
a Fortran77 code which
solves one or more ordinary differential equations (ODE)
using the (implicit) midpoint method, using a fixed point
iteration for the nonlinear equation.
-
midpoint_fixed_test
-
minpack,
a Fortran77 code which
solves linear and nonlinear least squares problems,
by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
-
minpack_test
-
mixed,
a Fortran77 code which
uses mixed language programming in which
the main program is written in Fortran77;
-
mixed_test
-
mm_io,
a Fortran77 code which
reads or writes sparse matrices that use the
Matrix Market (MM) sparse matrix file format.
-
mm_io_test
-
monomial,
a Fortran77 code which
enumerates, lists, ranks, unranks and randomizes multivariate monomials
in a space of M dimensions, with total degree less than N,
equal to N, or lying within a given range.
-
monomial_test
-
monomial_value,
a Fortran77 code which
evaluates a monomial in M dimensions.
-
monomial_value_test
-
monte_carlo_rule,
a Fortran77 code which
generates a dataset of N random M-dimensional points,
regards it as a quadrature rule for the unit hypercube,
and writes out three files of information.
-
monte_carlo_rule_test
-
mpi,
Fortran77 codes which
use MPI for the parallel execution of programs;
-
mpi_test
-
multitask_mpi,
a Fortran77 code which
demonstrates how to multitask, that is, to execute several
unrelated and distinct tasks simultaneously, using MPI for
parallel execution.
-
multitask_mpi_test
-
multitask_openmp,
a Fortran77 code which
demonstrates how to multitask, that is, to execute several
unrelated and distinct tasks simultaneously, using OpenMP for
parallel execution.
-
multitask_openmp_test
-
mumps_test,
a Fortran77 code which
uses mumps() to solve a large linear algebraic system.
-
mus,
a Fortran77 code which
implements the multiple shooting method
for two point boundary value problems (BVP),
for linear or nonlinear cases,
by Robert Mattheij and G Staarink.
-
mus_test
-
mxm,
a Fortran77 code which
sets up a matrix multiplication problem A=B*C of arbitrary size,
and compares the time required for IJK, IKJ, JIK, JKI, KIJ
and KJI orderings of the loops.
-
mxm_test
-
mxm_openmp,
a Fortran77 code which
computes a dense matrix product C=A*B,
using OpenMP for parallel execution.
-
mxm_openmp_test
-
naca,
a Fortran77 code which
takes the parameters of certain NACA airfoils and return the
coordinates of a sequence of points that outline the wing shape.
The points are plotted with gnuplot().
-
naca_test
-
napack,
a Fortran77 code which
includes many routines for applied numerical linear algebra,
by William Hager.
-
napack_test
-
nas,
a Fortran77 code which
runs the NASA kernel benchmark.
-
nas_test
-
navier_stokes_2d_exact,
a Fortran77 code which
evaluates an exact solution to the incompressible time-dependent
Navier Stokes Equations (NSE) over an arbitrary domain in 2D.
-
navier_stokes_2d_exact_test
-
navier_stokes_3d_exact,
a Fortran77 code which
evaluates an exact solution to the incompressible time-dependent
Navier Stokes Equations (NSE) over an arbitrary domain in 3D.
-
navier_stokes_3d_exact_test
-
nearest_interp_1d,
a Fortran77 code which
interpolates a set of data using a piecewise constant (PWC) interpolant
defined by the nearest neighbor criterion,
creating graphics files for processing by gnuplot().
-
nearest_interp_1d_test
-
newton_rc,
a Fortran77 code which
demonstrates the use of Newton's method to solve a system of nonlinear
equations, using reverse communication (RC).
-
newton_rc_test
-
nintlib,
a Fortran77 code which
applies approximate integration/quadrature in M dimensions;
-
nintlib_test
-
nl2sol,
a Fortran77 code which
implements an adaptive nonlinear least squares algorithm,
by John Dennis, David Gay, Roy Welsch.
-
nl2sol_test
-
nms,
a Fortran77 code which
includes a wide variety of numerical software, including
solvers for linear systems of equations, interpolation of data,
numerical quadrature, linear least squares data fitting,
the solution of nonlinear equations,
ordinary differential equations (ODE),
optimization and nonlinear least squares,
simulation and random numbers,
trigonometric approximation and Fast Fourier Transforms (FFT).
-
nms_test
-
normal,
a Fortran77 code which
generates normally distributed pseudorandom numbers.
-
normal_test
-
nspcg,
a Fortran77 code which
carries out the iterative solution of large nonsymmetric systems of
linear equations. The package includes a
variety of matrix storage formats, preconditioners, and solvers.
-
ode,
a Fortran77 code which
handles ordinary differential equations (ODE),
by Shampine and Gordon;
-
ode_test
-
odepack,
a Fortran77 code which
contains nine ODE solvers, including LSODE, LSODES, LSODA,
LSODAR, LSODPK, LSODKR, LSODI, LSOIBT, and LSODIS,
by Alan Hindmarsh.
-
odepack_test
-
openmp_test,
a Fortran77 code which
uses the OpenMP interface
for parallel processing on shared memory systems;
-
optimize_test,
a Fortran77 code which
looks at the use of automatic optimization by the compiler
to make the executable code run faster.
-
ornstein_uhlenbeck,
a Fortran77 code 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().
-
ornstein_uhlenbeck_test
-
owen,
a Fortran77 code which
evaluates Owen's T function;
-
owen_test
-
padua,
a Fortran77 code which
returns the points and weights for Padu sets, useful for interpolation
in 2D. gnuplot() is used to make plots of the points.
-
padua_test
-
paranoia,
a Fortran77 code which
checks properties of a computer's arithmetic,
by William Kahan.
-
paranoia_test
-
partition_brute,
a Fortran77 code which
uses a brute force algorithm to seek solutions of the partition problem,
splitting a set of integers into two subsets with equal sum.
-
partition_brute_test
-
patterson_rule,
a Fortran77 code which
returns the points and weights of a 1D Gauss-Patterson quadrature rule
of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
-
patterson_rule_test
-
pbma_io,
a Fortran77 code which
reads or writes ASCII Portable Bit Map (PBM) 2D bit map graphics files;
-
pbma_io_test
-
pce_burgers,
a Fortran77 code which
defines and solves a version of the
time-dependent viscous Burgers equation, with uncertain viscosity,
using a polynomial chaos expansion (PCE) in terms of Hermite polynomials,
by Gianluca Iaccarino.
-
pce_burgers_test
-
pce_ode_hermite,
a Fortran77 code which
sets up a simple scalar ordinary differential equation (ODE) for
exponential decay with an uncertain decay rate, using a
polynomial chaos expansion (PCE) in terms of Hermite polynomials.
-
pce_ode_hermite_test
-
pchip,
a Fortran77 code which
constructs a piecewise cubic Hermite (PWH) interpolant to data, and
carry out various related operations, by Fred Fritsch.
-
pchip_test
-
pdflib,
a Fortran77 code which
evaluates Probability Density Functions (PDF)
and produces random samples from them,
including beta, binomial, chi, exponential, gamma, inverse chi,
inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
-
pdflib_test
-
pgma_io,
a Fortran77 code which
reads or writes ASCII Portable Gray Map (PGM) 2D grayscale graphics files;
-
pgma_io_test
-
pink_noise,
a Fortran77 code which
computes a pink noise signal obeying a 1/f power law.
-
pink_noise_test
-
point_merge,
a Fortran77 code which
considers N points in M dimensional space, and counts or indexes
the unique or "tolerably unique" items.
-
point_merge_test
-
poisson_1d,
a Fortran77 code which
solves a discretized version of the Poisson equation -uxx = f(x)
on the interval a ≤ x ≤ b, with Dirichlet boundary conditions
u(a) = ua, u(b) = ub.
The linear system is solved using Gauss-Seidel iteration.
-
poisson_1d_test
-
poisson_1d_multigrid,
a Fortran77 code which
applies the multigrid method to a discretized version of the
1D Poisson equation.
-
poisson_1d_multigrid_test
-
poisson_2d,
a Fortran77 code which
solves the Poisson equation in a rectangle,
using finite differences and Jacobi iteration.
-
poisson_2d_test
-
poisson_openmp,
a Fortran77 code which
computes an approximate 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_openmp_test
-
poisson_serial,
a Fortran77 code which
computes an approximate solution to the Poisson equation in a
rectangle, and is intended as the starting point for the
creation of a parallel version.
-
poisson_serial_test
-
poisson_simulation,
a Fortran77 code which
simulates a Poisson process in which events randomly occur with an
average waiting time of Lambda,
creating graphics files for processing by gnuplot().
-
poisson_simulation_test
-
polpak,
a Fortran77 code which
evaluates a variety of mathematical functions, polynomials, and
sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan,
Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci,
Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter,
Hypergeometric 2F1, Jacobi,
Krawtchouk, Laguerre, Lambert, Legendre, Lerch, Meixner, Mertens,
Moebius, Motzkin, Phi, Stirling Number, Tau, Tribonacci, Zernike.
-
polpak_test
-
polygon,
a Fortran77 code 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_test
-
polygon_grid,
a Fortran77 code which
generates a grid of points
over the interior of a polygon in 2D.
-
polygon_grid_test
-
polygon_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of a polygon in 2D.
-
polygon_integrals_test
-
polygon_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
over the interior of a polygon in 2D.
-
polygon_monte_carlo_test
-
polygon_triangulate,
a Fortran77 code which
triangulates a possibly nonconvex polygon in 2D,
and which uses gnuplot() to display the external edges and
internal diagonals of the triangulation.
-
polygon_triangulate_test
-
polynomial,
a Fortran77 code which
adds, multiplies, differentiates, evaluates and prints multivariate
polynomials in a space of M dimensions.
-
polynomial_test
-
polynomial_conversion,
a Fortran77 code which
converts representations of a polynomial between monomial, Bernstein,
Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
-
polynomial_conversion_test
-
power_method,
a Fortran77 code which
carries out the power method for finding a dominant eigenvalue
and its eigenvector.
-
power_method_test
-
power_rule,
a Fortran77 code which
constructs a power rule, that is, a product quadrature rule
from identical 1D factor rules.
-
power_rule_test
-
ppma_io,
a Fortran77 code which
reads or writes ASCII Portable Pixel Map (PPM)
2D color graphics files;
-
ppma_io_test
-
pppack,
a Fortran77 code which
computes piecewise polynomial (PWP)
interpolants and approximants, in particular, cubic splines,
by Carl DeBoor.
-
pppack_test
-
praxis,
a Fortran77 code which
minimizes a scalar function of several variables, without
requiring derivative information,
by Richard Brent.
-
praxis_test
-
prime_mpi,
a Fortran77 code which
counts the number of primes between 1 and N,
using MPI for parallel execution.
-
prime_mpi_test
-
prime_openmp,
a Fortran77 code which
counts the number of primes between 1 and N,
using OpenMP for parallel execution.
-
prime_openmp_test
-
prime_serial,
a Fortran77 code which
counts the number of primes between 1 and N,
and is intended as a starting point for a parallel version.
-
prime_serial_test
-
prob,
a Fortran77 code which
evaluates, samples, inverts, and characterizes a number of
Probability Density Functions (PDF)
and Cumulative Density Functions (CDF), including anglit, arcsin,
benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford,
burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged,
dipole, dirichlet mixture, discrete, empirical, english sentence and
word length, error, exponential, extreme values, f, fisk,
folded normal, frechet, gamma, generalized logistic, geometric,
gompertz, gumbel, half normal, hypergeometric, inverse gaussian,
laplace, levy, logistic, log normal, log series, log uniform,
lorentz, maxwell, multinomial, nakagami, negative binomial, normal,
pareto, planck, poisson, power, quasigeometric, rayleigh,
reciprocal, runs, sech, semicircular, student t, triangle, uniform,
von mises, weibull, zipf.
-
prob_test
-
product_rule,
a Fortran77 code which
creates an M-dimensional quadrature rule
from a product of distinct 1d quadrature rules;
-
product_rule_test
-
pwl_approx_1d,
a Fortran77 code which
approximates a set of data using a piecewise linear (PWL) function.
-
pwl_approx_1d_test
-
pwl_interp_1d,
a Fortran77 code which
interpolates a set of data using a piecewise linear (PWL) function.
-
pwl_interp_1d_test
-
pwl_interp_2d,
a Fortran77 code which
evaluates a piecewise linear (PWL) interpolant to data defined on
a regular 2D grid.
-
pwl_interp_2d_test
-
pwl_interp_2d_scattered,
a Fortran77 code which
evaluates a piecewise linear (PWL) interpolant to data which is available
at an irregularly arranged set of points.
-
pwl_interp_2d_scattered_test
-
pwl_product_integral,
a Fortran77 code which
calculates the exact value of the integral of the product of two
piecewise linear (PWL) functions F(X) and G(X).
-
pwl_product_integral_test
-
pyramid_exactness,
a Fortran77 code which
investigates the polynomial exactness of a quadrature rule
over the interior of the unit pyramid in 3D.
-
pyramid_exactness_test
-
pyramid_felippa_rule,
a Fortran77 code which
returns Felippa's quadratures rules for approximating integrals
over the interior of a pyramid in 3D.
-
pyramid_felippa_rule_test
-
pyramid_grid,
a Fortran77 code which
computes a grid of points
over the interior of the unit pyramid in 3D;
-
pyramid_grid_test
-
pyramid_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit pyramid in 3D.
-
pyramid_integrals_test
-
pyramid_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate integrals of a function
over the interior of the unit pyramid in 3D;
-
pyramid_monte_carlo_test
-
pyramid_rule,
a Fortran77 code which
computes a quadrature rule
over the interior of the unit pyramid in 3D.
-
pyramid_rule_test
-
qr_solve,
a Fortran77 code which
computes the least squares solution of a linear system A*x=b.
-
qr_solve_test
-
quad_mpi,
a Fortran77 code which
applies a quadrature rule to estimate an integral, using MPI;
-
quad_mpi_test
-
quad_openmp,
a Fortran77 code which
applies a quadrature rule to estimate an integral
over a 1D interval, using OpenMP for parallel execution;
-
quad_openmp_test
-
quad_rule,
a Fortran77 code which
implements rules for approximate integration/quadrature
in one dimension;
-
quad_rule_test
-
quad_serial,
a Fortran77 code which
applies a quadrature rule to estimate an integral,
intended as a starting point for parallelization exercises.
-
quad_serial_test
-
quad2d,
a Fortran77 code which
applies a product quadrature rule to estimate an integral
over a 2D rectangle,
intended as a starting point for parallelization exercises.
-
quad2d_test
-
quad2d_openmp,
a Fortran77 code which
applies a product quadrature rule to estimate an integral
over a 2D rectangle, using OpenMP for parallel execution;
-
quad2d_openmp_test
-
quadmom,
a Fortran77 code which
computes a Gaussian quadrature rule for a weight function rho(x)
based on the Golub-Welsch procedure that only requires knowledge
of the moments of rho(x).
-
quadmom_test
-
quadpack,
a Fortran77 code which
estimates integrals using numerical quadrature,
by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.
-
quadpack_test
-
quadrature_golub_welsch,
a Fortran77 code which
computes the points and weights of a Gaussian quadrature rule using
the Golub-Welsch procedure.
-
quadrature_golub_welsch_test
-
quadrature_least_squares,
a Fortran77 code which
computes weights for sub-interpolatory quadrature rules,
that is, it estimates integrals by integrating a polynomial that
approximates the function data in a least squares sense.
-
quadrature_least_squares_test
-
quadrature_weights_vandermonde,
a Fortran77 code which
computes the weights of a quadrature rule using the Vandermonde
matrix, assuming that the points have been specified.
-
quadrature_weights_vandermonde_test
-
quadrature_weights_vandermonde_2d,
a Fortran77 code which
computes the weights of a 2D quadrature rule using the Vandermonde
matrix, assuming that the points have been specified.
-
quadrature_weights_vandermonde_2d_test
-
r4lib,
a Fortran77 code which
contains many utility routines, using "R4" or
"single precision real" arithmetic.
-
r4lib_test
-
r8lib,
a Fortran77 code which
contains many utility routines, using "R8" or
"double precision real" arithmetic.
-
r8lib_test
-
randlc,
a Fortran77 code which
is a random number generator (RNG) used by the NAS Benchmark programs.
-
randlc_test
-
random_data,
a Fortran77 code 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_data_test
-
random_mpi,
a Fortran77 code which
demonstrates one way to use a random number generator (RNG)
to generate the same sequence of values for both sequential execution
and parallel execution under MPI.
-
random_mpi_test
-
random_openmp,
a Fortran77 code which
is a parallel program using OpenMP to generate multiple
distinct streams of random numbers.
-
random_openmp_test
-
ranlib,
a Fortran77 code which
is a library of random number generators which
produces random samples from Probability Density Functions (PDF),
including Beta, Chi-square Exponential, F, Gamma, Multivariate normal,
Noncentral chi-square, Noncentral F, Univariate normal,
random permutations, Real uniform, Binomial, Negative Binomial,
Multinomial, Poisson and Integer uniform,
by Barry Brown and James Lovato.
-
ranlib_test
-
rbf_interp_1d,
a Fortran77 code which
defines and evaluates radial basis function (RBF)
interpolants to 1D data.
-
rbf_interp_1d_test
-
rbf_interp_2d,
a Fortran77 code which
defines and evaluates radial basis function (RBF)
interpolants to 2D data.
-
rbf_interp_2d_test
-
rbf_interp_nd,
a Fortran77 code which
defines and evaluates radial basis function (RBF) interpolants
to multidimensional data.
-
rbf_interp_nd_test
-
reactor simulation,
a Fortran77 code 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."
-
reactor simulation_test
-
ring_mpi,
a Fortran77 code which
uses the MPI parallel programming environment, and measures the time
necessary to copy a set of data around a ring of processes.
-
ring_mpi_test
-
rk4,
a Fortran77 code which
applies the fourth order Runge-Kutta (RK) algorithm to estimate the
solution of an ordinary differential equation (ODE)
at the next time step.
-
rk4_test
-
rkf45,
a Fortran77 code which
solves a system of ordinary differential equations (ODE)
by the Runge-Kutta-Fehlberg method.
-
rkf45_test
-
rnglib,
a Fortran77 code which
implements a random number generator (RNG) with splitting facilities,
allowing multiple independent streams to be computed,
by L'Ecuyer and Cote.
-
rnglib_test
-
satisfy_brute,
a Fortran77 code which
uses brute force to find all assignments of values to a set of
logical variables which make a complicated logical statement true.
-
satisfy_brute_test
-
satisfy_mpi,
a Fortran77 code which
demonstrates, for a particular circuit, an exhaustive search
for solutions of the circuit satisfiability problem,
using MPI to perform the calculation in parallel.
-
satisfy_mpi_test
-
satisfy_openmp,
a Fortran77 code which
demonstrates, for a particular circuit, an exhaustive search
for solutions of the circuit satisfiability problem,
using OpenMP for parallel execution.
-
satisfy_openmp_test
-
schedule_openmp,
a Fortran77 code which
demonstrates the default, static, and dynamic methods of "scheduling"
loop iterations in OpenMP to avoid work imbalance.
-
schedule_openmp_test
-
scotch_test,
a Fortran77 program which
tests the scotch sparse matrix package.
-
sde,
a Fortran77 code which
illustrates properties of
stochastic ordinary differential equations (SODE), 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;
-
sde_test
-
search_mpi,
a Fortran77 code which
searches integers between A and B for a solution J such that F(J)=C,
carried out in parallel using MPI.
-
search_mpi_test
-
search_serial,
a Fortran77 code 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.
-
search_serial_test
-
select,
a Fortran77 code which
carries out Nijenhuis and Wilf's generalized
combinatorial selection algorithm;
-
select_test
-
serba,
a Fortran77 code which
applies the boundary element
method to solve the elasticify equation in a 2D region,
by Federico Paris and Jose Canas.
-
serba_test
-
set_theory,
a Fortran77 code which
demonstrates various set theoretic operations
using several models of a set.
-
set_theory_test
-
setmat,
a Fortran77 code which
sets and gets matrix entries
using a variety of matrix storage formats.
-
setmat_test
-
sftpack,
a Fortran77 code which
implements the "slow" Fourier transform, intended as a teaching
tool and comparison with the fast Fourier transform (FFT).
-
sftpack_test
-
sgefa_openmp,
a Fortran77 code which
compares a standard linear algebra solver against a revised version
which runs in parallel with OpenMP.
-
sgefa_openmp_test
-
shepard_interp_1d,
a Fortran77 code which
defines and evaluates Shepard interpolants to 1D data,
based on inverse distance weighting.
-
shepard_interp_1d_test
-
shepard_interp_2d,
a Fortran77 code which
defines and evaluates Shepard interpolants to 2D data,
based on inverse distance weighting.
-
shepard_interp_2d_test
-
shepard_interp_nd,
a Fortran77 code which
defines and evaluates Shepard interpolants to multidimensional data,
based on inverse distance weighting.
-
shepard_interp_nd_test
-
simpack,
a Fortran77 code which
estimates an integral over a
region that is the union of multidimensional simplexes,
by Alan Genz.
-
simpack_test
-
simplex_coordinates,
a Fortran77 code which
computes the Cartesian coordinates of the vertices of
a regular simplex in M dimensions.
-
simplex_coordinates_test
-
simplex_gm_rule,
a Fortran77 code which
defines Grundmann-Moeller quadrature rules
over the interior of a triangle in 2D, a tetrahedron in 3D, or
over the interior of the simplex in M dimensions.
-
simplex_gm_rule_test
-
simplex_grid,
a Fortran77 code which
generates a regular grid of points
over the interior of an arbitrary simplex in M dimensions.
-
simplex_grid_test
-
simplex_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit simplex in M dimensions.
-
simplex_integrals_test
-
simplex_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate an integral
over the interior of the unit simplex in M dimensions.
-
simplex_monte_carlo_test
-
sine_transform,
a Fortran77 code which
demonstrates some simple properties of the discrete sine transform.
-
sine_transform_test
-
slap_io,
a Fortran77 code which
reads and writes SLAP sparse matrix files;
-
slap_io_test
-
snakes_and_ladders,
a Fortran77 code which
provides tools for the study of the game of Snakes and Ladders.
-
snakes_and_ladders_test
-
solve,
a Fortran77 code which
demonstrates how Gauss elimination solves a
linear system A*x=b.
-
solve_test
-
sort_rc,
a Fortran77 code which
sorts a list of any kind of objects,
using reverse communication (RC).
-
sort_rc_test
-
spaeth2,
a Fortran77 code which
performs the cluster analysis of data,
by Helmut Spaeth;
-
spaeth2_test
-
sparse_display,
a Fortran77 code which
reads 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() function.
-
sparse_display_test
-
sparse_grid_cc,
a Fortran77 code which
creates sparse grids based on Clenshaw-Curtis rules.
-
sparse_grid_cc_test
-
sparse_grid_hw,
a Fortran77 code which
creates sparse grids based on Gauss-Legendre, Gauss-Hermite,
Gauss-Patterson, or a nested variation of Gauss-Hermite rules,
by Florian Heiss and Viktor Winschel.
-
sparse_grid_hw_test
-
sparse_interp_nd,
a Fortran77 code which
defines a sparse interpolant to a function f(x) of a
M-dimensional argument.
-
sparse_interp_nd_test
-
sparsekit,
a Fortran77 code which
performs sparse matrix operations,
by Yousef Saad;
-
sparsekit_test
-
sparsepak,
a Fortran77 code which
is a version of the Waterloo Sparse Matrix Package;
-
sparsepak_test
-
specfun,
a Fortran77 code which
computes special functions, including Bessel I, J, K and Y functions,
Dawson Integral, Error (Erf), Exponential Integral (E1 and EI), Gamma,
log Gamma, and Psi/Digamma,
by William Cody and Laura Stoltz;
-
specfun_test
-
special_functions,
a Fortran77 code which
evaluates special functions, including
Airy, Associated Legendre,
Bernoulli Numbers, Bessel, Beta, Complete Elliptic Integral,
Cosine Integral, Elliptic Integral, Error,
Euler Numbers, Exponential Integral, Fresnel Integral, Gamma, Hankel,
Hermite polynomials, Hypergeometric 2F1, Incomplete Beta,
Incomplete Gamma, Jacobian Elliptic, Kelvin,
Kummer Confluent Hypergeometric, Laguerre polynomials, Lambda,
Legendre functions, Legendre polynomials, Mathieu,
Modified Spherical Bessel, Parabolic Cylinder, Psi,
Riccati-Bessel, Sine Integral, Spheroidal Angular, Spheroidal Wave,
Struve, Tricomi Confluent Hypergeometric, Whittaker,
by Shanjie Zhang, Jianming Jin;
-
special_functions_test
-
sphere_exactness,
a Fortran77 code which
tests the polynomial exactness of a quadrature rule
on the surface of the unit sphere in 3D.
-
sphere_exactness_test
-
sphere_fibonacci_grid,
a Fortran77 code which
uses a Fibonacci spiral to create a grid of points
on the surface of the unit sphere in 3D.
-
sphere_fibonacci_grid_test
-
sphere_grid,
a Fortran77 code which
provides a number of ways of generating grids of points, or of
points and lines, or of points and lines and faces,
on the surface of the unit sphere in 3D.
-
sphere_grid_test
-
sphere_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the surface of the unit sphere in 3D.
-
sphere_integrals_test
-
sphere_lebedev_rule,
a Fortran77 code which
computes Lebedev quadrature rules
on the surface of the unit sphere in 3D.
-
sphere_lebedev_rule_test
-
sphere_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
on the surface of the unit sphere in 3D.
-
sphere_monte_carlo_test
-
sphere_quad,
a Fortran77 code which
uses triangulation to approximate an integral
on the surface of the unit sphere in 3D;
-
sphere_quad_test
-
sphere_stereograph,
a Fortran77 code which
computes the stereographic mapping between points
on the surface of the unit sphere in 3D
and points on the plane Z = 1; a generalized mapping is
also available.
-
sphere_stereograph_test
-
sphere_triangle_monte_carlo,
a Fortran77 code which
used the Monte Carlo method to estimate the integral of a function
defined in a triangle
on the surface of the unit sphere in 3D.
-
sphere_triangle_monte_carlo_test
-
sphere_triangle_quad,
a Fortran77 code which
uses quadrature to estimate the integral of a function
in a spherical triangle on the surface of the unit sphere in 3D.
-
sphere_triangle_quad_test
-
spiral_exact,
a Fortran77 code which
computes a 2D velocity vector field that is an exact solution
of the continuity equation.
-
spiral_exact_test
-
spline,
a Fortran77 code which
interpolates and approximates via splines;
-
spline_test
-
square_arbq_rule,
a Fortran77 code which
returns quadrature rules,
with exactness up to total degree 20,
over the interior of the symmetric square in 2D,
by Hong Xiao and Zydrunas Gimbutas.
-
square_arbq_rule_test
-
square_exactness,
a Fortran77 code which
investigates the polynomial exactness of quadrature rules for f(x,y)
over the interior of a rectangle in 2D.
-
square_exactness_test
-
square_felippa_rule,
a Fortran77 code which
returns Felippa's quadratures rules for approximating integrals
over the interior of a square in 2D.
-
square_felippa_rule_test
-
square_grid,
a Fortran77 code which
computes a grid of points
over the interior of a square in 2D.
-
square_grid_test
-
square_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit square in 2D.
-
square_integrals_test
-
square_monte_carlo,
a Fortran77 code which
applies a Monte Carlo method to estimate the integral of a function
over the interior of the unit square in 2D.
-
square_monte_carlo_test
-
square_symq_rule,
a Fortran77 code which
returns symmetric quadrature rules,
with exactness up to total degree 20,
over the interior of the symmetric square in 2D,
by Hong Xiao and Zydrunas Gimbutas.
-
square_symq_rule_test
-
st_io,
a Fortran77 code which
reads and writes sparse linear systems stored in the
Sparse Triplet (ST) format.
-
st_io_test
-
st_to_ccs,
a Fortran77 code which
converts sparse matrix data from Sparse Triplet (ST) format
to Compressed Column Storage (CCS) format;
-
st_to_ccs_test
-
starpac,
a Fortran77 code which
carries out statistical data analysis,
by Janet Donaldson.
-
starpac_test
-
steam_nbs,
a Fortran77 code which
contains steam table functions devised by the Nation Bureau of
Standards (NBS). This version of the code is (almost) unchanged from the
original release. It can be useful when checking the revised
Fortran90 version.
-
steam_nbs_interact,
a Fortran77 code which
allows the user to interactively query the steam table functions
from the National Bureau of Standards (NBS).
-
steam_nbs_interact_test
-
stochastic_diffusion,
functions which
implement several versions of a stochastic diffusivity coefficient.
-
stochastic_diffusion_test
-
stochastic_heat2d,
a Fortran77 code 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_heat2d_test
-
stochastic_rk,
a Fortran77 code which
applies a Runge-Kutta scheme to a stochastic
ordinary differential equation (SODE).
-
stochastic_rk_test
-
stokes_2d_exact,
a Fortran77 code which
evaluates exact solutions to the incompressible steady
Stokes equations over the unit square in 2D.
-
stokes_2d_exact_test
-
string_pde,
a Fortran77 code which
simulates the behavior of a vibrating string
by solving the corresponding initial boundary value problem (IBVP),
creating files to be displayed by gnuplot().
-
string_pde_test
-
stroud_rule,
a Fortran77 code which
defines quadrature rules for a variety of M-dimensional regions,
including the interior of the square, cube and hypercube, the pyramid,
cone and ellipse, the hexagon, the M-dimensional octahedron,
the circle, sphere and hypersphere, the triangle,
tetrahedron and simplex, and the surface of the circle, sphere
and hypersphere.
-
stroud_rule_test
-
subpak,
a Fortran77 code which
implements a wide variety of operations
on real and integer vectors and matrices;
-
subpak_test
-
subset,
a Fortran77 code which
enumerates, generates, randomizes, ranks and unranks combinatorial
objects including combinations, compositions, Gray codes, index sets,
partitions, permutations, polynomials, subsets, and Young tables.
Backtracking routines are included to solve some combinatorial
problems.
-
subset_test
-
subset_sum,
a Fortran77 code which
seeks solutions of the subset sum problem, in which it is desired
to find a subset of integers which has a given sum.
-
subset_sum_test
-
subset_sum_brute,
a Fortran77 code which
uses brute force to find solutions of the subset sum problem,
in which it is desired to find a subset of integers which has a given sum.
-
subset_sum_brute_test
-
subset_sum_swap,
a Fortran77 code which
uses swapping to try to improve an initial estimated solution
of the subset sum problem, which seeks a subset of a set of integers
which has a given sum. Even when an exact solution exists, this
approach often only finds an approximate solution.
-
subset_sum_swap_test
-
svd_snowfall,
a Fortran77 code which
reads a file containing historical snowfall data and
analyzes the data with the Singular Value Decomposition (SVD),
displaying the results using gnuplot().
-
svd_snowfall_test
-
svd_test,
a Fortran77 code which
demonstrates the calculation
of the singular value decomposition (SVD) and some of its properties;
-
svd_truncated,
a Fortran77 code 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.
-
svd_truncated_test
-
table_io,
a Fortran77 code which
reads and writes a set of data as a table file.
-
table_io_test
-
task_division,
a Fortran77 code which
implements a simple procedure for smoothly dividing T tasks among
P processors; such a method is suitable for MPI and other parallel
environments, particularly when T is not an exact multiple of P,
and when the processors are indexed starting from 0 or from 1.
-
task_division_test
-
tcell,
a Fortran77 code which
solves the time-dependent 2D
incompressible Navier Stokes equations in a T-shaped region,
by Hyung-Chun Lee.
-
tcell_test
-
tcell_mass,
a Fortran77 code which
creates and saves the mass matrix associated with a
finite element method (FEM) solution of
the time dependent 2D incompressible
Navier Stokes equations in the TCELL region,
by Hyung-Chun Lee.
-
tcell_mass_test
-
templated,
a Fortran77 code which
forms basic implementations of
iterative methods for solving large sparse linear systems,
using double precision arithmetic.
-
templated_test
-
templates,
a Fortran77 code which
forms basic implementations of
iterative methods for solving large sparse linear systems;
-
templates_test
-
test_approx,
a Fortran77 code which
implements test problems for approximation,
provided as a set of (x,y) data.
-
test_approx_test
-
test_con,
a Fortran77 code which
implements test problems for numerical continuation.
-
test_con_test
-
test_eigen,
a Fortran77 code which
implements test matrices for eigenvalue analysis.
-
test_eigen_test
-
test_int,
a Fortran77 code which
implements test problems for
approximate integration/quadrature in one dimension.
-
test_int_test
-
test_int_circle,
a Fortran77 code which
defines several test integrals over the unit circle, making it possible
to check the accuracy of quadrature rules.
-
test_int_circle_test
-
test_int_2d,
a Fortran77 code which
implements test problems for
approximate integration/quadrature in two dimensions.
-
test_int_2d_test
-
test_interp,
a Fortran77 code which
defines test problems for interpolation,
provided as a set of (x,y(x)) data.
-
test_interp_test
-
test_interp_1d,
a Fortran77 code which
defines test problems for interpolation of data y(x),
which depends on a 1D argument.
-
test_interp_1d_test
-
test_interp_2d,
a Fortran77 code which
defines test problems for interpolation of data z(x,y),
depending on a 2D argument.
-
test_interp_2d_test
-
test_interp_fun,
a Fortran77 code which
defines functions whose sampled data can be used
in testing interpolation algorithms.
-
test_interp_fun_test
-
test_interp_nd,
a Fortran77 code which
defines test problems for interpolation of data z(x),
depending on an M-dimensional argument.
-
test_interp_nd_test
-
test_laplace,
a Fortran77 code which
returns examples of a forward function f(t)
and its corresponding Laplace transform L(f,z).
-
test_laplace_test
-
test_lls,
a Fortran77 code which
implements linear least squares test problems of the form A*x=b.
-
test_lls_test
-
test_matrix,
a Fortran77 code 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 matrix.
-
test_matrix_test
-
test_matrix_exponential,
a Fortran77 code which
defines tests for computing the matrix exponential function.
-
test_matrix_exponential_test
-
test_min,
a Fortran77 code which
implements test problems for
minimization of a scalar function of a scalar variable.
-
test_min_test
-
test_nearest,
a Fortran77 code which
tests the time complexity of various procedures for solving the
nearest neighbor problem.
-
test_nearest_test
-
test_nonlin,
a Fortran77 code which
implements test problems for the solution
of systems of nonlinear equations.
-
test_nonlin_test
-
test_opt_con,
a Fortran77 code which
defines test problems for the
minimization of a scalar function of several variables,
with the search constrained to lie within a specified hyper-rectangle.
-
test_opt_con_test
-
test_optimization,
a Fortran77 code which
implements test problems for optimization
of a scalar function of several variables,
as described by Molga and Smutnicki.
-
test_optimization_test
-
test_values,
a Fortran77 code which
supplies test values of various mathematical functions, including
Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial,
Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen,
Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind,
dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic,
Error, Euler, Exponential integral, F probability, Fresnel, Frobenius,
Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite,
Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic,
Jacobi Elliptic functions sn(), cn(), dn(), the Julian Ephemeris Date,
Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky,
Lobatto, Logarithmic integral, Log normal, McNugget numbers,
Mersenne primes, Mertens, Mittag-Leffler, Moebius,
Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition,
Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime,
Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral,
Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic,
Stirling, Stromgen, Struve, Student, Subfactorial, Student probability,
Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises,
Weibull, Wright Omega, Zeta.
-
test_values_test
-
test_zero,
a Fortran77 code which
implements test problems for the solution
of a single nonlinear equation in one variable.
-
test_zero_test
-
tester,
a BASH script which runs the test programs.
-
testpack,
a Fortran77 code which
contains a set of test integrand functions,
by Alan Genz.
-
testpack_test
-
tet_mesh,
a Fortran77 code which
carries out various tasks associated with tetrahedral meshes in 3D;
-
tet_mesh_test
-
tet_mesh_to_gmsh,
a Fortran77 code which
writes a tetrahedral mesh to a gmsh() file.
-
tet_mesh_to_gmsh_test
-
tet_mesh_to_xml,
a Fortran77 code which
writes a tetrahedral mesh to an XML file.
-
tet_mesh_to_xml_test
-
tetrahedron,
a Fortran77 code 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.
-
tetrahedron_test
-
tetrahedron_analyze,
a Fortran77 code 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,
-
tetrahedron_analyze_test
-
tetrahedron_arbq_rule,
a Fortran77 code which
returns quadrature rules,
with exactness up to total degree 15,
over the interior of a tetrahedron in 3D,
by Hong Xiao and Zydrunas Gimbutas.
-
tetrahedron_arbq_rule_test
-
tetrahedron_exactness,
a Fortran77 code which
tests the polynomial exactness of a quadrature rule
over the interior of a tetrahedron in 3D.
-
tetrahedron_exactness_test
-
tetrahedron_felippa_rule,
a Fortran77 code which
returns Felippa's quadratures rules for approximating integrals
over the interior of a tetrahedron in 3D.
-
tetrahedron_felippa_rule_test
-
tetrahedron_grid,
a Fortran77 code which
computes a grid of points
over the interior of a tetrahedron in 3D.
-
tetrahedron_grid_test
-
tetrahedron_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit tetrahedron in 3D.
-
tetrahedron_integrals_test
-
tetrahedron_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate an integral
over the interior of a general tetrahedron in 3D.
-
tetrahedron_monte_carlo_test
-
tetrahedron01_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate an integral
over the interior of the unit tetrahedron in 3D.
-
tetrahedron01_monte_carlo_test
-
timer_test,
a Fortran77 code which
illustrates how executing code may be timed.
-
timestamp,
a Fortran77 code which
prints out the YMDHMS date as a timestamp.
-
timestamp_test
-
toeplitz,
a Fortran77 code which
implements Toeplitz matrix system solvers.
-
toeplitz_test
-
toeplitz_cholesky,
a Fortran77 code which
computes the Cholesky factorization of
a nonnegative definite symmetric Toeplitz matrix.
-
toeplitz_cholesky_test
-
toms097,
a Fortran77 code 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 097.
-
toms097_test
-
toms178,
a Fortran77 code which
seeks the minimizer of a scalar function of several variables
using the Hooke-Jeeves method;
this is a version of ACM TOMS algorithm 178.
-
toms178_test
-
toms179,
a Fortran77 code which
calculates the incomplete Beta ratio;
this is a version of ACM TOMS algorithm 179.
-
toms179_test
-
toms291,
a Fortran77 code which
approximates the logarithm of the Gamma function;
this is a version of ACM TOMS algorithm 291.
-
toms291_test
-
toms322,
a Fortran77 code which
evaluates the normal, Student's T, F and chi-square
cumulative density functions (CDF);
this is a version of ACM TOMS algorithm 322.
-
toms322_test
-
toms332,
a Fortran77 code which
evaluates Jacobi polynomials;
this is a version of ACM TOMS algorithm 332.
-
toms332_test
-
toms343,
a Fortran77 code which
computes the eigenvalues and
eigenvectors of a general real matrix;
this is a version of ACM TOMS algorithm 343.
-
toms343_test
-
toms344,
a Fortran77 code which
calculates the Student T distribution;
this is a version of ACM TOMS algorithm 344.
-
toms344_test
-
toms347,
a Fortran77 code which
sorts an integer vector;
this is a version of ACM TOMS algorithm 347.
-
toms347_test
-
toms351,
a Fortran77 code which
estimates an integral using Romberg integration;
this is a version of ACM TOMS algorithm 351.
-
toms351_test
-
toms352,
a Fortran77 code which
computes the characteristic values
and associated solutions of Mattieu's differential equation;
this is a version of ACM TOMS algorithm 352.
-
toms352_test
-
toms353,
a Fortran77 code which
estimates an integral involving a cosine
or sine factor using Filon quadrature;
this is a version of ACM TOMS algorithm 353.
-
toms353_test
-
toms358,
a Fortran77 code which
computes the singular value decomposition (SVD)
of a complex matrix;
this is a version of ACM TOMS algorithm 358.
-
toms358_test
-
toms359,
a Fortran77 code which
computes the factorial analysis of variance;
this is a version of ACM TOMS algorithm 359.
-
toms359_test
-
toms365,
a Fortran77 code which
finds a root of an analytic complex function
by the downhill method;
this is a version of ACM TOMS algorithm 365.
-
toms365_test
-
toms370,
a Fortran77 code which
produces random numbers sampled
from an arbitrary probability density function (PDF);
this is a version of ACM TOMS algorithm 370.
-
toms370_test
-
toms379,
a Fortran77 code which
approximates the integral of a function,
by James Lyness.
this is a version of ACM TOMS algorithm 379.
-
toms379_test
-
toms384,
a Fortran77 code which
computes the eigenvalues and eigenvectors
of a symmetric matrix;
this is a version of ACM TOMS algorithm 384.
-
toms384_test
-
toms385,
a Fortran77 code which
evaluates the exponential integral function;
this is a version of ACM TOMS algorithm 385.
-
toms385_test
-
toms392,
a Fortran77 code which
approximates the time evolution of a
hyperbolic partial differential equation (PDE);
this is a version of ACM TOMS algorithm 392.
-
toms392_test
-
toms418,
a Fortran77 code which
estimates Fourier integrals of the form
integral ( a<=x<=b ) f(x) * cos(wx) dx, or
integral ( a<=x<=b ) f(x) * sin(wx) dx, by Bo Einarsson.
This is a version of ACM TOMS algorithm 418.
-
toms418_test
-
toms419,
a Fortran77 code which
seeks the zeroes of a polynomial with complex coefficients;
this code is commonly called cpoly();
this is a version of ACM TOMS algorithm 419.
-
toms419_test
-
toms423,
a Fortran77 code which
implements Gaussian elimination,
revised versions of decomp() and solve();
this is a version of ACM TOMS algorithm 423.
-
toms423_test
-
toms424,
a Fortran77 code which
implements Clenshaw-Curtis integration;
this is a version of ACM TOMS algorithm 424.
-
toms424_test
-
toms425,
a Fortran77 code which
generates a sequence of vectors
from a multivariate normal distribution with given covariance;
this is a version of ACM TOMS algorithm 425.
-
toms425_test
-
toms427,
a Fortran77 code which
estimates the value of a Fourier cosine integral of the form
integral ( 0 <= x < +oo ) f(t) cos ( w * t ) dt,
by Peter Linz.
This is a version of ACM TOMS algorithm 427.
-
toms427_test
-
toms429,
a Fortran77 code which
reports information about the estimated location
of roots of a polynomial;
this is a version of ACM TOMS algorithm 429.
-
toms429_test
-
toms431,
a Fortran77 code which
solves quadratic and linear programming problems;
this is a version of ACM TOMS algorithm 431.
-
toms431_test
-
toms434,
a Fortran77 code which
computes the probability of a given
RxC contingency table;
this is a version of ACM TOMS algorithm 434.
-
toms434_test
-
toms435,
a Fortran77 code which
computes the modified incomplete gamma function;
this is a version of ACM TOMS algorithm 435.
-
toms435_test
-
toms436,
a Fortran77 code which
carries out product-type trapezoidal integration;
this is a version of ACM TOMS algorithm 436.
-
toms436_test
-
toms437,
a Fortran77 code which
carries out product-type Simpson's integration;
this is a version of ACM TOMS algorithm 437.
-
toms437_test
-
toms438,
a Fortran77 code which
carries out product-type two point Gauss-Legendre-Simpson
integration;
this is a version of ACM TOMS algorithm 438.
-
toms438_test
-
toms439,
a Fortran77 code which
carries out product-type three point Gauss-Legendre-Simpson
integration;
this is a version of ACM TOMS algorithm 439.
-
toms439_test
-
toms441,
a Fortran77 code which
samples the dipole distribution;
this is a version of ACM TOMS algorithm 441.
-
toms441_test
-
toms443,
a Fortran77 code which
evaluates Lambert's W function;
this is a version of ACM TOMS algorithm 443.
-
toms443_test
-
toms446,
a Fortran77 code which
manipulates Chebyshev series for interpolation and approximation;
this is a version of ACM TOMS algorithm 446,
by Roger Broucke.
-
toms446_test
-
toms448,
a Fortran77 code which
counts the number of partitions of an integer into a given set
of integers;
this is a version of ACM TOMS algorithm 448.
-
toms448_test
-
toms449,
a Fortran77 code which
solves linear programming problems with variables restricted to
0 and 1 values;
this is a version of ACM TOMS algorithm 449.
-
toms449_test
-
toms450,
a Fortran77 code which
minimizes a scalar function of N variables using the method
of Rosenbrock;
this is a version of ACM TOMS algorithm 450.
-
toms450_test
-
toms451,
a Fortran77 code which
determines quantiles of the Chi-Square distribution;
this is a version of ACM TOMS algorithm 451.
-
toms451_test
-
toms452,
a Fortran77 code which
generates a sequence of combinations of M
things out of N;
this is a version of ACM TOMS algorithm 452.
-
toms452_test
-
toms453,
a Fortran77 code which
determines the abscissas and weights for a
Gaussian quadrature formula for Bromwich's integral;
this is a version of ACM TOMS algorithm 453.
-
toms453_test
-
toms454,
a Fortran77 code which
implements the complex method of constrained optimization;
this is a version of ACM TOMS algorithm 454.
-
toms454_test
-
toms456,
a Fortran77 code which
implements the routing algorithm;
this is a version of ACM TOMS algorithm 456.
-
toms456_test
-
toms460,
a Fortran77 code which
determines the optimal parameters for
an alternating direction implicit (ADI) iteration;
this is a version of ACM TOMS algorithm 460.
-
toms460_test
-
toms461,
a Fortran77 code which
applies cubic spline solutions to a class of
functional differential equations;
this is a version of ACM TOMS algorithm 461.
-
toms461_test
-
toms462,
a Fortran77 code which
evaluates the bivariate normal distribution;
this is a version of ACM TOMS algorithm 462.
-
toms462_test
-
toms463,
a Fortran77 code which
chooses "nice" ranges for a graph
of computer-generated data;
this is a version of ACM TOMS algorithm 463.
-
toms463_test
-
toms467,
a Fortran77 code which
transposes a matrix in place;
this is a version of ACM TOMS algorithm 467.
-
toms467_test
-
toms468,
a Fortran77 code which
carries out automatic numerical integration;
this is a version of ACM TOMS algorithm 468.
-
toms468_test
-
toms470,
a Fortran77 code which
solves an almost tridiagonal system of linear equations;
this is a version of ACM TOMS algorithm 470.
-
toms470_test
-
toms493,
a Fortran77 code which
seeks the roots of a real polynomial, commonly called rpoly();
this is a version of ACM TOMS algorithm 493,
by Michael Jenkins.
-
toms493_test
-
toms494,
a Fortran77 code which
approximates a 1D partial differential equation (PDE) as a system of
ordinary differential equation (ODE);
this library is commonly called pdeone();
this is a version of ACM TOMS algorithm 494.
-
toms494_test
-
toms502,
a Fortran77 code which
computes a sequence of solutions of a parameterized
system of equations;
this is a version of ACM TOMS algorithm 502.
-
toms502_test
-
toms511,
a Fortran77 code which
evaluates Bessel I or J functions of real, non integer, order,
This is a version of ACM TOMS Algorithm 511;
-
toms511_test
-
toms515,
a Fortran77 code which
selects random subsets of size K from a set of size N,
This is a version of ACM TOMS Algorithm 515,
by Bill Buckles, Matthew Lybanon.
-
toms515_test
-
toms526,
a Fortran77 code which
interpolates scattered bivariate data, by Hiroshi Akima;
this is a version of ACM TOMS algorithm 526.
-
toms526_test
-
toms550,
a Fortran77 code which
evaluates certain measures of a solid
polyhedron, including surface area, centroid, volume, weight,
moments and products of inertia;
this is a version of ACM TOMS algorithm 550.
-
toms550_test
-
toms552,
a Fortran77 code which
solves an overdetermined constrained linear system;
this is a version of ACM TOMS algorithm 552.
-
toms552_test
-
toms563,
a Fortran77 code which
solves a linearly constrained L1 minimization problem,
by Richard Bartels, Andrew Conn.
This is a version of ACM TOMS algorithm 563.
-
toms563_test
-
toms565,
a Fortran77 code which
approximates the solution of a system of time-dependent
partial differential equations (PDE) over a 2D domain;
this library is commonly called pdetwo();
this is a version of ACM TOMS algorithm 565;
-
toms565_test
-
toms571,
a Fortran77 code which
evaluates or inverts the von Mises
and Fisher distributions of directions on a circle or sphere;
this is a version of ACM TOMS algorithm 571.
-
toms571_test
-
toms577,
a Fortran77 code which
evaluates Carlson's elliptic integral functions rc(), rd(), rf()
and rj(). This is a version of ACM TOMS algorithm 577.
-
toms577_test
-
toms581,
a Fortran77 code which
implements an improved algorithm for the singular value decomposition
(SVD) of a rectangular matrix, by Tony Chan.
this is a version of ACM TOMS algorithm 581.
-
toms581_test
-
toms596,
a Fortran77 code which
seeks to produce a sequence of points that satisfy a set of nonlinear
equations with one degree of freedom;
this library is commonly called pitcon();
this is a version of ACM TOMS algorithm 596.
-
toms596_test
-
toms597,
a Fortran77 code which
evaluates Bessel functions I of real, non-integer order,
by William Cody.
This is a version of ACM TOMS Algorithm 597;
-
toms597_test
-
toms599,
a Fortran77 code which
produces samples from the exponential, gamma, normal, Poisson,
and uniform distributions,
by Ahrens, Dieter, and Kohrt.
This is a version of ACM TOMS algorithm 599.
-
toms599_test
-
toms611,
a Fortran77 code which
performs unconstrained optimization of a scalar function;
this library is commonly called uncmin();
this is a version of ACM TOMS algorithm 611.
-
toms611_test
-
toms612,
a Fortran77 code which
approximates the integral of a function over a triangle;
the code is commonly known as triex();
this is a version of ACM TOMS algorithm 612.
-
toms612_test
-
toms614,
a Fortran77 code which
computes the integral of functions which may have singularities at
one or both ends of a interval, which may be finite, semi-infinite,
or infinite, by Sikorski, Sprenger, Schwing.
This is a version of ACM TOMS algorithm 614.
-
toms614_test
-
toms626,
a Fortran77 code which
creates a contour plot of data
associated with a triangulated set of points.
This is a version of ACM TOMS algorithm 626.
-
toms626_test
-
toms632,
a Fortran77 code which
solves the multiple knapsack problem,
by Silvano Martello and Paolo Toth.
This is a version of ACM TOMS algorithm 632.
-
toms632_test
-
toms641,
a Fortran77 code which
computes the exact solution of a system of linear equations,
by John Springer.
This is a version of ACM TOMS algorithm 641.
-
toms641_test
-
toms644,
a Fortran77 code which
evaluates the Bessel I, J, K, Y functions,
the Airy functions Ai and Bi,
and the Hankel function, for complex argument and real order.
This is a version of ACM TOMS algorithm 644.
-
toms644_test
-
toms647,
a Fortran77 code which
evaluates the Faure, Halton, and Sobol quasirandom sequences,
this is a version of ACM TOMS algorithm 647;
-
toms647_test
-
toms648,
a Fortran77 code which
defines non-stiff test problems for solvers of
ordinary differential equations (ODE);
this is a version of one part of ACM TOMS algorithm 648.
-
toms648_test
-
toms655,
a Fortran77 code which
computes the weights for interpolatory quadrature rule;
this library is commonly called iqpack(),
and is by Sylvan Elhay and Jaroslav Kautsky.
this version of ACM TOMS algorithm 655 has been extensively modified.
-
toms655_test
-
toms659,
a Fortran77 code which
computes elements of the Sobol quasirandom sequence;
this is a version of ACM TOMS algorithm 659.
-
toms659_test
-
toms660,
a Fortran77 code which
takes scattered data in 2D and
creates an interpolating function F(X,Y);
this program is often called qshep2d();
this is a version of ACM TOMS algorithm 660,
by Robert Renka.
-
toms660_test
-
toms661,
a Fortran77 code which
takes scattered data in 3D
and creates an interpolating function F(X,Y,Z),
called qshep3d();
this is a version of ACM TOMS algorithm 661,
by Robert Renka.
-
toms661_test
-
toms664,
a Fortran77 code which
uses Gauss elimination to solve linear systems involving large
banded matrices. Disk storage is used when there is not
enough memory for the working data;
this library is commonly called gbsol();
this is a version of ACM TOMS algorithm 664.
-
toms664_test
-
toms666,
a Fortran77 code which
locates and evaluates roots of systems of nonlinear equations,
by Michael Vrahatis. This is a version of ACM TOMS algorithm 666.
-
toms666_test
-
toms672,
a Fortran77 code which
generates an interpolatory quadrature rule of highest possible order,
given a set of preassigned abscissas;
this library is commonly called extend();
this is a version of ACM TOMS algorithm 672.
-
toms672_test
-
toms699,
a Fortran77 code which
implements a new representation of Patterson's quadrature formula;
this is a version of ACM TOMS algorithm 699.
-
toms699_test
-
toms706,
a Fortran77 code which
estimates the integral of a function over a triangulated region;
this library is commonly called dcutri();
this is a version of ACM TOMS algorithm 706.
-
toms706_test
-
toms707,
a Fortran77 code which
evaluates the confluent hypergeometric function for complex
arguments of large magnitude, by Warren Perger, Atul Bhalla,
and Mark Nardin.
This is a version of ACM TOMS algorithm 707.
-
toms707_test
-
toms708,
a Fortran77 code which
evaluates the incomplete beta function;
this is a version of ACM TOMS algorithm 708.
-
toms708_test
-
toms715,
a Fortran77 code which
evaluates special functions, including the Bessel I, J, K, and Y
functions of order 0, of order 1, and of any real order, Dawson's
integral, the error function, exponential integrals, the gamma
function, the normal distribution function, the psi function.
This is a version of ACM TOMS algorithm 715.
-
toms715_test
-
toms723,
a Fortran77 code which
computes the Fresnel sine and cosine integrals,
by W van Snyder.
This is a version of ACM TOMS algorithm 723.
-
toms723_test
-
toms724,
a Fortran77 code which
computes the inverse Cumulative Density Function (CDF) or percentiles
of the F distribution,
by Roger Abernathy and Robert Smith.
This is a version of ACM TOMS algorithm 724.
-
toms724_test
-
toms725,
a Fortran77 code which
evaluates multivariate normal integrals associated with the computation
of the cumulative probability density function (CDF) associated with a
multidimensional variable governed by a normal probability density
function (PDF) with a known
correlation matrix, by Zvi Drezner.
This is a version of ACM TOMS algorithm 725.
-
toms725_test
-
toms726,
a Fortran77 code which
computes recursion coefficients for orthogonal polynomials,
and the abscissa and weights for related quadrature rules;
this code is commonly called orthpol(),
and is by Walter Gautschi.
This is a version of ACM TOMS algorithm 726.
-
toms726_test
-
toms738,
a Fortran77 code which
evaluates Niederreiter's quasirandom sequence;
this is a version of ACM TOMS algorithm 738;
-
toms738_test
-
toms743,
a Fortran77 code which
evaluates Lambert's W function.
This is a version of ACM TOMS algorithm 743,
by Barry, Barry and Culligan-Hensley.
-
toms743_test
-
toms757,
a Fortran77 code which
evaluates uncommon special functions,
by Allan Mcleod.
This is a version of ACM TOMS algorithm 757;
-
toms757_test
-
toms772,
a Fortran77 code which
carries out computational geometry on the unit sphere;
this library is commonly called stripack(),
by Robert Renka.
This is a version of ACM TOMS algorithm 772.
-
toms772_test
-
toms790,
a Fortran77 code which
computes an interpolating function to scattered data in the plane;
this library is commonly called cshep2d();
by Robert Renka.
This is a version of ACM TOMS algorithm 790.
-
toms790_test
-
toms792,
a Fortran77 code which
tests functions that interpolate scattered data in the plane;
by Robert Renka.
This is a version of ACM TOMS algorithm 792.
-
toms792_test
-
toms793,
a Fortran77 code which
carries out Gauss quadrature for rational functions,
by Walter Gautschi.
This library is commonly called gqrat().
This is a version of ACM TOMS algorithm 793.
-
toms793_test
-
toms886,
a Fortran77 code which
defines the Padua points for interpolation in a 2D region,
including the rectangle, triangle, and ellipse,
by Marco Caliari, Stefano de Marchi, Marco Vianello.
This is a version of ACM TOMS algorithm 886.
-
toms886_test
-
trapezoidal,
a Fortran77 code which
solves one or more ordinary differential equations (ODE)
using the (implicit) trapezoidal method, and a version of
fsolve() to handle the nonlinear equation.
-
trapezoidal_test
-
treepack,
a Fortran77 code which
carries out computations on trees,
a simple kind of graph that is minimally connected.
-
treepack_test
-
triangle,
a Fortran77 code which
computes properties, including angles, area, centroid, circumcircle,
edge lengths, incircle, orientation, orthocenter, and quality,
of a triangle in 2D.
-
triangle_test
-
triangle_analyze,
a Fortran77 code which
reads a triangle defined in a file, and
computes angles, area, centroid, circumcircle, edge lengths,
incircle, orientation, orthocenter, and quality.
-
triangle_analyze_test
-
triangle_exactness,
a Fortran77 code which
tests the polynomial exactness of a quadrature rule
over the interior of a triangle in 2D.
-
triangle_exactness_test
-
triangle_felippa_rule,
a Fortran77 code which
returns Felippa's quadratures rules for approximating integrals
over the interior of a triangle in 2D.
-
triangle_felippa_rule_test
-
triangle_grid,
a Fortran77 code which
computes a grid of points
over the interior of a triangle in 2D.
-
triangle_grid_test
-
triangle_integrals,
a Fortran77 code which
returns the exact value of the integral of any polynomial
over the interior of an arbitrary triangle in 2D.
-
triangle_integrals_test
-
triangle_io,
a Fortran77 code which
reads or writes some of the files created by Jonathan Shewchuk's
triangle() program.
-
triangle_io_test
-
triangle_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate an integral
over the interior of a general triangle in 2D.
-
triangle_monte_carlo_test
-
triangle_svg,
a Fortran77 code which
uses Scalable Vector Graphics (SVG) to plot a triangle and
any number of points, to illustrate quadrature rules and
sampling techniques.
-
triangle_svg_test
-
triangle_symq_rule,
a Fortran77 code which
returns efficient symmetric quadrature rules,
with exactness up to total degree 50,
over the interior of a triangle in 2D,
by Hong Xiao and Zydrunas Gimbutas.
-
triangle_symq_rule_test
-
triangle_to_fem,
a Fortran77 code which reads the NODE and ELE files
created by the triangle program to
describe a triangular mesh, and writes a corresponding pair of
node and element files in the 2D FEM format.
-
triangle_to_fem_test
-
triangle_to_medit,
a Fortran77 code 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_medit_test
-
triangle_to_xml,
a Fortran77 code which reads the NODE and ELE files created by triangle() to
describe a triangular mesh in 2D, and writes out a corresponding XML mesh
file for use by dolfin() or fenics().
-
triangle_to_xml_test
-
triangle01_integrals,
a Fortran77 code which
returns the integral of any monomial
over the interior of the unit triangle in 2D.
-
triangle01_integrals_test
-
triangle01_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate an integral
over the interior of the unit triangle in 2D.
-
triangle01_monte_carlo_test
-
triangulation,
a Fortran77 code which
computes the triangulation of a set of points in the plane,
and performs various operations using a triangulation, including
searching a Delaunay triangulation to find
which triangle contains a given point.
-
triangulation_test
-
triangulation_node_to_element,
a Fortran77 code which
reads files describing a set of nodes, their triangulation, and the
value of one or more quantities at each node, and outputs a file
that averages the quantities for each element. This operation
in effect creates an "order1" finite element model of the data.
-
triangulation_node_to_element_test
-
triangulation_svg,
a Fortran77 code which
creates an SVG image of a triangulation, to be displayed
by a web browser.
-
triangulation_svg_test
-
tripack,
a Fortran77 code which
computes constrained Delaunay triangulation
in the plane, ACM TOMS algorithm 751,
by Robert Renka.
-
tripack_test
-
truncated_normal,
a Fortran77 code which
works with the truncated normal distribution over [A,B], or
[A,+oo) or (-oo,B], returning the probability density function (PDF),
the cumulative density function (CDF), the inverse CDF, the mean,
the variance, and sample values.
-
truncated_normal_test
-
truncated_normal_rule,
a Fortran77 code which
computes a quadrature rule for a normal distribution that has been
truncated to [A,+oo), (-oo,B] or [A,B].
-
truncated_normal_rule_test
-
tsp_brute,
a Fortran77 code which
reads a file of city-to-city distances and solves a small
traveling salesperson problem, using brute force.
-
tsp_brute_test
-
ttyplt,
a Fortran77 code which
produces simple typewriter graphics plots.
-
ttyplt_test
-
umfpack,
a Fortran77 code which
solve a large sparse linear system,
by Timothy Davis.
-
umfpack_test
-
umfpack_2.0,
a Fortran77 code which
solve a large sparse linear system,
by Timothy Davis.
-
umfpack_2.0_test
-
uncmin,
a Fortran77 code which
performs unconstrained optimization of a scalar function;
this is a version of ACM TOMS algorithm 611.
-
uncmin_test
-
unicycle,
a Fortran77 code which
considers permutations containing a single cycle,
sometimes called cyclic permutations.
-
unicycle_test
-
uniform,
a Fortran77 code which
generates uniform random numbers.
-
uniform_test
-
valgrind_test,
a Fortran77 code which
uses valgrind() to detect memory leaks.
-
vandermonde,
a Fortran77 code which
carries out certain operations associated with the Vandermonde matrix.
-
vandermonde_test
-
vandermonde_approx_1d,
a Fortran77 code which
finds a polynomial approximant to data y(x) of a 1D argument
by setting up and solving an overdetermined linear system
for the polynomial coefficients involving the Vandermonde matrix.
-
vandermonde_approx_1d_test
-
vandermonde_approx_2d,
a Fortran77 code 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 Fortran77 code 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 Fortran77 code 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.
-
walsh_transform,
a Fortran77 code which
implements the Walsh data transform.
-
walsh_transform_test
-
wathen_matrix,
a Fortran77 code which
compares storage schemes: full, banded, sparse triplet, and
solution strategies: Linpack full, Linpack banded, conjugate gradient,
for linear systems involving the Wathen matrix, which arises when
solving a problem using the finite element method (FEM).
-
wathen_matrix_test
-
wave_mpi,
a Fortran77 code which
uses finite differences and MPI to estimate a solution to the
wave equation.
-
wave_mpi_test
-
wavelet,
a Fortran77 code which
does some simple wavelet calculations;
-
wavelet_test
-
wedge_exactness,
a Fortran77 code which
investigates the polynomial exactness of a quadrature rule
over the interior of the unit wedge in 3D.
-
wedge_exactness_test
-
wedge_felippa_rule,
a Fortran77 code which
returns quadrature rules for approximating integrals
over the interior of the unit wedge in 3D.
-
wedge_felippa_rule_test
-
wedge_grid,
a Fortran77 code which
computes a grid of points
over the interior of the unit wedge in 3D.
-
wedge_grid_test
-
wedge_integrals,
a Fortran77 code which
returns the exact value of the integral of any monomial
over the interior of the unit wedge in 3D.
-
wedge_integrals_test
-
wedge_monte_carlo,
a Fortran77 code which
uses the Monte Carlo method to estimate an integral
over the interior of the unit wedge in 3D.
-
wedge_monte_carlo_test
-
weekday,
a Fortran77 code which
determines the day of the week corresponding to a given date,
such as 14 October 1066, Julian calendar, ... which was a Saturday.
-
weekday_test
-
wishart_matrix,
a Fortran77 code which
produces sample matrices from the Wishart or Bartlett distributions,
useful for sampling random covariance matrices.
-
wishart_matrix_test
-
wtime,
a Fortran77 code which
returns a reading of the wall clock time in seconds.
-
wtime_test
-
xerror,
a Fortran77 code which
reports and handles errors detected during program execution.
-
xerror_test
-
zero_brent,
a Fortran77 code which
seeks a solution of a scalar nonlinear equation f(x)=0,
by Richard Brent.
-
zero_brent_test
-
zero_chandrupatla,
a Fortran77 code which
finds a zero of a scalar function of a scalar variable,
starting from a change of sign interval, using the
Chandrupatla method, which can converge faster than
bisection, regula falsi, or Brent's method,
by Tirupathi Chandrapatla.
-
zero_chandrupatla_test
-
zero_itp,
a Fortran77 code which
finds a zero of a scalar function of a scalar variable,
starting from a change of sign interval, using the
Interpolate/Truncate/Project (ITP) method, which has
faster convergence than the bisection method.
-
zero_itp_test
-
zero_laguerre,
a Fortran77 code which
uses Laguerre's method to find the zero of a function.
The method needs first and second derivative information.
The method almost always works when the function is a polynomial.
-
zero_laguerre_test
-
zero_muller,
a Fortran77 code which
seeks a root of a nonlinear equation using the Muller method,
with complex arithmetic.
-
zero_muller_test
-
zero_rc,
a Fortran77 code which
seeks solutions of a scalar nonlinear equation f(x)=0,
using reverse communication.
-
zero_rc_test
-
ziggurat,
a Fortran77 code which
works as a random number generator (RNG) for the
uniform, normal or exponential distributions,
using the ziggurat method.
-
ziggurat_test
-
ziggurat_openmp,
a Fortran77 code which
demonstrates the ziggurat()
a random number generator (RNG) used
in an OpenMP parallel program.
-
ziggurat_openmp_test
Last revised on 18 October 2024.