Software_Summaries


abaqus, examples which illustrate the use of ABAQUS, which is a finite element program specifically designed for structural engineering problems, with additional modules for computational fluid dynamics and for electromagnetic problems.

abinit, examples which illustrate the use of ABINIT, which allows one to find the total energy, charge density and electronic structure of systems made of electrons and nuclei (molecules and periodic solids) within Density Functional Theory (DFT), using pseudopotentials and a planewave basis, or augmented plane waves, or even wavelets.

abyss, examples which illustrate the use of ABYSS, which is a de novo, parallel, paired-end sequence assembler that is designed for short reads. The single-processor version is useful for assembling genomes up to 100 Mbases in size. The parallel version is implemented using MPI and is capable of assembling larger genomes.

albany_test, a C++ program which tests the albany linear algebra library.

allinea-forge, examples which illustrate the use of ALLINEA-FORGE, which is a pair of programs, ALLINEA-DDT for debugging, and ALLINEA-MAP for program performance monitoring. Both are designed for programs that are running on clusters and in parallel.

allocatable_array, a C program which demonstrates how a C function can declare a pointer to an array, call a function, which can then allocate it and fill it with data, and then return the allocated and initialized array to the calling function through the argument list.

allocatable_array, a C++ program which demonstrates how a C++ function can declare a pointer to an array, call a function, which can then allocate it and fill it with data, and then return the allocated and initialized array to the calling function through the argument list.

allocatable_array, a FORTRAN90 program which demonstrates how a FORTRAN main program can declare an allocatable array, pass it to a subroutine, which can then allocate it and fill it with data, and then return the allocated and initialized array to the calling program.

alpert_rule, a C library which can set up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.

alpert_rule, a C++ library which can set up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.

alpert_rule, a FORTRAN90 library which can set up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.

alpert_rule, a MATLAB library which can set up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.

alpert_rule, a Python library which can set up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.

alpert_rule_test

alpert_rule_test

alphabet_lowercase, a dataset directory which contains large images of the 26 lowercase alphabetic characters.

alphabet_uppercase, a dataset directory which contains large images of the 26 uppercase alphabetic characters.

anagram, a C++ program which determines anagrams of a string, by James Cherry;

analemma, a C program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot, based on a C program by Brian Tung.

analemma, a C++ program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot, based on a C program by Brian Tung.

analemma, a FORTRAN77 program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot, based on a C program by Brian Tung.

analemma, a FORTRAN90 program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot, based on a C program by Brian Tung.

analemma, a MATLAB program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, based on a C program by Brian Tung.

analemma, a Python program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot, based on a C program by Brian Tung.

analemma_test

analemma_test

analemma_test

analemma_test

ann, a C++ library which computes Approximate Nearest Neighbors, by David Mount, Sunil Arya;

ann_test, a C++ program which uses ann() to approximate the nearest neighbors of a set of points stored in a file, by David Mount, Sunil Arya;

ann_to_fig, a C++ program which plots the search tree used by ann() while seeking the approximate nearest neighbors of a set of points, by David Mount, Sunil Arya;

annulus_flow, a FENICS script which simulates flow in an annulus, goverened by the time-dependent Navier Stokes equations.

annulus_monte_carlo a C library which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.

annulus_monte_carlo a C++ library which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.

annulus_monte_carlo a FORTRAN90 library which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.

annulus_monte_carlo a MATLAB library which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.

annulus_monte_carlo a Python library which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.

annulus_monte_carlo_test

-

annulus_monte_carlo_test

-

annulus_rule, a C library which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.

annulus_rule, a C++ library which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.

annulus_rule, a FORTRAN90 library which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.

annulus_rule, a MATLAB library which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.

annulus_rule, a Python library which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.

annulus_rule_test

annulus_rule_test

ansys, examples which illustrate the use of ANSYS, a suite of programs which provide solutions to physical problems posed in almost any area of engineering. ANSYS includes programs specialized for fluids, structures, electronics, semiconductors, systems, and multiphysics.

apache-ant, examples which illustrate the use of APACHE-ANT, which is a Java-based build utility.

apbs-static, examples which illustrate the use of APBS-STATIC, which is an adaptive Poisson-Boltzmann solver which models biomolecular solvation.

apportionment, a FORTRAN90 library which demonstrates some of the methods used or proposed for fairly assigning a number of seats in the House of Representatives to each state;

arbitrary_weight_rule, a MATHEMATICA program which accepts a formula for an arbitrary (but nonnegative) weight function over an interval, and determines the points and weights of a corresponding Gaussian quadrature rule, by Fukuda, Katsuya, Alt and Matveenko;

arby4, a FORTRAN90 program which accepts solutions of a 2D fluid flow problem governed by the Navier Stokes equations (NSE), and analyzes it using the reduced basis method. This is version 4 of a program which had 4 versions;

area_under_curve, a MATLAB function which displays the area under a curve, that is, the points (x,y) between the X axis and the curve Y=F(X).

area_under_curve_test

args, a C program which reports the commandline arguments with which it was invoked;

args, a C++ program which reports the commandline arguments with which it was invoked;

args, a FORTRAN77 program which reports the commandline arguments with which it was invoked;

args, a FORTRAN90 program which reports the commandline arguments with which it was invoked;

args, a MATLAB program which reports the commandline arguments with which it was invoked;

args, a Python program which reports the commandline arguments with which it was invoked;

args_test

args_test

arpack, a FORTRAN90 library which computes eigenvalues for large matrices, which includes a reverse communication (RC) feature, by Richard Lehoucq, Danny Sorensen, Chao Yang;

arpack_test

arpack_test, MATLAB functions which call arpack to compute eigenvalues and eigenvectors of large sparse matrices, accessible via the built-in eigs() command;

asa_2011_geometry, MATLAB programs which were used during labs, demonstrations, and lectures associated with the Geometry Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.

asa_2011_graphs, MATLAB programs which were used during labs, demonstrations, and lectures associated with the Graph Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.

asa_2011_images, MATLAB programs which were used during labs, demonstrations, and lectures associated with the Image Algorithms portion of the class Algorithms for Science Applications II, as taught at the Scientific Computing Department, Florida State University, Spring Semester 2011.

asa005, a C library 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, a C++ library 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, a FORTRAN77 library 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, a FORTRAN90 library 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, a MATLAB library 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

asa005_test

asa006, a C library which computes the Cholesky factorization of a symmetric positive definite matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;

asa006, a C++ library which computes the Cholesky factorization of a symmetric positive definite matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;

asa006, a FORTRAN77 library which computes the Cholesky factorization of a symmetric positive definite matrix, by Michael Healy; This is a version of Applied Statistics Algorithm 6;

asa006, a FORTRAN90 library which computes the Cholesky factorization of a symmetric positive definite matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;

asa006, a MATLAB library which computes the Cholesky factorization of a symmetric positive definite matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;

asa006_test

asa006_test

asa007, a C library which computes the inverse of a symmetric positive definite matrix, and uses a version of ASA006 for Cholesky factorization, by Michael Healy. This is a version of Applied Statistics Algorithm 7.

asa007, a C++ library which computes the inverse of a symmetric positive definite matrix, and uses a version of ASA006 for Cholesky factorization, by Michael Healy. This is a version of Applied Statistics Algorithm 7.

asa007, a FORTRAN77 library which computes the inverse of a symmetric positive definite matrix, and uses a version of ASA006 for Cholesky factorization. The algorithm is by Michael Healy. This is a version of Applied Statistics Algorithm 7;

asa007, a FORTRAN90 library which computes the inverse of a symmetric positive definite matrix, and uses a version of ASA006 for Cholesky factorization, by Michael Healy. This is a version of Applied Statistics Algorithm 7.

asa007, a MATLAB library which computes the inverse of a symmetric positive definite matrix, and uses a version of ASA006 for Cholesky factorization, by Michael Healy. This is a version of Applied Statistics Algorithm 7.

asa007_test

asa007_test

asa032, a C library which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.

asa032, a C++ library which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.

asa032, a FORTRAN77 library which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32;

asa032, a FORTRAN90 library which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.

asa032, a MATLAB library which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.

asa032_test

asa032_test

asa047, a C library which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.

asa047, a C++ library which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.

asa047, a FORTRAN77 library which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47;

asa047, a FORTRAN90 library which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.

asa047, a MATLAB library which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.

asa047, a Python library which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.

asa047_test

asa047_test

asa053, a C library which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.

asa053, a C++ library which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.

asa053, a FORTRAN77 library which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.

asa053, a FORTRAN90 library which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.

asa053, a MATLAB library which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.

asa053_test

asa053_test

asa058, a C library which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.

asa058, a C++ library which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.

asa058, a FORTRAN77 library which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58;

asa058, a FORTRAN90 library which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.

asa058, a MATLAB library which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.

asa058_test

asa058_test

asa063, a C library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.

asa063, a C++ library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.

asa063, a FORTRAN77 library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63;

asa063, a FORTRAN90 library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.

asa063, a MATLAB library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.

asa063, a Python library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.

asa063_test

asa063_test

asa066, a C library which evaluates the Cumulative Density Function (CDF) of the normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.

asa066, a C++ library which evaluates the Cumulative Density Function (CDF) of the normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.

asa066, a FORTRAN77 library which evaluates the Cumulative Density Function (CDF) of the normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66;

asa066, a FORTRAN90 library which evaluates the Cumulative Density Function (CDF) of the normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.

asa066, a MATLAB library which evaluates the Cumulative Density Function (CDF) of the normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.

asa066_test

asa066_test

asa076, a C library which evaluates the Owen's 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, a C++ library which evaluates the Owen's 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, a FORTRAN77 library which evaluates the Owen's 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, a FORTRAN90 library which evaluates the Owen's 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, a MATLAB library which evaluates the Owen's 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

asa076_test

asa091, a C library which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.

asa091, a C++ library which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.

asa091, a FORTRAN77 library which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91;

asa091, a FORTRAN90 library which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.

asa091, a MATLAB library 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

asa091_test

asa103, a C library which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.

asa103, a C++ library which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.

asa103, a FORTRAN77 library which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103;

asa103, a FORTRAN90 library which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.

asa103, a MATLAB library which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.

asa103, a Python library which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.

asa103_test

asa103_test

asa109, a C library which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.

asa109, a C++ library which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.

asa109, a FORTRAN77 library which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109;

asa109, a FORTRAN90 library which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.

asa109, a MATLAB library which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.

asa109_test

asa111, a C library which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.

asa111, a C++ library which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.

asa111, a FORTRAN77 library which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111;

asa111, a FORTRAN90 library which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.

asa111, a MATLAB library which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.

asa111_test

asa113, a C library which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.

asa113, a C++ library which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.

asa113, a FORTRAN77 library which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.

asa113, a FORTRAN90 library which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.

asa113, a MATLAB library 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 C library which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.

asa121, a C++ library which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.

asa121, a FORTRAN77 library which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121;

asa121, a FORTRAN90 library which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.

asa121, a MATLAB library which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.

asa121_test

asa136, a C library which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.

asa136, a C++ library which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.

asa136, a FORTRAN77 library which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136;

asa136, a FORTRAN90 library which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.

asa136, a MATLAB library which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.

asa136_test

asa144, a C library which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.

asa144, a C++ library which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.

asa144, a FORTRAN77 library which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144;

asa144, a FORTRAN90 library which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.

asa144, a MATLAB library which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.

asa144_test

asa147, a C library which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.

asa147, a C++ library which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.

asa147, a FORTRAN77 library which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147;

asa147, a FORTRAN90 library which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.

asa147, a MATLAB library which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.

asa147_test

asa152, a C library which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;

asa152, a C++ library which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;

asa152, a FORTRAN77 library which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;

asa152, a FORTRAN90 library which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;

asa152, a MATLAB library which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152.

asa152_test

asa159, a C library which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.

asa159, a C++ library which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.

asa159, a FORTRAN77 library which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159;

asa159, a FORTRAN90 library which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.

asa159, a MATLAB library which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.

asa159_test

asa172, a C library which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. This is a version of Applied Statistics Algorithm 172.

asa172, a C++ library which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;

asa172, a FORTRAN77 library which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;

asa172, a FORTRAN90 library which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;

asa172, a MATLAB library which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;

asa172_test

asa183, a C library which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.

asa183, a C++ library which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.

asa183, a FORTRAN77 library which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183;

asa183, a FORTRAN90 library which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.

asa183, a MATLAB library which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.

asa183, a Python library 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 library 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, a FORTRAN90 library 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;

asa205, a FORTRAN77 library 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, a FORTRAN90 library 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.

asa226, a C library 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, a C++ library 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, a FORTRAN77 library 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, a FORTRAN90 library 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, a MATLAB library 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 C library which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.

asa239, a C++ library which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.

asa239, a FORTRAN77 library which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239;

asa239, a FORTRAN90 library which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.

asa239, a MATLAB library which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.

asa239_test

asa241, a C library which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.

asa241, a C++ library which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.

asa241, a FORTRAN77 library which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241;

asa241, a FORTRAN90 library which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.

asa241, a MATLAB library which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.

asa241, a Python library 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 C library 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, a C++ library 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, a FORTRAN77 library 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, a FORTRAN90 library 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, a MATLAB library 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 C library which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.

asa245, a C++ library which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.

asa245, a FORTRAN77 library which evaluates the logarithm of the Gamma function, by Allan Mcleod; This is a version of Applied Statistics Algorithm 245;

asa245, a FORTRAN90 library which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.

asa245, a MATLAB library which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.

asa245_test

asa266, a C library which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;

asa266, a C++ library which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;

asa266, a FORTRAN77 library which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;

asa266, a FORTRAN90 library which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;

asa266, a MATLAB library which evaluates various properties of the Dirichlet Probability Density Function (PDF); This is a version of Applied Statistics Algorithm 266.

asa266_test

asa299, a C library which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;

asa299, a C++ library which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;

asa299, a FORTRAN77 library which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;

asa299, a FORTRAN90 library which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;

asa299, a MATLAB library 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 C library 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, a C++ library 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, a FORTRAN77 library 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, a FORTRAN90 library 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, a MATLAB library 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.

asa314, a C library which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;

asa314, a C++ library which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;

asa314, a FORTRAN77 library which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;

asa314, a FORTRAN90 library which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;

asa314, a MATLAB library which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;

ascii_art_grayscale, a data directory which contains grayscale ASCII Art files, in which images are created using printable characters.

ascii_to_mri, a C program which restores magnetic resonance imaging (MRI) data to its original binary format, having been previously converted to an ASCII text file.

ascii_to_mri_test, a BASH script which tests ascii_to_mri.

aspect: examples which illustrate the use of ASPECT, which is a C++ program that simulates the process of convection within the mantle of the earth. ASPECT is built on top of the DEAL.II finite element library.

atbash, a C library which applies the Atbash substitution cipher to a string of text.

atbash, a C++ library which applies the Atbash substitution cipher to a string of text.

atbash, a FORTRAN90 library which applies the Atbash substitution cipher to a string of text.

atbash, a MATLAB library which applies the Atbash substitution cipher to a string of text.

atbash, a Python library which applies the Atbash substitution cipher to a string of text.

atbash_test, a C program which applies the Atbash substitution cipher to a string of text.

atlas, examples which illustrate the use of the ATLAS library, which provides a version of the Basic Linear Algebra Subprograms (BLAS) which have been adaptively tuned for optimal performance on a specific hardware and software environment.

autodocksuite, examples which illustrate the use of AUTODOCKSUITE, which is a set of programs which predict the binding of small molecules to a receptor of known 3D structure.

automake, examples which illustrate the use of AUTOMAKE, which is part of the GNU AUTOTOOLS package; from relatively simple user input, AUTOMAKE generates files that can, in turn, generate Makefiles and other items necessary for building a software package.

backtrack_binary_rc, a C library which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).

backtrack_binary_rc, a C++ library which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).

backtrack_binary_rc, a FORTRAN77 library which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).

backtrack_binary_rc, a FORTRAN90 library which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).

backtrack_binary_rc, a MATLAB library which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).

backtrack_binary_rc, a Python library which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).

ball_and_stick_display, a MATLAB program which demonstrates the creation of a 3D ball and stick image;

ball_distance, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected in the unit ball.

ball_grid, a C library which computes a grid of points over the interior of a ball in 3D.

ball_grid, a C++ library which computes a grid of points over the interior of a ball in 3D.

ball_grid, a FORTRAN77 library which computes a grid of points over the interior of a ball in 3D.

ball_grid, a FORTRAN90 library which computes a grid of points over the interior of a ball in 3D.

ball_grid, a MATLAB library which computes a grid of points over the interior of a ball in 3D.

ball_grid, a Python library which computes a grid of points over the interior of a ball in 3D.

ball_integrals, a C library which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.

ball_integrals, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.

ball_integrals, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.

ball_integrals, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.

ball_integrals, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.

ball_integrals, a Python library which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.

ball_monte_carlo, a C library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;

ball_monte_carlo, a C++ library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;

ball_monte_carlo, a FORTRAN77 library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;

ball_monte_carlo, a FORTRAN90 library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;

ball_monte_carlo, a MATLAB library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;

ball_monte_carlo, a Python library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;

bamg, a data directory which contains geometry files that can be input to the BAMG meshing program.

bamg, examples which illustrate the use of BAMG, a program for generating 2D meshes that can be used to define the geometry for the the finite element package FREEFEM++.

bamtools, examples which illustrate the use of BAMTOOLS, which is a collection of tools for manipulating genome alignment information stored in the BAM file format.

band_qr, a FORTRAN77 library 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, a FORTRAN90 library which computes the QR factorization of a banded matrix, and can solve related linear systems, by Alfredo Remon, Enrique Quintana-Orti, Gregorio Quintana-Orti.

bank, a C library which can compute the check digit associated with a US Bank Routing Number check digit, or it can report whether a 9-digit code is actually valid.

bank, a C++ library which can compute the check digit associated with a US Bank Routing Number check digit, or it can report whether a 9-digit code is actually valid.

bank, a FORTRAN90 library which can compute the check digit associated with a US Bank Routing Number check digit, or it can report whether a 9-digit code is actually valid.

bank, a MATLAB library which can compute the check digit associated with a US Bank Routing Number check digit, or it can report whether a 9-digit code is actually valid.

bank, a Python library which can compute the check digit associated with a US Bank Routing Number check digit, or it can report whether a 9-digit code is actually valid.

bar_plot, a FORTRAN90 library which creates RGB color arrays for data that represents a sort of bar plot (several Y values for each X value).

barycentric_interp_1d, a C library which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.

barycentric_interp_1d, a C++ library which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.

barycentric_interp_1d, a FORTRAN77 library which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.

barycentric_interp_1d, a FORTRAN90 library which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.

barycentric_interp_1d, a MATLAB library which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.

barycentric_interp_1d, a Python library which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.

bash_shell, examples which illustrate the use of BASH shell scripts.

basis_compare, a FORTRAN90 program which compares two sets, each containing N orthonormal M-dimensional vectors, to see if they span the same subspace.

batch, R programs which illustrate how an R program can be executed in "batch mode".

bayes_beta, a FORTRAN90 program which uses Bayesian analysis to estimate the parameters in a beta distribution based on a series of sample data.

bayes_dice, a FORTRAN90 program which uses Bayesian analysis to adjust a model of loaded dice based on a sequence of experimental observations.

bayes_weight, a FORTRAN90 program which uses Bayesian analysis to adjust a model of loaded dice based on a sequence of experimental observations.

bcftools, examples which illustrate the use of BCFTOOLS, which is a collection of tools for variant calling and manipulating VCF's and BCF's.

bdmlib, a FORTRAN77 library which estimates the weights in a Dirichlet mixtured based on sample data;

bdmlib, a FORTRAN90 library which estimates the weights in a Dirichlet mixtured based on sample data;

beagle-lib, examples which illustrate the use of BEAGLE-LIB, which is a library which evaluates the likelihood of sequence evolution on trees.

beale_cipher, a dataset directory which contains the text of the three Beale cipher documents, which are supposed to indicate the location of a hoard of gold and silver.

bedtools, examples which illustrate the use of BEDTOOLS, which is a collection of tools for carrying out genome arithmetic.

bellman_ford, a C library which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.

bellman_ford, a C++ library which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.

bellman_ford, a FORTRAN77 library which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.

bellman_ford, a FORTRAN90 library which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.

bellman_ford, a MATLAB library which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.

bellman_ford, a Python library which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.

bernstein_approximation, a MATLAB library which looks at some simple cases of approximation of a function f(x) by a Bernstein polynomial.

bernstein_polynomial, a C library which evaluates the Bernstein polynomials, useful for uniform approximation of functions;

bernstein_polynomial, a C++ library which evaluates the Bernstein polynomials, useful for uniform approximation of functions;

bernstein_polynomial, a FORTRAN77 library which evaluates the Bernstein polynomials, useful for uniform approximation of functions;

bernstein_polynomial, a FORTRAN90 library which evaluates the Bernstein polynomials, useful for uniform approximation of functions;

bernstein_polynomial, a MATLAB library which evaluates the Bernstein polynomials, useful for uniform approximation of functions;

bernstein_polynomial, a Python library which evaluates the Bernstein polynomials, useful for uniform approximation of functions;

besselj, a C library which evaluates Bessel J functions of noninteger order.

besselj, a C++ library which evaluates Bessel J functions of noninteger order.

besselj, a FORTRAN90 library which evaluates Bessel J functions of noninteger order.

besselj, a MATLAB library which evaluates Bessel J functions of noninteger order.

besselj, a Python library which evaluates Bessel J functions of noninteger order.

beta_nc, a C library which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.

beta_nc, a C++ library which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.

beta_nc, a FORTRAN77 library which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.

beta_nc, a FORTRAN90 library which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.

beta_nc, a MATLAB library which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.

betis, a FORTRAN77 program which applies the boundary element method (BEM) to solve Laplace's equation in a 2D region, by Federico Paris and Jose Canas.

bezier_surface, a data directory which contains bezier_surface files, a simple format comprising two files, suitable for storing the definition of a Bezier surface used in 3D graphics;

bezier_surface, a FORTRAN90 library which reads, writes, prints and manipulates data that defines a Bezier surface;

bezier_surface, a MATLAB library which reads, writes, prints and manipulates the data that defines a Bezier surface;

bezier_surface_display, a MATLAB program which displays a Bezier surface;

bicycle_lock, a C library which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.

bicycle_lock, a C++ library which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.

bicycle_lock, a FORTRAN90 library which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.

bicycle_lock, a MATLAB library which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.

bicycle_lock, a Python library which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.

bin_packing, a dataset directory which contains instances of the bin packing problem, in which a number of objects are to be packed in the minimum possible number of uniform bins;

bins, a C++ library which orders, sorts and searches data using bins;

bins, a FORTRAN77 library which orders, sorts and searches data using bins;

bins, a FORTRAN90 library which orders, sorts and searches data using bins;

bio, a C library which manages binary I/O, by Greg Hood.

birthday_remote, a MATLAB program which runs a Monte Carlo simulation of the birthday paradox, and includes instructions on how to run the job, via MATLAB's batch facility, on a remote system such as Virginia Tech's Ithaca cluster.

birthdays, a dataset directory which contains data related to birthdays, such as the birthdays of members of hockey teams, and the number of babies born in the US on each calendar day over an interval of several years.

bisect, a Python library which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using classes.

bisection_integer, a C library which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].

bisection_integer, a C++ library which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].

bisection_integer, a FORTRAN77 library which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].

bisection_integer, a FORTRAN90 library which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].

bisection_integer, a MATLAB library which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].

bisection_rc, a C library which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).

bisection_rc, a C++ library which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).

bisection_rc, a FORTRAN77 library which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).

bisection_rc, a FORTRAN90 library which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).

bisection_rc, a MATLAB library which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).

bisection_rc, a Python library which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).

bits_to_ui, a C++ program which reads a text file of "bits", ('0' and '1' characters), and writes a binary file in which groups of 32 bits have been interpreted as an unsigned integer;

black_scholes, a C library which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.

black_scholes, a C++ library which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.

black_scholes, a FORTRAN77 library which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.

black_scholes, a FORTRAN90 library which implements some simple approaches to the Black-Scholes option valuation theory, creating graphics files for processing by gnuplot, by Desmond Higham.

black_scholes, a MATLAB library which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.

black_scholes, a Python library which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.

blacs_test, FORTRAN90 programs which test blacs, the Basic Linear Algebra Communication Subprograms, which form a linear algebra-oriented message passing interface that may be implemented efficiently and uniformly across a large range of distributed memory platforms.

blas, a C library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations), level 2 (matrix-vector operations) and level 3 (matrix-matrix operations), for single precision real arithmetic, double precision real arithmetic, single precision complex arithmetic, and double precision complex arithmetic.

blas, a C++ library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations), level 2 (matrix-vector operations) and level 3 (matrix-matrix operations), for single precision real arithmetic, double precision real arithmetic, single precision complex arithmetic, and double precision complex arithmetic.

blas, a FORTRAN77 library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations), level 2 (matrix-vector operations) and level 3 (matrix-matrix operations), for single precision real arithmetic, double precision real arithmetic, single precision complex arithmetic, and double precision complex arithmetic.

blas, a FORTRAN90 library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations), level 2 (matrix-vector operations) and level 3 (matrix-matrix operations), for single precision real arithmetic, double precision real arithmetic, single precision complex arithmetic, and double precision complex arithmetic.

blas, a MATLAB library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations), level 2 (matrix-vector operations) and level 3 (matrix-matrix operations), for single precision real arithmetic, double precision real arithmetic, single precision complex arithmetic, and double precision complex arithmetic.

blas_osx, a C program which demonstrates how to access the BLAS library on a Macintosh that is running the OSX operating system.

blas_osx, a C++ program which demonstrates how to access the BLAS library on a Macintosh that is running the OSX operating system.

blas_osx, a FORTRAN90 program which demonstrates how to access the BLAS library on a Macintosh that is running the OSX operating system.

blas0, a C library which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).

blas0, a C++ library which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).

blas0, a FORTRAN77 library which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).

blas0, a FORTRAN90 library which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).

blas0, a MATLAB library which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).

blas1, a C library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations) for single and double precision, and for real and complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1, a C++ library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations) for single and double precision, and for real and complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1, a FORTRAN77 library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations) for single and double precision, and for real and complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1, a MATLAB library which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 (vector-vector operations) for single and double precision, and for real and complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1_c, a C library which contains 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, a C++ library which contains 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, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using single precision complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1_cC, a FORTRAN90 library which contains 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, a MATLAB library which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using single precision complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1_d, a C library which contains 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, a C++ library which contains 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, a FORTRAN77 library which contains 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, a FORTRAN90 library which contains 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, a MATLAB library which contains 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, a Python library which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using double precision real arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1_s, a C library which contains 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, a C++ library which contains 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, a FORTRAN77 library which contains 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, a FORTRAN90 library which contains 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, a MATLAB library which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using single precision real arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas1_z, a C library which contains 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, a C++ library which contains 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, a FORTRAN77 library which contains 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, a FORTRAN90 library which contains 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, a MATLAB library which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using double precision complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.

blas2_, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision complex arithmetic;

blas2_, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision complex arithmetic;

blas2_d, a C library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision real arithmetic;

blas2_d, a C++ library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision real arithmetic;

blas2_d, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision real arithmetic;

blas2_d, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision real arithmetic;

blas2_d, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision real arithmetic;

blas2_d, a MATLAB library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision real arithmetic;

blas2_s, a C library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision real arithmetic;

blas2_s, a C++ library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision real arithmetic;

blas2_s, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision real arithmetic;

blas2_s, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision real arithmetic;

blas2_s, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision real arithmetic;

blas2_s, a MATLAB library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using single precision real arithmetic;

blas2_z, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision complex arithmetic;

blas2_z, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using double precision complex arithmetic;

blas3_c, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using single precision complex arithmetic;

blas3_c, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using single precision complex arithmetic;

BLAS3_D, a C library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using double precision real arithmetic.

BLAS3_D, a C++ library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using double precision real arithmetic.

BLAS3_D, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using double precision real arithmetic;

BLAS3_D, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using double precision real arithmetic;

BLAS3_D, a MATLAB library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using double precision real arithmetic;

BLAS3_S, a C library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using single precision real arithmetic.

BLAS3_S, a C++ library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using single precision real arithmetic;

BLAS3_S, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using single precision real arithmetic;

BLAS3_S, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using single precision real arithmetic;

BLAS3_S, a MATLAB library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using single precision real arithmetic;

BLAS3_Z, a FORTRAN77 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using double precision complex arithmetic;

BLAS3_Z, a FORTRAN90 library which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using double precision complex arithmetic;

BLEND, a C library which implements blended mapping or transfinite interpolation;

BLEND, a C++ library which implements blended mapping or transfinite interpolation;

BLEND, a FORTRAN77 library which implements blended mapping or transfinite interpolation;

BLEND, a FORTRAN90 library which implements blended mapping or transfinite interpolation;

BLEND, a MATLAB library which implements blended mapping or transfinite interpolation;

BLSPRICE, MATLAB programs which demonstrate the use of the BLSPRICE function, for Black-Scholes option pricing, from the MATLAB Financial Mathematics toolbox.

BMP_IO, a C++ library which reads and writes information stored in a BMP graphics file;

BMP_TO_PPMA, a C++ program which converts a BMP graphics file to an ASCII Portable Pixel Map (PPM) file;

BMP_TO_PPMB, a C++ program which converts a BMP graphics file to a binary Portable Pixel Map (PPM) file;

BOOST, examples which illustrate the use of BOOST, which is a C++ library of high-quality functions which are free, peer-reviewed, portable, intended to work with, and to extend, the C++ Standard Library.

BOOST-MPI, examples which illustrate the use of BOOST-MPI, which is a C++ library, part of the BOOST distribution, specifically designed for MPI applications.

BOOST-UCS2, examples which illustrate the use of BOOST-UCS2, which is a C++ library of high-quality functions which are free, peer-reviewed, portable, intended to work with, and to extend, the C++ Standard Library.

boost_test, C++ programs which demonstrate the use of the Boost libraries;

BOWTIE, examples which illustrate the use of BOWTIE, which is a tool for fast, efficient short sequencing read alignment.

BOWTIE2, examples which illustrate the use of BOWTIE2, which is a tool for fast and sensitive sequencing read alignment.

BOX_BEHNKEN, a C library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;

BOX_BEHNKEN, a C++ library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;

BOX_BEHNKEN, a FORTRAN77 library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;

BOX_BEHNKEN, a FORTRAN90 library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;

BOX_BEHNKEN, a MATLAB library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;

BOX_DISPLAY, a MATLAB program which displays a box plot, over integer pairs of data, of a function defined by two formulas.

BOX_GAMES, a MATLAB library which contains utilities for creating and displaying simple board games, such as for checkers, or life, or a cellular automaton.

BOX_PLOT, a MATLAB program which displays a box plot of data that consists of pairs of integers;

BRAIN_SENSOR_POD, a MATLAB program which applies the method of Proper Orthogonal Decomposition to seek underlying patterns in sets of 40 sensor readings of brain activity.

BRENT, a C library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, including a reverse communication (RC) option, by Richard Brent.

BRENT, a C++ library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, including a reverse communication (RC) option, by Richard Brent. The C++ version includes some customizations by John Denker.

BRENT, a FORTRAN77 library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, including a reverse communication (RC) option, by Richard Brent.

BRENT, a FORTRAN90 library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, including a reverse communication (RC) option, by Richard Brent.

BRENT, a MATLAB library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, including a reverse communication (RC) option, by Richard Brent.

BRENT_OLD, a C++ library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent. This version has been replaced by a new version with including a reverse communication (RC) option, some customizations by John Denker.

BROWNIAN_MOTION_SIMULATION, a C library which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot.

BROWNIAN_MOTION_SIMULATION, a C++ library which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot.

BROWNIAN_MOTION_SIMULATION, a FORTRAN77 library which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot.

BROWNIAN_MOTION_SIMULATION, a FORTRAN90 library which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot.

BROWNIAN_MOTION_SIMULATION, a MATLAB library which simulates Brownian motion in an M-dimensional region.

BROWNIAN_MOTION_SIMULATION, a Python library which simulates Brownian motion in an M-dimensional region.

BT_SERIAL, a FORTRAN77 program which a serial version of the NAS Block Tridiagonal (BT) Parallel Benchmark.

BT_SERIAL, a FORTRAN90 program which a serial version of the NAS Block Tridiagonal (BT) Parallel Benchmark .

BUCKLING_SPRING, a MATHEMATICA program which explores the buckling spring equations.

BUCKLING_SPRING, a MATLAB program which explores the buckling spring equations.

BURGERS, a dataset directory which contains 40 solutions of the Burgers equation in one space dimension and time, at equally spaced times from 0 to 1, with values at 41 equally spaced nodes in [0,1];

BURGERS_CHARACTERISTICS, a MATHEMATICA program which solves the time dependent inviscid Burgers equation using the method of characteristics, by Mikel Landajuela.

burgers_solution, a C library which evaluates exact solutions of the time-dependent 1D viscous Burgers equation.

burgers_solution, a C++ library which evaluates exact solutions of time-dependent 1D viscous Burgers equation.

burgers_solution, a FORTRAN77 library which evaluates an exact solution of the time-dependent 1D viscous Burgers equation.

burgers_solution, a FORTRAN90 library which evaluates exact solutions of time-dependent 1D viscous Burgers equation.

burgers_solution, a MATLAB library which evaluates exact solutions of time-dependent 1D viscous Burgers equation.

burgers_solution, a Python library which evaluates exact solutions of time-dependent 1D viscous Burgers equation.

burgers_steady_viscous, a MATLAB library which solves the steady (time-independent) viscous Burgers equation using a finite difference method (FDM) discretization of the conservative form of the equation, and then applying Newton's method to solve the resulting nonlinear system.

burgers_steady_viscous, a FENICS script which uses the finite element method to solve a version of the steady viscous Burgers equation over the interval [-1,+1].

BURGERS_TIME_INVISCID, a MATLAB library which solves the time-dependent inviscid Burgers equation using a finite difference method (FDM) discretization, and one of six solution methods selected by the user, by Mikal Landajuela.

burgers_time_viscous, a MATLAB library which solves the time-dependent viscous Burgers equation using a finite difference method (FDM) discretization of the conservative form of the equation.

burgers_time_viscous, a FENICS script which uses the finite element method to solve a version of the time-dependent viscous Burgers equation over the interval [-1,+1].

BVEC, a C library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.

BVEC, a C++ library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.

BVEC, a FORTRAN77 library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.

BVEC, a FORTRAN90 library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.

BVEC, a MATLAB library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.

BVEC, a Python library which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.

BVLS, a FORTRAN77 library which applies linear least squares (LLS) methods to solve a system for which lower and upper constraints may have been placed on every variable, by Charles Lawson and Richard Hanson.

BVLS, a FORTRAN90 library which applies linear least squares (LLS) methods to solve a system for which lower and upper constraints may have been placed on every variable, by Charles Lawson and Richard Hanson.

bvp, FENICS scripts which solve two-point boundary value problems (BVP) in 1D.

BVP4C, MATLAB programs which illustrate how to use the MATLAB command bvp4c(), which can solve boundary value problems (BVP's) in one spatial dimension.

BVPSOL, a FORTRAN77 library 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.

BZIP2, examples which illustrate the use of BZIP2, which is a program to compress a single file, and BUNZIP2, which reverses the compression.

C, C programs which illustrate some of the features of the C programming language.

C_ARRAYS, C programs which illustrate the use of vectors, matrices and tensors.

C_CALLS_F77, C programs which call a FORTRAN77 subroutine.

C_CALLS_F90, C programs which call a FORTRAN90 subroutine.

C_COMMENT, a FORTRAN90 program which makes a copy of a file in which C++ style comments have been replaced by C-style comments.

C_CONDOR, C programs which illustrate how a C program can be run in batch mode using the condor queueing system.

C_FILES, C programs which illustrate the use of files.

C_INTRINSICS, a C program which illustrates the use of intrinsic functions supplied by the C language.

C_MISTAKE, programs which illustrate some simple but devious programming mistakes in C.

C_OPERATORS, a C program which illustrates the use of some of the operators supplied by the C language.

C_RANDOM, C programs which illustrate the use of C random number generator (RNG) functions.

C_SHELL, examples which illustrate the use of C shell scripts.

C++_CALLS_C, C++ programs which call a C function.

C++_CALLS_F77, C++ programs which call a FORTRAN77 subroutine.

C++_CALLS_F90, C++ programs which call a FORTRAN90 subroutine.

C++_CONDOR, C++ programs which illustrate how a C++ program can be run in batch mode using the condor queueing system.

C4_COMPLEX_LIB, a C library which defines a single precision complex (C4) variable as a structure, and implements certain corresponding elementary functions.

C4_COMPLEX_LIB, a C++ library which defines a class called c4_complex for complex numbers with single precision components.

C4LIB, a C library which implements certain elementary functions for single precision complex (C4) variables using the C99 float complex datatype.

C4LIB, a C++ library which implements certain elementary functions for single precision complex (C4) variables using the C++ complex datatype.

C4LIB, a FORTRAN77 library which implements certain elementary functions for single precision complex (C4) variables;

C4LIB, a FORTRAN90 library which implements certain elementary functions for single precision complex (C4) variables;

C4LIB, a MATLAB library which implements certain elementary functions for single precision complex (C4) variables.

C4LIB, a Python library which implements certain elementary functions for single precision complex (C4) variables.

C8_COMPLEX_LIB, a C library which defines a double precision complex (C8) variable as a structure, and implements certain corresponding elementary functions.

C8_COMPLEX_LIB, a C++ library which defines a class called c8_complex for complex numbers with double precision components.

C8LIB, a C library which implements certain elementary functions for double precision complex (C8) variables using the C99 standard double complex datatype.

C8LIB, a C++ library which implements certain elementary functions for double precision complex (C8) variables using the C++ complex <double> datatype.

C8LIB, a FORTRAN77 library which implements certain elementary functions for double precision complex (C8) variables;

C8LIB, a FORTRAN90 library which implements certain elementary functions for double precision complex (C8) variables;

C8LIB, a MATLAB library which implements certain elementary functions for double precision complex (C8) variables;

C8LIB, a Python library which implements certain elementary functions for double precision complex (C8) variables;

CAESAR, a C library which can apply a Caesar Shift Cipher to a string of text.

CAESAR, a C++ library which can apply a Caesar Shift Cipher to a string of text.

CAESAR, a FORTRAN90 library which can apply a Caesar Shift Cipher to a string of text.

CAESAR, a MATLAB library which can apply a Caesar Shift Cipher to a string of text.

CAESAR, a Python library which can apply a Caesar Shift Cipher to a string of text.

CAFFE, examples which illustrate the use of CAFFE, which is a deep learning framework, a set of libraries and utitlies that enable the construction of deep learning programs.

CALENDAR_NYT, a FORTRAN90 library which shows the correspondence between dates and the New York Times volume and issue number;

CALENDAR_NYT, a MATLAB library which shows the correspondence between dates and the New York Times volume and issue number;

CALENDAR_RD, a C++ program which computes the representation of a given date in a number of calendrical systems, by Edward Reingold, Nachum Dershowitz.

CALPAK, a C library which makes various calendar calculations;

CALPAK, a C++ library which makes various calendar calculations;

CALPAK, a FORTRAN90 library which makes various calendar calculations;

CALPAK, a MATLAB library which makes various calendar calculations;

CALPAK, a Python library which makes various calendar calculations;

CASE1_FLOW, a dataset directory which 401 solutions of a flow problem in a channel governed by the Navier Stokes equations (NSE);

CATALOG, a C++ program which reads a C, C++, FORTRAN77 or FORTRAN90 program and prints every line that begins with a special index tag. If the program has been marked up expecting this convention, it is a handy way of making a table of contents of a program file.

CAUCHY_PRINCIPAL_VALUE, a C library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.

CAUCHY_PRINCIPAL_VALUE, a C++ library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.

CAUCHY_PRINCIPAL_VALUE, a FORTRAN77 library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.

CAUCHY_PRINCIPAL_VALUE, a FORTRAN90 library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.

CAUCHY_PRINCIPAL_VALUE, a MATLAB library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.

CAUCHY_PRINCIPAL_VALUE, a Python library which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.

CAUSTIC_OPENGL, a C++ program which computes a caustic curve in 2D and displays it using OpenGL.

CAVITY_FLOW, a dataset directory which contains 500 time steps of flow governed by the Navier-Stokes Equations (NSE) in a driven cavity;

CAVITY_FLOW_DISPLAY, a MATLAB program which displays a single velocity field solution for the driven cavity;

CAVITY_FLOW_MOVIE, a MATLAB program which animates the velocity solutions for the driven cavity;

cblas_test, a C program which illustrates the use of the CBLAS, a C translation of the FORTRAN77 Basic Linear Algebra Subprograms (BLAS) which are used by the C translation of the FORTRAN77 LAPACK linear algebra library.

cblas_test, a C++ program which illustrates the use of the CBLAS, a C translation of the FORTRAN77 Basic Linear Algebra Subprograms (BLAS) which are used by the C translation of the FORTRAN77 LAPACK linear algebra library.

CC, a data directory which contains instances of the Compressed Column (CC) sparse matrix file format;

CC_DISPLAY, a MATLAB program which displays the points used in a 2D Clenshaw-Curtis quadrature rule;

CC_IO, a C library which reads and writes sparse linear systems stored in the Compressed Column (CC) format.

CC_IO, a C++ library which reads and writes sparse linear systems stored in the Compressed Column (CC) format.

CC_IO, a FORTRAN77 library which reads and writes sparse linear systems stored in the Compressed Column (CC) format.

CC_IO, a FORTRAN90 library which reads and writes sparse linear systems stored in the Compressed Column (CC) format.

CC_IO, a MATLAB library which reads and writes sparse linear systems stored in the Compressed Column (CC) format.

CC_PROJECT, a MATLAB library which investigates generalized Clenshaw-Curtis quadrature rules for semi-infinite and infinite intervals, by John Boyd.

CC_TO_ST, a C library which converts a sparse matrix from compressed column (CC) to sparse triplet (ST) format.

CC_TO_ST, a C++ library which converts a sparse matrix from compressed column (CC) to sparse triplet (ST) format.

CC_TO_ST, a FORTRAN77 library which converts a sparse matrix from compressed column (CC) to sparse triplet (ST) format.

CC_TO_ST, a FORTRAN90 library which converts a sparse matrix from compressed column (CC) to sparse triplet (ST) format.

CC_TO_ST, a MATLAB library which converts a sparse matrix from compressed column (CC) to sparse triplet (ST) format.

CCL, a MATLAB program which estimates the Lebesgue constants for sets of points in [-1,+1] computed in several ways. The program is probably of limited interest except as an example of an application of the lebesgue_constant() function.

CCN_RULE, a C program which defines one of a set of Clenshaw Curtis Nested (CCN) quadrature rules of any order.

CCN_RULE, a C++ program which defines one of a set of Clenshaw Curtis Nested (CCN) quadrature rules of any order.

CCN_RULE, a FORTRAN77 program which defines one of a set of Clenshaw Curtis Nested (CCN) quadrature rules of any order.

CCN_RULE, a FORTRAN90 program which defines one of a set of Clenshaw Curtis Nested (CCN) quadrature rules of any order.

CCN_RULE, a MATLAB program which defines one of a set of Clenshaw Curtis Nested (CCN) quadrature rules of any order..

CCVT_BOX, a C++ program which calculates a Constrained Centroidal Voronoi Tessellation (CCVT) constrained to a box region, with points projected to the boundary;

CCVT_BOX, a FORTRAN90 program which calculates a Constrained Centroidal Voronoi Tessellation (CCVT) constrained to a box region, with points projected to the boundary;

CCVT_BOX, a MATLAB program which calculates a Constrained Centroidal Voronoi Tessellation (CCVT) constrained to a box region, with points projected to the boundary;

CCVT_REFLECT, a FORTRAN90 program which carries out a Constrained Centroidal Voronoi Tessellation (CCVT) calculation that tries to include points on the boundary as well as the interior, using a natural nonparametric technique;

CCVT_REFLECT, a MATLAB program which carries out a Constrained Centroidal Voronoi Tessellation (CCVT) calculation that tries to include points on the boundary as well as the interior, using a natural nonparametric technique;

CDDLIB, examples which illustrate the use of CDDLIB, which is a library for interpreting the description of a polygon, polyhedron, or polytope in higher dimensions, and determining various properties, including representation, adjacency, projection, and linear programming.

CDFLIB, a C library which evaluates the cumulative density function (CDF), inverse CDF, and certain other inverse functions, for distributions including beta, binomial, chi-square, noncentral chi-square, F, noncentral F, gamma, negative binomial, normal, Poisson, and students T, by Barry Brown, James Lovato, Kathy Russell.

CDFLIB, a C++ library which evaluates the cumulative density function (CDF), inverse CDF, and certain other inverse functions, for distributions including beta, binomial, chi-square, noncentral chi-square, F, noncentral F, gamma, negative binomial, normal, Poisson, and students T, by Barry Brown, James Lovato, Kathy Russell.

CDFLIB, a FORTRAN90 library which evaluates the cumulative density function (CDF), inverse CDF, and certain other inverse functions, for distributions including beta, binomial, chi-square, noncentral chi-square, F, noncentral F, gamma, negative binomial, normal, Poisson, and students T, by Barry Brown, James Lovato, Kathy Russell.

CDL, a data directory which contains CDL files, a text version of netcdf files created by the ncdump program;

CELL, a C library which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.

CELL, a C++ library which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.

CELL, a FORTRAN77 library which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.

CELL, a FORTRAN90 library which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.

CELL, a MATLAB library which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.

CELL_DETECTION_TASKS, a MATLAB program which creates modified versions of a sequence of gray-scale tagged image files (TIF's) containing images of cells; the processing of each file is carried out independently, using the task feature of MATLAB's parallel computing toolbox.

CELLULAR_AUTOMATON, a C program which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.

CELLULAR_AUTOMATON, a C++ program which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.

CELLULAR_AUTOMATON, a FORTRAN77 program which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.

CELLULAR_AUTOMATON, a FORTRAN90 program which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.

CELLULAR_AUTOMATON, a MATLAB program which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.

CENSUS, a dataset directory which contains US census data;

CENTRALIZE, a MATLAB library which estimates the centroid and radius of a shape, or a set of N data points, in a space of dimension M.

CFD_BARBA, a Python library which contains plain Python scripts of some of the iPython workbooks associated with the "12 Steps to Navier-Stokes" presentation by Lorena Barba.

CG, a C library which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite (only real, positive eigenvalues) and symmetric.

CG, a C++ library which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite (only real, positive eigenvalues) and symmetric.

CG, a FORTRAN77 library which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite (only real, positive eigenvalues) and symmetric.

CG, a FORTRAN90 library which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite (only real, positive eigenvalues) and symmetric.

CG, a MATLAB library which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite (only real, positive eigenvalues) and symmetric.

CG, a Python library which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite (only real, positive eigenvalues) and symmetric.

CG_DISTRIBUTED, a MATLAB program which implements a version of the Conjugate Gradient (CG) NAS Parallel Benchmark using distributed memory.

CG_LAB_TRIANGLES, MATLAB programs associated with a computer lab assignment on computational geometry and triangles;

CG_PLUS, a FORTRAN77 library which implements the conjugate gradient (CG) method for minimizing a scalar function of multiple variables.

CG_RC, a C library which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).

CG_RC, a C++ library which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).

CG_RC, a FORTRAN77 library which implements the conjugate gradient (CG) method for solvireversng a positive definite sparse linear system A*x=b, using reverse communication (RC).

CG_RC, a FORTRAN90 library which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).

CG_RC, a MATLAB library which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).

CG_RC, a Python library which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).

CGAL, examples which illustrate the use of CGAL, which is the computational geometry algorithms library, a C++ library that provides efficient, reliable implementations of geometric algorithms.

CHAIN_LETTER_TREE, a MATLAB program which analyzes a similarity matrix for 11 versions of a single chain letter and produces a dendrogram or tree diagram that suggests the degrees of relatedness and the evolutionary history of the letters.

CHAIN_LETTERS, a dataset directory which contains chain letters.

CHANGE_MAKING, a C library which considers the change making problem, in which a given sum is to be formed using coins of various denominations.

CHANGE_MAKING, a C++ library which considers the change making problem, in which a given sum is to be formed using coins of various denominations.

CHANGE_MAKING, a FORTRAN77 library which considers the change making problem, in which a given sum is to be formed using coins of various denominations.

CHANGE_MAKING, a FORTRAN90 library which considers the change making problem, in which a given sum is to be formed using coins of various denominations.

CHANGE_MAKING, a MATLAB library which considers the change making problem, in which a given sum is to be formed using coins of various denominations.

CHANGE_MAKING, a dataset directory which contains test data for the change making problem;

CHEBYSHEV, a C library which computes the Chebyshev interpolant/approximant to a given function over an interval.

CHEBYSHEV, a C++ library which computes the Chebyshev interpolant/approximant to a given function over an interval.

CHEBYSHEV, a FORTRAN77 library which computes the Chebyshev interpolant/approximant to a given function over an interval.

CHEBYSHEV, a FORTRAN90 library which computes the Chebyshev interpolant/approximant to a given function over an interval.

CHEBYSHEV, a MATLAB library which computes the Chebyshev interpolant/approximant to a given function over an interval.

CHEBYSHEV_INTERP_1D, a C library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).

CHEBYSHEV_INTERP_1D, a C++ library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).

CHEBYSHEV_INTERP_1D, a FORTRAN77 library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).

CHEBYSHEV_INTERP_1D, a FORTRAN90 library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).

CHEBYSHEV_INTERP_1D, a MATLAB library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).

CHEBYSHEV_INTERP_1D, a Python library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).

CHEBYSHEV_POLYNOMIAL, a C library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.

CHEBYSHEV_POLYNOMIAL, a C++ library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.

CHEBYSHEV_POLYNOMIAL, a FORTRAN77 library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.

CHEBYSHEV_POLYNOMIAL, a FORTRAN90 library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.

CHEBYSHEV_POLYNOMIAL, a MATLAB library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.

CHEBYSHEV_POLYNOMIAL, a Python library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.

CHEBYSHEV_SERIES, a C library which can evaluate a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.

CHEBYSHEV_SERIES, a C++ library which can evaluate a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.

CHEBYSHEV_SERIES, a FORTRAN77 library which can evaluate a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.

CHEBYSHEV_SERIES, a FORTRAN90 library which can evaluate a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.

CHEBYSHEV_SERIES, a MATLAB library which can evaluate a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.

CHEBYSHEV1_RULE, a C++ program which can compute and print a Gauss-Chebyshev type 1 quadrature rule.

CHEBYSHEV1_RULE, a FORTRAN90 program which computes and prints a Gauss-Chebyshev type 1 quadrature rule.

CHEBYSHEV1_RULE, a MATLAB program which computes and prints a Gauss-Chebyshev type 1 quadrature rule.

CHEBYSHEV2_RULE, a C++ program which computes and prints a Gauss-Chebyshev type 2 quadrature rule.

CHEBYSHEV2_RULE, a FORTRAN90 program which computes and prints a Gauss-Chebyshev type 2 quadrature rule.

CHEBYSHEV2_RULE, a MATLAB program which compute and print a Gauss-Chebyshev type 2 quadrature rule.

CHRISPELL_FREEFEM++ examples which are associated with a FreeFem++ presentation by John Chrispell and Jason Howell.

CHRPAK, a C library which works with characters and strings.

CHRPAK, a C++ library which works with characters and strings.

CHRPAK, a FORTRAN77 library which works with characters and strings.

CHRPAK, a FORTRAN90 library which works with characters and strings.

CHRPAK, a MATLAB library which works with characters and strings.

CHRPAK, a Python library which works with characters and strings.

CIRCLE_ARC_GRID, a C program which computes a grid of points over the length of a circle or circular arc in 2D.

CIRCLE_ARC_GRID, a C++ program which computes a grid of points computes a grid of points over the length of a circle or circular arc in 2D.

CIRCLE_ARC_GRID, a FORTRAN77 program which computes a grid of points over the length of a circle or circular arc in 2D.

CIRCLE_ARC_GRID, a FORTRAN90 program which computes a grid of points over the length of a circle or circular arc in 2D.

CIRCLE_ARC_GRID, a MATLAB program which computes a grid of points over the length of a circle or circular arc in 2D.

CIRCLE_ARC_GRID, a Python program which computes a grid of points over the length of a circle or circular arc in 2D.

circle_distance, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected on the unit circle.

CIRCLE_GRID_DISPLAY, a MATLAB program which reads a matrix of integers, and draws a corresponding grid of circles filled with color.

CIRCLE_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.

CIRCLE_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.

CIRCLE_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.

CIRCLE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.

CIRCLE_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.

CIRCLE_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.

CIRCLE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function on the circumference of the unit circle in 2D.

CIRCLE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function on the circumference of the unit circle in 2D.

CIRCLE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function on the circumference of the unit circle in 2D;

CIRCLE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function on the circumference of the unit circle in 2D;

CIRCLE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function on the circumference of the unit circle in 2D;

CIRCLE_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function on the circumference of the unit circle in 2D;

CIRCLE_RULE, a C library which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).

CIRCLE_RULE, a C++ library which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).

CIRCLE_RULE, a FORTRAN77 library which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).

CIRCLE_RULE, a FORTRAN90 library which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).

CIRCLE_RULE, a MATLAB library which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).

CIRCLE_SEGMENT, a C library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature, creating some graphics plots using gnuplot.

CIRCLE_SEGMENT, a C++ library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature, creating some graphics plots using gnuplot.

CIRCLE_SEGMENT, a FORTRAN77 library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature, creating some graphics plots using gnuplot.

CIRCLE_SEGMENT, a FORTRAN90 library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature, creating some graphics plots using gnuplot.

CIRCLE_SEGMENT, a MATLAB library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.

CIRCLE_TEST, a FORTRAN90 program which performs a circle-spacing test on sets of points;

CIRCLES, a MATLAB library which can be used, when creating graphics, to draw one or more circles, while controlling the center locations, radii, colors, edge colors, and transparency, by Chad Greene.

CITCOMS, examples which illustrate the use of CITCOMS, which is a finite element code which solves compressible thermochemical convection problems posed in the Earth's mantel. The program can focus on a single region or a global solution.

CITIES, a dataset directory which contains sets of information about cities and the distances between them;

CITIES, a C++ library which handles various problems associated with a set of cities on a map.

CITIES, a FORTRAN90 library which handles various problems associated with a set of cities on a map.

CITIES, a MATLAB library which handles various problems associated with a set of cities on a map.

clapack_test, C programs which illustrate the use of the CLAPACK library, a C translation of the FORTRAN77 BLAS and LAPACK linear algebra libraries, including single and double precision, real and complex arithmetic.

clapack_test, C++ programs which illustrate the use of the CLAPACK library, a C translation of the FORTRAN77 BLAS and LAPACK linear algebra libraries, including single and double precision, real and complex arithmetic.

CLAPACK, examples which illustrate the use of the CLAPACK library, a C translation of the FORTRAN77 BLAS and LAPACK linear algebra libraries, including single and double precision, real and complex arithmetic.

CLAUSEN, a C library which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).

CLAUSEN, a C++ library which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).

CLAUSEN, a FORTRAN90 library which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).

CLAUSEN, a MATLAB library which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).

CLAUSEN, a Python library which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).

CLEAN77, a FORTRAN77 program which can reformat a FORTRAN77 file, using some standard indenting and numbering conventions.

CLEBSCH_GORDAN, a FORTRAN77 library which evaluates Clebsch-Gordan coefficients involved in angular momentum coupling in quantum mechanics;

CLENSHAW_CURTIS_RULE, a C program which defines a Clenshaw Curtis quadrature rule.

CLENSHAW_CURTIS_RULE, a C++ program which defines a Clenshaw Curtis quadrature rule.

CLENSHAW_CURTIS_RULE, a FORTRAN77 program which defines a Clenshaw Curtis quadrature rule.

CLENSHAW_CURTIS_RULE, a FORTRAN90 program which defines a Clenshaw Curtis quadrature rule.

CLENSHAW_CURTIS_RULE, a MATLAB program which defines a Clenshaw Curtis quadrature rule.

CLUSTER_ENERGY, a FORTRAN90 program which groups data into a given number of clusters to minimize the energy.

CMAKE, examples which illustrate the use of CMAKE.

CNF, a data directory which contain CNF files, used to define satisfiability problems in conjunctive normal form (CNF);

CNF_IO, a C++ library which reads or writes files used to store boolean formulas in conjunctive normal form (CNF).

CNF_IO, a FORTRAN77 library which reads or writes files used to store boolean formulas in conjunctive normal form (CNF).

CNF_IO, a FORTRAN90 library which reads or writes files used to store boolean formulas in conjunctive normal form (CNF).

CNOISE, a C library which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.

CNOISE, a MATLAB library which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.

CODEPACK, a FORTRAN90 library which computes codes that can determine if two graphs are isomorphic.

COIN_SIMULATION, a MATLAB library which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.

COLLATZ, a MATHEMATICA program which reads an integer from the user and computes the Collatz sequence based on that integer.

COLLATZ, a MATLAB library which computes and analyzes the Collatz sequence (or hailstone sequence or 3n+1 sequence);

COLLATZ_PARFOR, a MATLAB program which seeks the maximum Collatz sequence between 1 and N, running in parallel using MATLAB's parfor feature.

COLLATZ_RECURSIVE, a C library which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.

COLLATZ_RECURSIVE, a C++ library which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.

COLLATZ_RECURSIVE, a FORTRAN90 library which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.

COLLATZ_RECURSIVE, a MATLAB library which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.

COLLATZ_RECURSIVE, a Python library which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.

COLLOCATION, a MATLAB library which demonstrates some simple examples of the use of collocation to produce a function g(x) that satisfies the same constraints as a function f(x), but only at a discrete set of points.

COLNEW, a FORTRAN77 library which solves a boundary value problem (BVP), a mixed-order system of ordinary differential equations (ODE's) subject to separated, multipoint boundary conditions, using collocation at Gaussian points, by Uri Ascher and Georg Bader.

COLOR, a dataset directory which describes colors by name, triples of integers between 0 and 255, or triples of real numbers between 0 and 1.

COLOR_REMOTE, a MATLAB program which carries out the color segmentation of an image in parallel, via Single Program Multiple Data (SPMD) commands; this includes instructions on how to run the job, via MATLAB's batch facility, on a remote system such as Virginia Tech's Ithaca cluster.

COLORED_NOISE, a C library which generates samples of noise obeying a 1/f^alpha power law.

COLORED_NOISE, a C++ library which generates samples of noise obeying a 1/f^alpha power law.

COLORED_NOISE, a FORTRAN77 library which generates samples of noise obeying a 1/f^alpha power law.

COLORED_NOISE, a FORTRAN90 library which generates samples of noise obeying a 1/f^alpha power law.

COLORED_NOISE, a MATLAB library which generates samples of noise obeying a 1/f^alpha power law.

COLORS, a FORTRAN90 library which converts between various formats for describing colors;

COMBINATION_LOCK, a C program which simulates the process of determining the secret combination of a lock.

COMBINATION_LOCK, a C++ program which simulates the process of determining the secret combination of a lock.

COMBINATION_LOCK, a FORTRAN77 program which simulates the process of determining the secret combination of a lock.

COMBINATION_LOCK, a FORTRAN90 program which simulates the process of determining the secret combination of a lock.

COMBINATION_LOCK, a MATLAB program which simulates the process of determining the secret combination of a lock.

COMBINATION_LOCK, a Python program which simulates the process of determining the secret combination of a lock.

COMBO, a C library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.

COMBO, a C++ library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.

COMBO, a F77 library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.

COMBO, a FORTRAN90 library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.

COMBO, a MATLAB library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.

COMBO, a Python library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.

COMMUNICATOR_MPI, a C program which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.

COMMUNICATOR_MPI, a C++ program which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.

COMMUNICATOR_MPI, a FORTRAN77 program which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.

COMMUNICATOR_MPI, a FORTRAN90 program which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.

COMPASS_SEARCH, a C library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.

COMPASS_SEARCH, a C++ library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.

COMPASS_SEARCH, a FORTRAN77 library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.

COMPASS_SEARCH, a FORTRAN90 library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.

COMPASS_SEARCH, a MATLAB library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.

COMPASS_SEARCH, a Python library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.

COMPLEX_NUMBERS, a C program which demonstrates some simple features involved in the use of complex numbers.

COMPLEX_NUMBERS, a C++ program which demonstrates some simple features involved in the use of complex numbers.

COMPLEX_NUMBERS, a FORTRAN77 program which demonstrates some simple features involved in the use of complex numbers.

COMPLEX_NUMBERS, a FORTRAN90 program which demonstrates some simple features involved in the use of complex numbers.

COMPLEX_NUMBERS, a MATLAB program which demonstrates some simple features involved in the use of complex numbers.

COMPLEX_NUMBERS, a Python program which demonstrates some simple features involved in the use of complex numbers.

COMPLEXITY, MATLAB programs which measure the complexity of a few simple algorithms with increasing problem size.

COMSOL, examples which illustrate the use of COMSOL, which is a software platform that enables the interactive modeling of a variety of physics-based problems, and their solution using advanced numerical methods.

CONDITION, a C library which implements methods of computing or estimating the condition number of a matrix.

CONDITION, a C++ library which implements methods of computing or estimating the condition number of a matrix.

CONDITION, a FORTRAN77 library which implements methods of computing or estimating the condition number of a matrix.

CONDITION, a FORTRAN90 library which implements methods of computing or estimating the condition number of a matrix.

CONDITION, a MATLAB library which implements methods of computing or estimating the condition number of a matrix.

CONDITION, a Python library which implements methods of computing or estimating the condition number of a matrix.

CONDOR, examples which illustrate the use of the CONDOR queueing system to submit jobs that run on a one or more remote machines.

CONTINUATION, a MATLAB library which implements the continuation method for a simple 2D problem, which involves finding a point on the unit circle, and then finding a sequence of nearby points which trace out the full curve, using only the information available in the implicit definition of the curve from the function f(x,y)=x^2+y^2-1.

CONTINUED_FRACTION, a C library which implements some algorithms for dealing with simple and generalized continued fractions.

CONTINUED_FRACTION, a C++ library which implements some algorithms for dealing with simple and generalized continued fractions.

CONTINUED_FRACTION, a FORTRAN90 library which implements some algorithms for dealing with simple and generalized continued fractions.

CONTINUED_FRACTION, a MATLAB library which implements some algorithms for dealing with simple and generalized continued fractions.

CONTINUED_FRACTION, a Python library which implements some algorithms for dealing with simple and generalized continued fractions.

CONTOUR_GRADIENT, a MATLAB program which displays contours and gradient vectors for a function f(x,y).

CONTOUR_GRADIENT_3D, a MATLAB program which shows how contours and gradient vectors for a function f(x,y) can be displayed in a 3D plot.

CONTOUR_SEQUENCE4, a MATLAB program which makes a sequence of contour plots based on a single XY coordinate file, and a sequence of Z(X,Y) data files.

CONTRAST_SPMD, a MATLAB program which demonstrates the Single Program Multiple Data (SPMD) parallel programming feature for image operations; the client reads an image, the workers increase contrast over separate portions, and the client assembles and displays the results.

CONTRAST2_SPMD, a MATLAB program which demonstrates the Single Program Multiple Data (SPMD) parallel programming feature for image operations; this improves the contrast_spmd program by allowing the workers to share some data; this makes it possible to eliminate artificial seams in the processed image.

convection_diffusion, a FENICS script which simulates a 1D convection diffusion problem.

convection_diffusion_stabilized, a FENICS script which simulates a 1D convection diffusion problem, using a stabilization scheme.

convex_hull, a MATLAB program which demonstrates the computation of the convex hull of a set of 2D points.

CORA, examples which illustrate the use of CORA, which is a program for the analysis of correlation between time signals;

CORDIC, a C library which uses the CORDIC method to compute certain elementary functions.

CORDIC, a C++ library which uses the CORDIC method to compute certain elementary functions.

CORDIC, a FORTRAN77 library which uses the CORDIC method to compute certain elementary functions.

CORDIC, a FORTRAN90 library which uses the CORDIC method to compute certain elementary functions.

CORDIC, a MATLAB library which uses the CORDIC method to compute certain elementary functions.

CORDIC, a Python library which uses the CORDIC method to compute certain elementary functions.

CORRELATION, a C library which contains examples of statistical correlation functions.

CORRELATION, a C++ library which contains examples of statistical correlation functions.

CORRELATION, a FORTRAN77 library which contains examples of statistical correlation functions.

CORRELATION, a FORTRAN90 library which contains examples of statistical correlation functions.

CORRELATION, a MATLAB library which contains examples of statistical correlation functions.

CORRELATION_CHEBFUN, a MATLAB library which uses the chebfun library to compute truncated Karhunen-Loeve expansions of stochastic processes with a given correlation function.

COSINE_TRANSFORM, a C library which demonstrates some simple properties of the discrete cosine transform (DCT).

COSINE_TRANSFORM, a C++ library which demonstrates some simple properties of the discrete cosine transform (DCT).

COSINE_TRANSFORM, a FORTRAN90 library which demonstrates some simple properties of the discrete cosine transform (DCT).

COSINE_TRANSFORM, a MATLAB library which demonstrates some simple properties of the discrete cosine transform (DCT).

COSINE_TRANSFORM, a Python library which demonstrates some simple properties of the discrete cosine transform (DCT).

CPLEX, examples which illustrate the use of CPLEX, which is an executable program and a library for defining and solving a variety of linear programming problems, as well as network flow problems, quadratic programming problems, and mixed integer programming problems.

CPLEX_SOLUTION_READ, a MATLAB program which extracts solution data from a CPLEX result file; CPLEX can be "fed" by an LP file created by POLYOMINO_MONOHEDRAL_MATRIX or POLYOMINO_MULTIHEDRAL_MATRIX, and the results can be displayed by POLYOMINO_MONOHEDRAL_TILING_PRINT or POLYOMINO_MULTIHEDRAL_TILING_PRINT.

CPP, C++ programs which illustrate some features of the C++ language;

CPP_ARRAYS, C++ programs which illustrate the use of vectors, matrices and tensors.

CPP_FILES, C++ programs which illustrate the use of files.

CPP_INTRINSICS, a C++ program which illustrates the use of intrinsic functions.

CPP_RANDOM, C++ programs which illustrate the use of the C++ random number generator (RNG) functions.

CR, a data directory which contains examples of the Compressed Row (CR) sparse matrix file format;

CR2CRLF, a C++ program which reads a text file and replaces carriage returns by carriage returns + line feeds.

CR2LF, a C++ program which reads a text file and replaces carriage returns by line feeds.

CRC, a C++ library which computes the Cyclic Redundancy Checksum (CRC) as used by the Portable Network Graphics (PNG) format.

CRRM, a C++ program which reads a text file and removes the carriage return character.

CRYSTAL_COORDINATES, a FORTRAN90 program which generates a file of 3-dimensional point coordinates defining the locations of molecules in a face-centered cubic (FCC) crystal.

CSPARSE, a C library which carries out the direct solution of sparse linear systems, by Timothy Davis.

CSV, a data directory which contains examples of comma separated value (CSV) files;

CSV_IO, a FORTRAN90 library which reads and writes files that use the comma separated value (CSV) format.

CSV_IO, R examples which illustrate how to read or write data in the comma separated value (CSV) format.

CTANGLE, a C program which reads a CWEB file and creates the corresponding C source code file.

CUBPACK, a FORTRAN90 library which estimates the integral of a function over a collection of M-dimensional hyperrectangles and simplices, by Alan Genz and Ronald Cools.

CUBE_ARBQ_RULE, a C library which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.

CUBE_ARBQ_RULE, a C++ library which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.

CUBE_ARBQ_RULE, a FORTRAN77 library which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.

CUBE_ARBQ_RULE, a FORTRAN90 library which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.

CUBE_ARBQ_RULE, a MATLAB library which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.

CUBE_DISPLAY, a MATLAB program which displays a cube plot, over integer triples of data, of a function defined by two formulas.

CUBE_EXACTNESS, a C library which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.

CUBE_EXACTNESS, a C++ library which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.

CUBE_EXACTNESS, a FORTRAN77 library which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.

CUBE_EXACTNESS, a FORTRAN90 library which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.

CUBE_EXACTNESS, a MATLAB library which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.

CUBE_FELIPPA_RULE, a C library which returns the points and weights of a Felippa quadrature rule over the interior of a cube in 3D.

CUBE_FELIPPA_RULE, a C++ library which returns the points and weights of a Felippa quadrature rule over the interior of a cube in 3D.

CUBE_FELIPPA_RULE, a FORTRAN77 library which returns the points and weights of a Felippa quadrature rule over the interior of a cube in 3D.

CUBE_FELIPPA_RULE, a FORTRAN90 library which returns the points and weights of a Felippa quadrature rule over the interior of a cube in 3D.

CUBE_FELIPPA_RULE, a MATLAB library which returns the points and weights of a Felippa quadrature rule over the interior of a cube in 3D.

CUBE_GRID, a C library which computes a grid of points over the interior of a cube in 3D.

CUBE_GRID, a C++ library which computes a grid of points over the interior of a cube in 3D.

CUBE_GRID, a FORTRAN77 library which computes a grid of points over the interior of a cube in 3D.

CUBE_GRID, a FORTRAN90 library which computes a grid of points over the interior of a cube in 3D.

CUBE_GRID, a MATLAB library which computes a grid of points over the interior of a cube in 3D.

CUBE_GRID, a Python library which computes a grid of points over the interior of a cube in 3D.

CUBE_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.

CUBE_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.

CUBE_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.

CUBE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.

CUBE_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.

CUBE_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.

CUBE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.

CUBE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.

CUBE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D;

CUBE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D;

CUBE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D;

CUBE_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.

CUDA, examples which illustrate the use of CUDA, an extension to the C language which enables parallel programming on a Graphics Processing Unit (GPU);

CUDA_LOOP, a C library which shows how, in a CUDA program, the user's choice of block and thread factors determines the allocation of tasks to processors.

CUDA_LOOP, a C++ library which shows how, in a CUDA program, the user's choice of block and thread factors determines the allocation of tasks to processors.

CUDA_LOOP, a FORTRAN90 library which shows how, in a CUDA program, the user's choice of block and thread factors determines the allocation of tasks to processors.

CUDA_LOOP, a MATLAB library which shows how, in a CUDA program, the user's choice of block and thread factors determines the allocation of tasks to processors.

CUDA_LOOP, a Python library which shows how, in a CUDA program, the user's choice of block and thread factors determines the allocation of tasks to processors.

CUFFLINKS, examples which illustrate the use of CUFFLINKS, which is a set of tools for analysis of RNA-Seq data, including a program for producing transcripts.

CVT, a dataset directory which contains examples of a Centroidal Voronoi Tessellation (CVT);

CVT, a C++ library which computes elements of a Centroidal Voronoi Tessellation (CVT).

CVT, a FORTRAN90 library which computes elements of a Centroidal Voronoi Tessellation (CVT).

CVT, a MATLAB library which computes elements of a Centroidal Voronoi Tessellation (CVT).

CVT_1D_LLOYD, a MATLAB program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using Lloyd's method to compute the Voronoi regions exactly.

CVT_1D_LLOYD, a Python program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using Lloyd's method to compute the Voronoi regions exactly.

CVT_1D_LUMPING, a MATLAB program which allows the user to carry out a lumped version of Lloyd's iterative algorithm for a centroidal Voronoi Tessellation (CVT() in the interval [-1,+1], and is applied to investigate a relationship between CVT's and the Chebyshev Zero nodes.

CVT_1D_NONUNIFORM, a MATLAB program which computes an N-point Centroidal Voronoi Tessellation (CVT) in 1 dimension, under a nonuniform density, and plots the evolution of the locations of the generators during the iteration;

CVT_1D_SAMPLING, a MATLAB program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using sampling to estimate the Voronoi regions.

CVT_2D_LUMPING_, a MATLAB program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [-1,1]^2, under a Chebyshev density, using weighted sampling ("lumping") to estimate the Voronoi regions.

CVT_2D_SAMPLING, a MATLAB program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [0,1]x[0,1], under a uniform density, using sampling to estimate the Voronoi regions.

CVT_2D_SAMPLING, a Python program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit square [0,1]x[0,1], under a uniform density, using sampling to estimate the Voronoi regions.

CVT_3D_LUMPING_, a MATLAB program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [-1,1]^3, under a Chebyshev density, using weighted sampling ("lumping") to estimate the Voronoi regions.

CVT_3D_SAMPLING, a MATLAB program which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [0,1]x[0,1]x[0,1], under a uniform density, using sampling to estimate the Voronoi regions.

CVT_BASIS, a FORTRAN90 program which uses discrete Centroidal Voronoi Tessellation (CVT) techniques to produce a small set of basis vectors that are good cluster centers for a large set of data vectors;

CVT_BASIS_FLOW, a FORTRAN90 program which extracts dominant solution modes from a set of solutions of a flow problem governed by the Navier Stokes Equations (NSE) using Centroidal Voronoi Tessellation (CVT) methods.

CVT_CIRCLE_NONUNIFORM, a MATLAB program which calculates a Centroidal Voronoi Tessellation (CVT) over a circle with nonuniform density.

CVT_CIRCLE_UNIFORM, a MATLAB program which calculates a Centroidal Voronoi Tessellation (CVT) over a circle with uniform density.

CVT_CORN, a MATLAB program which studies a 2D model of the growth of a corn kernel, by treating the surface and interior biological cells as points to be organized by a Centroidal Voronoi Tessellation (CVT) with a nonuniform density; during a sequence of growth steps, new biological cells are randomly added to the surface and interior.

CVT_DATASET, a C++ program which computes a Centroidal Voronoi Tessellation (CVT) and writes it to a file.

CVT_DATASET, a FORTRAN90 program which computes a Centroidal Voronoi Tessellation (CVT) and writes it to a file.

CVT_DATASET, a MATLAB program which computes a Centroidal Voronoi Tessellation (CVT) and writes it to a file.

CVT_ELLIPSE_UNIFORM, a MATLAB program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over an ellipse, with a uniform density.

CVT_EXAMPLE_FIFTY_POINTS, a MATLAB program which illustrates the steps involved in the calculation of a Centroidal Voronoi Tessellation (CVT) of the unit square, with 50 generator points.

CVT_EXAMPLE_FIVE_POINTS, a MATLAB program which illustrates the steps involved in the calculation of a Centroidal Voronoi Tessellation (CVT) of the unit square, with 5 generator points.

CVT_FIXED, a FORTRAN90 library which computes a Centroidal Voronoi Tessellation (CVT), built on top of the cvt_size program, which allows the user to fix the location of some generators;

CVT_FIXED2, a FORTRAN90 library which implements a version of the Centroidal Voronoi Tessellation (CVT) algorithm which allows the user to fix some points;

CVT_METRIC, a MATLAB program which computes a Centroidal Voronoi Tessellation (CVT) under a spatially varying metric;

CVT_MOVIE, a MATLAB program which creates an animation of the evolution of a Centroidal Voronoi Tessellation (CVT);

CVT_MOVIE2, a MATLAB program which creates a Centroidal Voronoi Tessellation (CVT) movie;

CVT_MOVIE3, a MATLAB program which creates a Centroidal Voronoi Tessellation (CVT) movie in a region of unusual shape;

CVT_MOVIE4, a MATLAB program which creates a Centroidal Voronoi Tessellation (CVT) movie in a square, with a density function that drives points to the corners;

CVT_MOVIE5, a MATLAB program which repeats cvt_movie3, but with hexagonal grid initialization, fixed points, and boundary projection;

CVT_MOVIE5_DATA, a FORTRAN90 program which creates and saves data of a Centroidal Voronoi Tessellation (CVT) iteration, for use in a movie;

CVT_REFINE, a FORTRAN90 library which investigates how to refine a Centroidal Voronoi Tessellation (CVT) by fixing the current points and adding new ones;

CVT_SIZE, a FORTRAN90 library which controls Centroidal Voronoi Tessellation (CVT) cell sizes by specifying a weight function associated with each cell;

CVT_SQUARE_NONUNIFORM, a MATLAB program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a nonuniform density.

CVT_SQUARE_PDF_DISCRETE, a MATLAB program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a density derived from a discrete PDF.

CVT_SQUARE_UNIFORM, a MATLAB program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a uniform density.

CVT_TET_MESH, a FORTRAN90 program which constructs a Centroidal Voronoi Tessellation (CVT) for a region specified by the TEST_TET_MESH library;

CVT_TRIANGLE_UNIFORM, a MATLAB program which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a triangle, with a uniform density.

CVT_TRIANGULATION, a FORTRAN90 program which constructs a Centroidal Voronoi Tessellation (CVT) triangulation for certain regions from the test_triangulation() set of examples.

CVT_WEIGHT, a FORTRAN90 library which tried to control Centroidal Voronoi Tessellation (CVT) cell sizes by specifying a weight function associated with each cell;

CVTM_1D, a MATLAB program which estimates a mirror-periodic centroidal Voronoi Tessellation (CVTM) in the periodic interval [0,1], using a version of Lloyd's iteration.

CVTP, a dataset directory which contains examples of CVTP's, that is, Centroidal Voronoi Tessellations on a periodic domain.

CVTP, a FORTRAN90 library which creates a CVTP, that is, a Centroidal Voronoi Tessellation on a periodic domain.

CVTP, a MATLAB library which creates a CVTP, that is, a Centroidal Voronoi Tessellation on a periodic domain.

CVTP_1D, a MATLAB program which estimates a periodic centroidal Voronoi Tessellation (CVTP) in the periodic interval [0,1], using a version of Lloyd's iteration.

CWEAVE, a C program which reads a CWEB file and creates the corresponding TeX documentation file.

CWG_ODE, a FORTRAN77 library which contains three solvers for a system of ordinary differential equations (ODE's), by William Gear.

CYCLE_BRENT, a C library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.

CYCLE_BRENT, a C++ library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.

CYCLE_BRENT, a FORTRAN77 library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.

CYCLE_BRENT, a FORTRAN90 library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.

CYCLE_BRENT, a MATLAB library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.

CYCLE_BRENT, a Python library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.

CYCLE_FLOYD, a C library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.

CYCLE_FLOYD, a C++ library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.

CYCLE_FLOYD, a FORTRAN77 library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.

CYCLE_FLOYD, a FORTRAN90 library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.

CYCLE_FLOYD, a MATLAB library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.

CYCLE_FLOYD, a Python library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.

CYCLIC_REDUCTION, a C library which solves a tridiagonal linear system using cyclic reduction.

CYCLIC_REDUCTION, a C++ library which solves a tridiagonal linear system using cyclic reduction.

CYCLIC_REDUCTION, a FORTRAN77 library which solves a tridiagonal linear system using cyclic reduction.

CYCLIC_REDUCTION, a FORTRAN90 library which solves a tridiagonal linear system using cyclic reduction.

CYCLIC_REDUCTION, a MATLAB library which solves a tridiagonal linear system using cyclic reduction.

DATES, a dataset directory which contains lists of dates in various calendar systems.

DBEM, a FORTRAN77 program which uses the direct boundary element method (BEM) to analyze a problem in 2D elastic stress, by Prasanta Banerjee, Roy Butterfield.

DEALII, examples which illustrate the use of DEAL.II, a finite element method (FEM) Differential Equations Analysis Library (DEAL), for the definition and solution of partial differential equations (PDE's), by Wolfgang Bangerth and others.

DEALII_OSX, examples which illustrate the use of DEAL.II on a Macintosh running the OSX operating system, a finite element method (FEM) Differential Equations Analysis Library (DEAL), for the definition and solution of partial differential equations (PDE's), by Wolfgang Bangerth and others.

DEALII_RCC, examples which illustrate the use of DEAL.II, a finite element method (FEM) Differential Equations Analysis Library (DEAL), for the definition and solution of partial differential equations (PDE's), by Wolfgang Bangerth and others, on the FSU Research Computing Center (RCC) cluster.

deblank, a C++ program which reads a text file and writes a copy which has no blank lines.

decomment, a C++ program which makes a copy of a text file which contains no comment lines (that begin with "#").

delaunay_lmap_2d, a FORTRAN90 program which computes the Delaunay triangulation of points in the plane subject to a linear mapping.

delaunay_test, a Python program which demonstrates the use of the scipy.spatial function Delaunay(), to compute a Voronoi diagram, and matplotlib.pyplot.triplot(), to display it.

delaunay_tree_2d, a C++ program which computes the Delaunay triangulation of a 2D dataset, by Olivier Devillers.

detroff, a C++ program which removes from a file every occurrence of the TROFF overprint pair character+backspace, which can make a MAN page printable;

DG1D_ADVECTION, a MATLAB library which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the advection Equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.

DG1D_BURGERS, a MATLAB library which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D Burgers Equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.

DG1D_HEAT, a MATLAB library which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D heat Equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.

DG1D_MAXWELL, a MATLAB library which uses the Discontinuous Galerkin Method (DG) to approximate a solution of Maxwell's equations. The original version of the code was written by Jan Hesthaven and Tim Warburton.

DG1D_POISSON, a MATLAB program which applies the discontinuous Galerkin method (DG) to a 1D version of the Poisson equation, by Beatrice Riviere.

DG1D_POISSON, a Python program which applies the discontinuous Galerkin method (DG) to a 1D version of the Poisson equation, based on a MATLAB code by Beatrice Riviere, as modified by Alex Lindsay.

DIAPHONY, a C program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.

DIAPHONY, a C++ program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.

DIAPHONY, a FORTRAN77 program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.

DIAPHONY, a FORTRAN90 program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.

DIAPHONY, a MATLAB program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.

DICE_SIMULATION, a MATLAB program which simulates N tosses of M dice, making a histogram of the results.

DICTIONARY_CODE, a MATLAB library which demonstrates how a text file can be compressed and decompressed using a dictionary code.

DIFFER, a C library which determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.

DIFFER, a C++ library which determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.

DIFFER, a FORTRAN77 library which determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.

DIFFER, a FORTRAN90 library which determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.

DIFFER, a MATLAB library which determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.

DIGITAL_DICE, a MATLAB library which contains the scripts used to carry out the probability simulations described in Paul Nahin's "Digital Dice";

DIJKSTRA, a C library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA, a C++ library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA, a FORTRAN77 library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA, a FORTRAN90 library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA, a MATLAB library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA, a Python library which implements a simple version of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA_OPENMP, a C program which uses OpenMP to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA_OPENMP, a C++ program which uses OpenMP to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA_OPENMP, a FORTRAN77 program which uses OpenMP to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA_OPENMP, a FORTRAN90 program which uses OpenMP to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.

DIJKSTRA_SPMD, a MATLAB program which uses the Single Program Multiple Data (SPMD) feature to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.

DISK_DISTANCE, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected in the unit disk.

DISK_GRID, a C library which computes a grid points over the interior of the general disk in 2D;

DISK_GRID, a C++ library which computes a grid points over the interior of the general disk in 2D;

DISK_GRID, a FORTRAN77 library which computes a grid points over the interior of the general disk in 2D;

DISK_GRID, a FORTRAN90 library which computes a grid points over the interior of the general disk in 2D;

DISK_GRID, a MATLAB library which computes a grid points over the interior of the general disk in 2D;

DISK_GRID, a Python library which computes a grid points over the interior of the general disk in 2D;

DISK_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of the general disk in 2D;

DISK_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of the general disk in 2D;

DISK_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the general disk in 2D;

DISK_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of the general disk in 2D;

DISK_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of the general disk in 2D;

DISK_RULE, a C library which computes quadrature rules over the interior of the general disk in 2D;

DISK_RULE, a C++ library which computes quadrature rules over the interior of the general disk in 2D;

DISK_RULE, a FORTRAN90 library which computes quadrature rules over the interior of the general disk in 2D;

DISK_RULE, a MATLAB library which computes quadrature rules over the interior of the general disk in 2D;

DISK_RULE, a Python library which computes quadrature rules over the interior of the general disk in 2D;

DISK01_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.

DISK01_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.

DISK01_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.

DISK01_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.

DISK01_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.

DISK01_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.

DISK01_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk in 2D;

DISK01_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk in 2D;

DISK01_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk in 2D;

DISK01_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk in 2D;

DISK01_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk in 2D;

DISK01_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk in 2D;

DISK01_QUARTER_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit quarter disk in 2D;

DISK01_QUARTER_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit quarter disk in 2D;

DISK01_QUARTER_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit quarter disk in 2D;

DISK01_QUARTER_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit quarter disk in 2D;

DISK01_QUARTER_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit quarter disk in 2D;

DISK01_QUARTER_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit quarter disk in 2D;

DISK01_QUARTER_RULE, a MATLAB program which computes a quadrature rule over the interior of the unit quarter disk in 2D, with radius 1 and center (0,0).

DISK01_RULE, a C library which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).

DISK01_RULE, a C++ library which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).

DISK01_RULE, a FORTRAN77 library which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).

DISK01_RULE, a FORTRAN90 library which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).

DISK01_RULE, a MATLAB library which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).

DISK01_RULE, a Python library which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).

dislin_test, C programs which illustrate the use of DISLIN, a scientific graphics package, by Helmut Michels.

dislin_test, C++ programs which illustrate the use of DISLIN, a scientific graphics package, by Helmut Michels.

DISLIN, FORTRAN77 programs which illustrate the use of DISLIN, a scientific graphics package, by Helmut Michels.

dislin_test, FORTRAN90 programs which illustrate the use of DISLIN, a scientific graphics package, by Helmut Michels.

DIST_PLOT, a MATLAB program which makes contour plots of the distance function, as defined and used in Persson and Strang's distmesh code;

DISTANCE_TO_POSITION, a FORTRAN90 program which estimates the positions of cities based on a city-to-city distance table.

DISTANCE_TO_POSITION, a MATLAB program which estimates the positions of cities based on a city-to-city distance table.

DISTANCE_TO_POSITION_SPHERE, a MATLAB program which estimates the positions of cities on a sphere (such as the earth) based on a city-to-city distance table.

DISTMESH, a MATLAB library which carries out triangular or tetrahedral mesh generation, by Per-Olof Persson and Gilbert Strang.

DISTMESH_3D, a MATLAB library which constitutes the 3D subset of the distmesh() program for tetrahedral mesh generation, by Per-Olof Persson and Gilbert Strang.

DIVDIF, a C library which uses divided differences to compute the polynomial interpolant to a given set of data.

DIVDIF, a C++ library which uses divided differences to compute the polynomial interpolant to a given set of data.

DIVDIF, a FORTRAN77 library which uses divided differences to compute the polynomial interpolant to a given set of data.

DIVDIF, a FORTRAN90 library which uses divided differences to compute the polynomial interpolant to a given set of data.

DIVDIF, a MATLAB library which uses divided differences to compute the polynomial interpolant to a given set of data.

DLAP, a data directory which contains examples of DLAP files, a sparse matrix file format used by the DLAP package;

DLAP, a FORTRAN90 library which carries out the iterative solution of sparse linear systems, by Anne Greenbaum and Mark Seager.

DLAP_IO, a FORTRAN77 library which reads and writes sparse matrix files in the dlap format;

DLAP_IO, a FORTRAN90 library which reads and writes sparse matrix files in the dlap format;

DLAP_IO, a MATLAB library which reads and writes sparse matrix files in the dlap format;

dolfin-convert, a Python program which can convert a mesh file from Gmsh, MEDIT, METIS or SCOTCH format to an XML format suitable for use by DOLFIN or FENICS, by Anders Logg.

dolfin_test, Python programs which are used with the DOLFIN library to set up and solve a wide variety of problems using the finite element method (FEM).

dolfin_xml, a data directory which contains examples of XML files that describe 3D finite element method (FEM) meshes as used by DOLFIN and FENICS.

domain, a FENICS script which creates a region starting with a circle, and then "subtracting" a rectangle and smaller circle.

DOOMSDAY, a C library which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.

DOOMSDAY, a C++ library which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.

DOOMSDAY, a FORTRAN77 library which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.

DOOMSDAY, a FORTRAN90 library which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.

DOOMSDAY, a MATLAB library which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.

DOOMSDAY, a Python library which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.

DOUBLE_C_DATA, MATLAB programs which generate, plot or write out 2D data that forms two interlocking C shapes.

dpg_bvp, a FENICS script which uses the Discontinuous Petrov Galerkin (DPG) method to solve a boundary value problem over an interval, by Jay Gopalakrishnan.

dpg_laplace, a FENICS script which uses the Discontinuous Petrov Galerkin (DPG) method to solve a Poisson problem over the unit square, by Jay Gopalakrishnan.

dpg_laplace_adapt, a FENICS script which uses the Discontinuous Petrov Galerkin (DPG) method to solve a Poisson problem over the unit square, with adaptivity, by Jay Gopalakrishnan.

DQED, a FORTRAN77 library which solves constrained least squares problems, including a reverse communication (RC) option, by Richard Hanson and Fred Krogh.

DQED, a FORTRAN90 library which solves constrained least squares problems, including a reverse communication (RC) option, by Richard Hanson and Fred Krogh.

DRAFT_LOTTERY, a dataset directory which contains the numbers assigned to each birthday, for the Selective Service System lotteries for 1970 through 1976.

DREAM, a C program which implements the DREAM algorithm for accelerating Markov Chain Monte Carlo (MCMC) convergence using differential evolution, using five user functions to define the problem, by Guannan Zhang.

DREAM, a C++ program which implements the DREAM algorithm for accelerating Markov Chain Monte Carlo (MCMC) convergence using differential evolution, using five user functions to define the problem, by Guannan Zhang.

DREAM, a FORTRAN90 program which implements the DREAM algorithm for accelerating Markov Chain Monte Carlo (MCMC) convergence using differential evolution, using five user functions to define the problem, by Guannan Zhang.

DREAM, a MATLAB program which implements the DREAM algorithm for accelerating Markov Chain Monte Carlo (MCMC) convergence using differential evolution, using five user functions to define the problem, by Guannan Zhang.

DRUG_DOSAGE, a MATLAB program which simulates the variation in the blood levels of a medicinal drug being administered at specific dosages and times over a course of treatment. The level should rise about a given medicinal level for some time, but stay below the toxic level.

DRUG_DOSAGE, a Python program which simulates the variation in the blood levels of a medicinal drug being administered at specific dosages and times over a course of treatment. The level should rise about a given medicinal level for some time, but stay below the toxic level.

DSP, a data directory which contains examples of DSP files, a sparse matrix file format, storing just (I,J,A(I,J)), and using one-based indexing.

DUEL_SIMULATION, a C program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.

DUEL_SIMULATION, a C++ program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.

DUEL_SIMULATION, a FORTRAN77 program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.

DUEL_SIMULATION, a FORTRAN90 program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.

DUEL_SIMULATION, a MATHEMATICA program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.

DUEL_SIMULATION, a MATLAB program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.

DUEL_SIMULATION, a Python program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.

DUELING_IDIOTS, a MATLAB library which contains the scripts used to carry out the probability simulations described in Paul Nahin's "Dueling Idiots";

DUTCH, a FORTRAN90 library which carries out tasks in computational geometry.

EA-UTILS, examples which illustrate the use of EA-UTILS, which is a collection of command-line tools for processing biological sequencing data.

EARTH_SPHERE, a MATLAB program which displays a 3D image of the earth, including oceans, continents, and topography, by Clay Thompson and Will Campbell.

EDGE, a C library which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities. It uses gnuplot to display the jumps in curves and surfaces.

EDGE, a C++ library which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities. It uses gnuplot to display the jumps in curves and surfaces.

EDGE, a FORTRAN77 library which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities. It uses gnuplot to display the jumps in curves and surfaces.

EDGE, a FORTRAN90 library which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities. It uses gnuplot to display the jumps in curves and surfaces.

EDGE, a MATLAB library which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities.

EIGEN, examples which illustrate the use of EIGEN, a C++ template library for linear algebra, including natural and usable definitions of vectors and matrices, norms, factorizations, solution of linear systems, evaluation of eigenvalues, and many standard linear algebra algorithms for dense and sparse matrices.

EISPACK, a C library which carries out eigenvalue computations. It includes a function to compute the singular value decomposition (SVD) of a rectangular matrix. superseded by LAPACK;

EISPACK, a C++ library which carries out eigenvalue computations. It includes a function to compute the singular value decomposition (SVD) of a rectangular matrix. superseded by LAPACK;

EISPACK, a FORTRAN77 library which carries out eigenvalue computations. It includes a function to compute the singular value decomposition (SVD) of a rectangular matrix. superseded by LAPACK;

EISPACK, a FORTRAN90 library which carries out eigenvalue computations. It includes a function to compute the singular value decomposition (SVD) of a rectangular matrix. superseded by LAPACK;

ell, a FENICS script which solves the Poisson equation on the L-shaped region.

ELLIPSE_GRID, a C library which computes a grid of points over the interior of an ellipse in 2D.

ELLIPSE_GRID, a C++ library which computes a grid of points over the interior of an ellipse in 2D.

ELLIPSE_GRID, a FORTRAN77 library which computes a grid of points over the interior of an ellipse in 2D.

ELLIPSE_GRID, a FORTRAN90 library which computes a grid of points over the interior of an ellipse in 2D.

ELLIPSE_GRID, a MATLAB library which computes a grid of points over the interior of an ellipse in 2D.

ELLIPSE_GRID, a Python library which computes a grid of points over the interior of an ellipse in 2D.

ELLIPSE_MONTE_CARLO a C library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.

ELLIPSE_MONTE_CARLO a C++ library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.

ELLIPSE_MONTE_CARLO a FORTRAN77 library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.

ELLIPSE_MONTE_CARLO a FORTRAN90 library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.

ELLIPSE_MONTE_CARLO a MATLAB library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.

ELLIPSE_MONTE_CARLO a Python library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.

ELLIPSOID_GRID, a C library which computes a grid of points over the interior of an ellipsoid in 3D.

ELLIPSOID_GRID, a C++ library which computes a grid of points over the interior of an ellipsoid in 3D.

ELLIPSOID_GRID, a FORTRAN77 library which computes a grid of points over the interior of an ellipsoid in 3D.

ELLIPSOID_GRID, a FORTRAN90 library which computes a grid of points over the interior of an ellipsoid in 3D.

ELLIPSOID_GRID, a MATLAB library which computes a grid of points over the interior of an ellipsoid in 3D.

ELLIPSOID_GRID, a Python library which computes a grid of points over the interior of an ellipsoid in 3D.

ELLIPSOID_MONTE_CARLO a C library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.

ELLIPSOID_MONTE_CARLO a C++ library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.

ELLIPSOID_MONTE_CARLO a FORTRAN77 library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.

ELLIPSOID_MONTE_CARLO a FORTRAN90 library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.

ELLIPSOID_MONTE_CARLO a MATLAB library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.

ELLIPSOID_MONTE_CARLO a Python library which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.

ELLIPTIC_INTEGRAL, a C library which evaluates complete elliptic integrals of first, second and third kind, using Carlson's elliptic integral functions.

ELLIPTIC_INTEGRAL, a C++ library which evaluates complete elliptic integrals of first, second and third kind, using Carlson's elliptic integral functions.

ELLIPTIC_INTEGRAL, a FORTRAN77 library which evaluates complete elliptic integrals of first, second and third kind, using Carlson's elliptic integral functions.

ELLIPTIC_INTEGRAL, a FORTRAN90 library which evaluates complete elliptic integrals of first, second and third kind, using Carlson's elliptic integral functions.

ELLIPTIC_INTEGRAL, a MATLAB library which evaluates complete elliptic integrals of first, second and third kind, using Carlson's elliptic integral functions.

ENSIGHT examples which illustrate the use of ENSIGHT, which is a software program for visualizing, analyzing, and communicating data from computer simulations and experiments. It is most often used for Computational Fluid Dynamics (CFD), Computational Structural Mechanics (CSM), and other processes in Computer Aided Engineering (CAE).

ENTRUST, a MATLAB program which minimizes a scalar function of several variables using trust-region methods, by Jeff Borggaard and Gene Cliff.

EP_SERIAL, a FORTRAN77 program which a serial version of the NAS Embarassingly Parallel (EP) Parallel Benchmark.

EP_SERIAL, a FORTRAN90 program which a serial version of the NAS Embarassingly Parallel (EP) Parallel Benchmark.

EPICYCLOID, a MATLAB library which computes, plots and tabulates an epicycloid curve.

EPS, a data directory which contains examples of Encapsulated PostScript (EPS) files for 2D vector graphics;

EPS_TO_JPG, examples which illustrate how one can automate the conversion of Encapsulated PostScript (EPS) files to JPEG format.

EPS_TO_PNG, examples which illustrate how one can automate the conversion of Encapsulated PostScript (EPS) files to Portable Network Graphics (PNG) format.

EQUIDISTRIBUTION, a MATLAB library which investigates equidistribution properties relating to density functions and point sets.

ERRORS, a FORTRAN90 program which illustrates the failure of numerical algorithms;

ERRORS, a MATLAB program which illustrates the failure of numerical algorithms;

ESPRESSO, examples which illustrate the use of Quantum ESPRESSO, which is an integrated suite of open source computer codes for electronic-structure calculations and materials modeling at the nanoscale. It is based on density-functional theory (DFT), plane waves, and pseudopotentials.

EXACTNESS, a C library which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).

EXACTNESS, a C++ library which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).

EXACTNESS, a FORTRAN77 library which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).

EXACTNESS, a FORTRAN90 library which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).

EXACTNESS, a MATLAB library which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).

EXACTNESS, a Python library which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).

EXAML, examples which illustrate the use of EXAML, a program which implements the popular RAxML search algorithm for maximum likelihood based inference of phylogenetic trees. It uses a radically new MPI parallelization approach that yields improved parallel efficiency, in particular on partitioned multi-gene or whole-genome datasets.

EXM, a MATLAB library which illustrates the computational experiments in "Experiments with Matlab", by Cleve Moler.

EXPOKIT, a FORTRAN77 library which solves various forms of the matrix exponential problem, by Roger Sidje.

expression_test, a FENICS script which demonstrates some properties of the objects created by the FEniCS Expression() function.

EXTRACT, a FORTRAN90 program which extracts one routine from a FORTRAN77 or FORTRAN90 file;

F77, FORTRAN77 programs which illustrate features of FORTRAN77;

F77_CALLS_C, FORTRAN77 programs which call a C function.

F77_CALLS_C++, FORTRAN77 programs which call a C++ function.

F77_CALLS_MATLAB, FORTRAN77 programs which call a MATLAB function;

F77_CLASS, FORTRAN77 programs which were used to illustrate a programming class.

F77_CLEANUP, a FORTRAN90 program which makes a copy of a FORTRAN77 file in which some minor cleanups have been made.

F77_CONDOR, FORTRAN77 programs which illustrate how a FORTRAN77 program can be run in batch mode using the condor queueing system.

F77_INTRINSICS, a FORTRAN77 program which illustrates the use of intrinsic functions supplied by the FORTRAN77 language.

F77_RETURN, FORTRAN77 programs which illustrates how a FORTRAN77 program can return a program status value to the calling environment.

F77_TO_F90, a FORTRAN90 program which converts a FORTRAN77 file to FORTRAN90 format, by Michael Metcalfe;

F77SPLIT, a C program which splits a file containing multiple FORTRAN77 routines into separate files;

F90, FORTRAN90 programs which illustrate features of the FORTRAN90 programming language;

F90_CALLS_C, FORTRAN90 programs which call a C function.

F90_CALLS_C_AND_MPI, FORTRAN90 programs which call a C function while executing under the MPI parallel programming environment.

F90_CALLS_C++, FORTRAN90 programs which call a C++ function.

F90_CALLS_C++_AND_MPI, FORTRAN90 programs which call a C++ function while executing under the MPI parallel programming environment.

F90_CALLS_MATLAB, FORTRAN90 programs which call a MATLAB function;

F90_CONDOR, FORTRAN90 programs which illustrate how a FORTRAN90 program can be run in batch mode using the condor queueing system.

F90_FILES, programs which illustrate the use of files in the FORTRAN90 language.

F90_INTRINSICS, a FORTRAN90 program which illustrate the use of intrinsic functions supplied by the FORTRAN90 language.

F90_MISTAKE, FORTRAN90 programs which illustrate certain programming mistakes in FORTRAN90.

F90_MODULE, FORTRAN90 programs which illustrate the use of FORTRAN90's module feature.

F90_RANDOM, FORTRAN90 programs which illustrate the use of FORTRAN90 random number generator (RNG) routines.

F90_RETURN, FORTRAN90 programs which illustrates how a FORTRAN90 program can return a program status value to the calling environment.

F90_TO_F77, a FORTRAN90 program which assists in the conversion of a FORTRAN90 file to FORTRAN77 format.

F90SPLIT, a C program which splits a file containing multiple FORTRAN90 routines into separate files;

F90SPLIT, a FORTRAN90 program which reads a FORTRAN file and creates individual files for every subroutine or function in the file.

FACE_SPMD, a MATLAB program which demonstrates the Single Program Multiple Data (SPMD) parallel programming feature; the client has a 3D box that has been dissected into tetrahedrons. Multiple workers cooperate to construct a list of the triangular faces that lie on the boundaries of the box.

FAIR_DICE_SIMULATION, a C program which simulates N games in which two fair dice are thrown and summed, creating graphics files for processing by gnuplot.

FAIR_DICE_SIMULATION, a C++ program which simulates N games in which two fair dice are thrown and summed, creating graphics files for processing by gnuplot.

FAIR_DICE_SIMULATION, a FORTRAN77 program which simulates N games in which two fair dice are thrown and summed, creating graphics files for processing by gnuplot.

FAIR_DICE_SIMULATION, a FORTRAN90 program which simulates N games in which two fair dice are thrown and summed, creating graphics files for processing by gnuplot.

FAIR_DICE_SIMULATION, a MATLAB program which simulates N tosses of 2 dice, making a histogram of the results.

FASTGL, a C library which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.

FASTGL, a C++ library which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.

FASTGL, a FORTRAN90 library which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.

FASTGL, a MATLAB library which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.

FASTGL, a Python library which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.

FASTQC, examples which illustrate the use of FASTQC, which is a program that does fast quality checks on sequence data.

FASTX_TOOLKIT, examples which illustrate the use of FASTX_TOOLKIT, which is a collection of command line tools for Short-Reads FASTA/FASTQ files preprocessing.

FAURE, a dataset directory which contains examples of the Faure Quasi Monte Carlo (QMC) sequence;

FAURE, a C++ library which computes elements of a Faure Quasi Monte Carlo (QMC) sequence.

FAURE, a FORTRAN90 library which computes elements of a Faure Quasi Monte Carlo (QMC) sequence.

FAURE, a MATLAB library which computes elements of a Faure Quasi Monte Carlo (QMC) sequence.

FAURE_DATASET, a C++ program which creates a Faure Quasi Monte Carlo (QMC) dataset;

FAURE_DATASET, a FORTRAN90 program which creates a Faure Quasi Monte Carlo (QMC) dataset;

FAURE_DATASET, a MATLAB program which creates a Faure Quasi Monte Carlo (QMC) dataset;

FD_PREDATOR_PREY, a C program which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.

FD_PREDATOR_PREY, a C++ program which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.

FD_PREDATOR_PREY, a FORTRAN77 program which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.

FD_PREDATOR_PREY, a FORTRAN90 program which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.

FD_PREDATOR_PREY, a MATLAB program which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.

FD_PREDATOR_PREY, a Python program which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.

FD_TO_TEC, a MATLAB program which converts finite difference (FD) models into tecplot ASCII files.

FD1D, a data directory which contains examples of 1D FD files, two text files that describe many models constructed by the finite difference method (FDM) with one space variable, and either no time dependence or a snapshot at a given time;

FD1D_ADVECTION_DIFFUSION_STEADY, a C program which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_DIFFUSION_STEADY, a C++ program which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_DIFFUSION_STEADY, a FORTRAN77 program which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_DIFFUSION_STEADY, a FORTRAN90 program which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_DIFFUSION_STEADY, a MATLAB program which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k.

FD1D_ADVECTION_FTCS, a C program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_FTCS, a C++ program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_FTCS, a FORTRAN77 program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_FTCS, a FORTRAN90 program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_FTCS, a MATLAB program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method.

FD1D_ADVECTION_LAX, a C program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX, a C++ program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX, a FORTRAN77 program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX, a FORTRAN90 program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX, a MATLAB program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative.

FD1D_ADVECTION_LAX_WENDROFF, a C program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX_WENDROFF, a C++ program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX_WENDROFF, a FORTRAN77 program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX_WENDROFF, a FORTRAN90 program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot.

FD1D_ADVECTION_LAX_WENDROFF, a MATLAB program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative.

FD1D_ADVECTION_LAX_WENDROFF, a Python program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative.

FD1D_BURGERS_LAX, a C program which applies the finite difference method (FDM) and the Lax-Wendroff method to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LAX, a C++ program which applies the finite difference method (FDM) and the Lax-Wendroff method to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LAX, a FORTRAN77 program which applies the finite difference method (FDM) and the Lax-Wendroff method to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LAX, a FORTRAN90 program which applies the finite difference method (FDM) and the Lax-Wendroff method to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LAX, a MATLAB program which applies the finite difference method (FDM) and the Lax-Wendroff method to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LEAP, a C program which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LEAP, a C++ program which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LEAP, a FORTRAN77 program which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LEAP, a FORTRAN90 program which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BURGERS_LEAP, a MATLAB program which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous Burgers equation in one spatial dimension and time.

FD1D_BVP, a C program which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.

FD1D_BVP, a C++ program which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.

FD1D_BVP, a FORTRAN77 program which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.

FD1D_BVP, a FORTRAN90 program which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.

FD1D_BVP, a MATLAB program which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.

FD1D_DISPLAY, a MATLAB program which reads a pair of files defining a 1D finite difference method (FDM) model, and plots the data.

FD1D_HEAT_EXPLICIT, a C library which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_EXPLICIT, a C++ library which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_EXPLICIT, a FORTRAN77 library which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_EXPLICIT, a FORTRAN90 library which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_EXPLICIT, a MATLAB library which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_EXPLICIT, a Python library which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_IMPLICIT, a C program which uses the finite difference method (FDM) and implicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_IMPLICIT, a C++ program which uses the finite difference method (FDM) and implicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_IMPLICIT, a FORTRAN77 program which uses the finite difference method (FDM) and implicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_IMPLICIT, a FORTRAN90 program which uses the finite difference method (FDM) and implicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_IMPLICIT, a MATLAB program which uses the finite difference method (FDM) and implicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_IMPLICIT, a Python program which uses the finite difference method (FDM) and implicit time stepping to solve the time dependent heat equation in 1D.

FD1D_HEAT_STEADY, a C program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.

FD1D_HEAT_STEADY, a C++ program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.

FD1D_HEAT_STEADY, a FORTRAN77 program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.

FD1D_HEAT_STEADY, a FORTRAN90 program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.

FD1D_HEAT_STEADY, a MATLAB program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.

FD1D_PREDATOR_PREY, a FORTRAN77 program which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence,, by Marcus Garvie.

FD1D_PREDATOR_PREY, a FORTRAN90 program which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence, creating graphics files for processing by gnuplot, by Marcus Garvie.

FD1D_PREDATOR_PREY, a MATLAB program which implements the finite difference method (FDM) for predator-prey system with time and 1D spatial dependence, by Marcus Garvie.

FD1D_PREDATOR_PREY_PLOT, a MATLAB program which plots the output from the fd1d_predator_prey program, by Marcus Garvie.

FD1D_WAVE, a C library which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.

FD1D_WAVE, a C++ library which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.

FD1D_WAVE, a FORTRAN77 library which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.

FD1D_WAVE, a FORTRAN90 library which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.

FD1D_WAVE, a MATLAB library which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.

FD2D, a data directory which contains examples of 2D FD files, two text files that can be used to describe models created with the finite difference method (FDM).

FD2D_HEAT_EXPLICIT_SPMD, a MATLAB program which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 2D. A black and white image is used as the initial condition. MATLAB's Single Program Multiple Data (SPMD) facility is used to carry out the computation in parallel.

FD2D_HEAT_STEADY, a C program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.

FD2D_HEAT_STEADY, a C++ program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.

FD2D_HEAT_STEADY, a FORTRAN77 program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.

FD2D_HEAT_STEADY, a FORTRAN90 program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.

FD2D_HEAT_STEADY, a MATLAB program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.

FD2D_HEAT_STEADY, a Python program which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.

FD2D_PREDATOR_PREY, a FORTRAN90 program which implements the finite difference method (FDM) for a predator-prey system with time and 2D spatial dependence, by Marcus Garvie.

FD2D_PREDATOR_PREY, a MATLAB program which implements the finite difference method (FDM) for a predator-prey system with time and 2D spatial dependence, by Marcus Garvie.

FD3D, a data directory which contains examples of 3D FD files, two text files that can be used to describe models created with the finite difference method (FDM).

FDK-AAC, examples which illustrate the use of FDK-AAC, which is an AAC encoder and decoder library.

FE2D_PREDATOR_PREY_FAST, MATLAB programs which implement the finite element method (FEM) for a predator-prey system with time and 2D spatial dependence, in an arbitrary triangulated region, with a variety of boundary conditions, incorporating some Matlab optimizations, by Marcus Garvie.

FELIPPA, a MATHEMATICA library which defines quadrature rules for lines, triangles, quadrilaterals, pyramids, wedges, tetrahedrons and hexahedrons.

FEM_50, a MATLAB program which implements a finite element method (FEM) in just 50 lines of code, by Jochen Alberty, Carsten Carstensen, Stefan Funken.

FEM_50_HEAT, a MATLAB program which implements a finite element method (FEM) for the heat equation, by Jochen Alberty, Carsten Carstensen, Stefan Funken.

FEM_BASIS, a C library which can define basis functions for 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, a C++ library which can define basis functions for 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, a FORTRAN77 library which can define basis functions for 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, a FORTRAN90 library which can define basis functions for 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, a MATLAB library which can define basis functions for 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, a Python library which can define basis functions for 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_Q4_DISPLAY, a MATLAB program which displays a finite element method (FEM) basis function associated with a linear quadrilateral (Q4) mesh.

FEM_BASIS_T3_DISPLAY, a MATLAB program which displays a finite element method (FEM) basis function associated with a 3-node triangle (T3) mesh.

FEM_BASIS_T4_DISPLAY, a MATLAB program which displays a finite element method (FEM) basis function associated with a 4-node triangle (T4) mesh.

FEM_BASIS_T6_DISPLAY, a MATLAB program which displays a finite element method (FEM) basis function associated with a 6-node triangle (T6) mesh.

FEM_IO, a C library which reads or writes node, element and data files defining a model associated with the finite element method (FEM).

FEM_IO, a C++ library which reads or writes node, element and data files defining a model associated with the finite element method (FEM).

FEM_IO, a FORTRAN77 library which reads or writes node, element and data files defining a model associated with the finite element method (FEM).

FEM_IO, a FORTRAN90 library which reads or writes node, element and data files defining a model associated with the finite element method (FEM).

FEM_IO, a MATLAB library which reads or writes node, element and data files defining a model associated with the finite element method (FEM).

FEM_MESHING, a MATLAB library which looks at some simple issues in defining a geometric mesh for the finite element method (FEM) in 2D.

FEM_NEUMANN, a MATLAB program which sets up a time-dependent reaction-diffusion equation in 1D, with Neumann boundary conditions, discretized using the finite element method (FEM).

FEM_TO_GMSH, a C program which reads FEM files definining 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, a C++ program which reads FEM files definining 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, a FORTRAN77 program which reads FEM files definining 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, a FORTRAN90 program which reads FEM files definining 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, a MATLAB program which reads FEM files definining a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a Gmsh mesh file.

FEM_TO_MEDIT, a C program which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding MEDIT mesh file.

FEM_TO_MEDIT, a C++ program which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding MEDIT mesh file.

FEM_TO_MEDIT, a FORTRAN77 program which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding MEDIT mesh file.

FEM_TO_MEDIT, a FORTRAN90 program which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding MEDIT mesh file.

FEM_TO_MEDIT, a MATLAB program which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding MEDIT mesh file.

FEM_TO_MESH, a C++ program which reads a set of FEM files defining the node coordinates, boundary nodes, and elements of a finite element mesh, and rewrites the data as a MESH file.

FEM_TO_MESH, a FORTRAN90 program which reads a set of FEM files defining the node coordinates, boundary nodes, and elements of a finite element mesh, and rewrites the data as a MESH file.

FEM_TO_MESH, a MATLAB program which reads a set of FEM files defining the node coordinates, boundary nodes, and elements of a finite element mesh, and rewrites the data as a MESH file.

FEM_TO_TEC, a FORTRAN90 program which converts FEM models into tecplot ASCII files.

FEM_TO_TEC, a MATLAB program which converts FEM models into tecplot ASCII files.

FEM_TO_TRIANGLE, a C program which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle program.

FEM_TO_TRIANGLE, a C++ program which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle program.

FEM_TO_TRIANGLE, a FORTRAN77 program which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle program.

FEM_TO_TRIANGLE, a FORTRAN90 program which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle program.

FEM_TO_TRIANGLE, a MATLAB program which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle program.

FEM_TO_XML, a C program which reads FEM files defining 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, a C++ program which reads FEM files defining 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, a FORTRAN77 program which reads FEM files defining 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, a FORTRAN90 program which reads FEM files defining 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, a MATLAB program which reads FEM files defining 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, a Python program which reads FEM files defining a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding XML file for input to DOLFIN or FENICS.

FEM1D, a data directory which contains examples of 1D FEM files, text files that describe a 1D finite element model and associated nodal values.

FEM1D, a C program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D, a C++ program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D, a FORTRAN77 program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D, a FORTRAN90 program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D, a MATLAB program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D, a Python program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D_ADAPTIVE, a C program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP) using adaptive refinement to improve the solution.

FEM1D_ADAPTIVE, a C++ program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP) using adaptive refinement to improve the solution.

FEM1D_ADAPTIVE, a FORTRAN77 program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP) using adaptive refinement to improve the solution.

FEM1D_ADAPTIVE, a FORTRAN90 program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP) using adaptive refinement to improve the solution.

FEM1D_ADAPTIVE, a MATLAB program which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP) using adaptive refinement to improve the solution.

FEM1D_BVP_LINEAR, a C program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_LINEAR, a C++ program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_LINEAR, a FORTRAN77 program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_LINEAR, a FORTRAN90 program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_LINEAR, a MATLAB program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_LINEAR, a Python program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_QUADRATIC, a C program which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_QUADRATIC, a C++ program which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_QUADRATIC, a FORTRAN77 program which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_QUADRATIC, a FORTRAN90 program which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_QUADRATIC, a MATLAB program which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM1D_BVP_QUADRATIC, a Python program which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension.

FEM1D_CLASSES, a Python library which defines classes useful for solving a boundary value problem (BVP) of the form u''+2u'+u=f in 1 spatial dimension, using the finite element method (FEM), by Mike Sussman.

FEM1D_DISPLAY, a MATLAB program which reads three files defining a 1D arbitrary degree function associated with the finite element method (FEM), and displays a plot.

FEM1D_FUNCTION_10_DISPLAY, a MATLAB program which reads three files defining a 1D piecewise linear finite element function and displays a plot.

FEM1D_HEAT_EXPLICIT, a MATLAB program which uses the finite element method (FEM) and explicit time stepping to solve the time dependent heat equation in 1D.

FEM1D_HEAT_EXPLICIT, a Python program which uses the finite element method (FEM) and explicit time stepping to solve the time dependent heat equation in 1D.

FEM1D_HEAT_IMPLICIT, a MATLAB program which uses the finite element method (FEM) and implicit time stepping to solve the time dependent heat equation in 1D.

FEM1D_HEAT_STEADY, a C program which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.

FEM1D_HEAT_STEADY, a C++ program which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.

FEM1D_HEAT_STEADY, a FORTRAN77 program which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.

FEM1D_HEAT_STEADY, a FORTRAN90 program which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.

FEM1D_HEAT_STEADY, a MATLAB program which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.

FEM1D_LAGRANGE, a C library which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.

FEM1D_LAGRANGE, a C++ library which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.

FEM1D_LAGRANGE, a FORTRAN77 library which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.

FEM1D_LAGRANGE, a FORTRAN90 library which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.

FEM1D_LAGRANGE, a MATLAB library which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.

FEM1D_NONLINEAR, a C program which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).

FEM1D_NONLINEAR, a C++ program which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).

FEM1D_NONLINEAR, a FORTRAN77 program which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).

FEM1D_NONLINEAR, a FORTRAN90 program which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem.

FEM1D_NONLINEAR, a MATLAB program which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).

FEM1D_ODEN, a FORTRAN77 program which applies the finite element method (FEM) to a linear two point boundary value problem 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_PACK, a C library which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.

FEM1D_PACK, a C++ library which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.

FEM1D_PACK, a FORTRAN77 library which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.

FEM1D_PACK, a FORTRAN90 library which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.

FEM1D_PACK, a MATLAB library which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.

FEM1D_PMETHOD, a C program which applies the p-method version of the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D_PMETHOD, a C++ program which applies the p-method version of the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D_PMETHOD, a FORTRAN77 program which applies the p-method version of the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D_PMETHOD, a FORTRAN90 program which applies the p-method version of the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D_PMETHOD, a MATLAB program which applies the p-method version of the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).

FEM1D_PROJECT, a C program which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.

FEM1D_PROJECT, a C++ program which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.

FEM1D_PROJECT, a FORTRAN77 program which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.

FEM1D_PROJECT, a FORTRAN90 program which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.

FEM1D_PROJECT, a MATLAB program which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.

FEM1D_SAMPLE, a C program which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.

FEM1D_SAMPLE, a C++ program which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.

FEM1D_SAMPLE, a FORTRAN77 program which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.

FEM1D_SAMPLE, a FORTRAN90 program which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.

FEM1D_SAMPLE, a MATLAB program which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.

FEM1D_SPECTRAL_NUMERIC, a MATLAB program which applies the spectral finite element method (FEM) to solve the two point boundary value problem (BVP_ u'' = - pi^2 sin(x) over [-1,+1] with zero boundary conditions, using as basis elements the functions x^n*(x-1)*(x+1), and carrying out the integration numerically, using MATLAB's quad() function, by Miro Stoyanov.

FEM1D_SPECTRAL_SYMBOLIC, a MATLAB program which applies the spectral finite element method (FEM) to solve the two point boundary value problem (BVP) u'' = - pi^2 sin(x) over [-1,+1] with zero boundary conditions, using as basis elements the functions x^n*(x-1)*(x+1), and carrying out the integration using MATLAB's symbolic toolbox, by Miro Stoyanov.

FEM2D, a data directory which contains examples of 2D FEM files, text files that describe a 2D geometry and node values associated with the finite element method (FEM);

FEM2D_BVP_LINEAR, a C program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_LINEAR, a C++ program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_LINEAR, a FORTRAN77 program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_LINEAR, a FORTRAN90 program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_LINEAR, a MATLAB program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_LINEAR, a Python program which applies the finite element method (FEM), with piecewise bilinear elements, to a 2D boundary value problem (BVP) in a rectangle.

FEM2D_BVP_QUADRATIC, a C program which applies the finite element method (FEM), with piecewise quadratic elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_QUADRATIC, a C++ program which applies the finite element method (FEM), with piecewise quadratic elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_QUADRATIC, a FORTRAN77 program which applies the finite element method (FEM), with piecewise quadratic elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_QUADRATIC, a FORTRAN90 program which applies the finite element method (FEM), with piecewise quadratic elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_QUADRATIC, a MATLAB program which applies the finite element method (FEM), with piecewise quadratic elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_SERENE, a C program which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_SERENE, a C++ program which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_SERENE, a FORTRAN77 program which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_SERENE, a FORTRAN90 program which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_BVP_SERENE, a MATLAB program which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.

FEM2D_HEAT, a C++ program which uses the finite element method (FEM) and the backward Euler method to solve the 2D time-dependent heat equation on an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_HEAT, a FORTRAN90 program which uses the finite element method (FEM) and the backward Euler method to solve the 2D time-dependent heat equation on an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_HEAT, a MATLAB program which uses the finite element method (FEM) and the backward Euler method to solve the 2D time-dependent heat equation on an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_HEAT_RECTANGLE, a C++ program which uses the finite element method (FEM) to solve the 2D time dependent heat equation on the unit square, using a uniform grid of triangular elements.

FEM2D_HEAT_RECTANGLE, a FORTRAN90 program which uses the finite element method (FEM) to solve the 2D time dependent heat equation on the unit square, using a uniform grid of triangular elements.

FEM2D_HEAT_RECTANGLE, a MATLAB program which uses the finite element method (FEM) to solve the 2D time dependent heat equation on the unit square, using a uniform grid of triangular elements.

FEM2D_HEAT_RECTANGLE_STEADY_SPMD, a MATLAB program which uses the MATLAB Parallel Computing Toolbox in Single Program Multiple Data (SPMD) mode to set up and solve a distributed linear system for the steady (time independent) 2D heat equation, by Gene Cliff.

FEM2D_HEAT_SPARSE, a MATLAB program which uses the finite element method (FEM) to solve the time dependent heat equation in an arbitrary triangulated 2D region, using MATLAB's sparse matrix storage format and solver.

FEM2D_HEAT_SPARSE_SQUARE, a MATLAB library which defines the geometry of a square region, as well as boundary and initial conditions for a given heat problem, so that fem2d_heat_sparse can be called for a solution.

FEM2D_HEAT_SQUARE, a C++ library which defines the geometry of a square region, as well as boundary and initial conditions for a given heat problem, so that fem2d_heat can be called for a solution.

FEM2D_HEAT_SQUARE, a FORTRAN90 library which defines the geometry of a square region, as well as boundary and initial conditions for a given heat problem, so that fem2d_heat can be called for a solution.

FEM2D_HEAT_SQUARE, a MATLAB library which defines the geometry of a square region, as well as boundary and initial conditions for a given heat problem, so that fem2d_heat can be called for a solution.

FEM2D_MESH_DISPLAY, a MATLAB program which reads the FEM model of a 2D mesh, consisting of polygonal elements of any uniform order, and displays an image of the elements and nodes, with optional numbering.

FEM2D_MESH_DISPLAY_OPENGL, a C++ program which reads the FEM model of a 2D mesh, consisting of polygonal elements of any uniform order, and displays an image of the elements and nodes using OpenGL.

FEM2D_NAVIER_STOKES, a C++ program which uses the finite element method (FEM) to solve the 2D incompressible Navier Stokes equations (NSE) in an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_NAVIER_STOKES, a FORTRAN90 program which uses the finite element method (FEM) to solve the 2D incompressible Navier Stokes equations(NSE) in an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_NAVIER_STOKES, a MATLAB program which uses the finite element method (FEM) to solve the 2D incompressible Navier Stokes equations (NSE) in an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_NAVIER_STOKES_CAVITY, a C++ library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the cavity problem.

FEM2D_NAVIER_STOKES_CAVITY, a FORTRAN90 library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the cavity problem.

FEM2D_NAVIER_STOKES_CAVITY, a MATLAB library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the cavity problem.

FEM2D_NAVIER_STOKES_CHANNEL, a C++ library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the channel problem.

FEM2D_NAVIER_STOKES_CHANNEL, a FORTRAN90 library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the channel problem.

FEM2D_NAVIER_STOKES_CHANNEL, a MATLAB library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the channel problem.

FEM2D_NAVIER_STOKES_INOUT, a C++ library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the inout problem.

FEM2D_NAVIER_STOKES_INOUT, a FORTRAN90 library which contains the user-supplied routines necessary to run fem2d_navier_stokes on the inout problem.

FEM2D_NAVIER_STOKES_SPARSE, a MATLAB program which uses the finite element method (FEM) to solve the steady (time independent) incompressible Navier Stokes equations on an arbitrary triangulated region, using MATLAB's sparse() facility.

FEM2D_NAVIER_STOKES_SPARSE_BIG_CAVITY, a MATLAB library which contains the user-supplied routines necessary to run fem2d_navier_stokes_sparse on the big cavity problem.

FEM2D_NAVIER_STOKES_SPARSE_CAVITY, a MATLAB library which contains the user-supplied routines necessary to run fem2d_navier_stokes_sparse on the cavity problem.

FEM2D_NAVIER_STOKES_SPARSE_CHANNEL, a MATLAB library which contains the user-supplied routines necessary to run fem2d_navier_stokes_sparse on the channel problem.

FEM2D_NAVIER_STOKES_SPARSE_INOUT, a MATLAB library which contains the user-supplied routines necessary to run fem2d_navier_stokes_sparse on the inout problem.

FEM2D_PACK, a C library which contains utilities for 2D finite element method (FEM) calculations.

FEM2D_PACK, a C++ library which contains utilities for 2D finite element method (FEM) calculations.

FEM2D_PACK, a FORTRAN77 library which contains utilities for 2D finite element method (FEM) calculations.

FEM2D_PACK, a FORTRAN90 library which contains utilities for 2D finite element method (FEM) calculations.

FEM2D_PACK, a MATLAB library which contains utilities for 2D finite element method (FEM) calculations.

FEM2D_POISSON, a C++ program which solves Poisson's equation on a triangulated region, using the finite element method (FEM) and a banded solver.

FEM2D_POISSON, a FORTRAN90 program which solves Poisson's equation on a triangulated region, using the finite element method (FEM) and a banded solver.

FEM2D_POISSON_CG, a C++ program which solves Poisson's equation on a triangulated region, using the finite element method (FEM), sparse storage, and a conjugate gradient solver.

FEM2D_POISSON_CG, a FORTRAN90 program which solves Poisson's equation on a triangulated region, using the finite element method (FEM), sparse storage, and a conjugate gradient solver.

FEM2D_POISSON_CG, a MATLAB program which solves Poisson's equation on a triangulated region, using the finite element method (FEM), sparse storage, and a conjugate gradient solver.

FEM2D_POISSON_CG_BAFFLE, a C++ library which defines the geometry of a channel with 13 hexagonal baffles, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_cg as part of a solution procedure.

FEM2D_POISSON_CG_BAFFLE, a FORTRAN90 library which defines the geometry of a channel with 13 hexagonal baffles, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_cg as part of a solution procedure.

FEM2D_POISSON_CG_ELL, a C++ library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_cg as part of a solution procedure.

FEM2D_POISSON_CG_ELL, a FORTRAN90 library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_cg as part of a solution procedure.

FEM2D_POISSON_CG_LAKE, a C++ library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_cg as part of a solution procedure.

FEM2D_POISSON_CG_LAKE, a FORTRAN90 library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_cg as part of a solution procedure.

FEM2D_POISSON_ELL, a C++ library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson as part of a solution procedure.

FEM2D_POISSON_ELL, a FORTRAN90 library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson as part of a solution procedure.

FEM2D_POISSON_LAKE, a C++ library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson as part of a solution procedure.

FEM2D_POISSON_LAKE, a FORTRAN90 library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson as part of a solution procedure.

FEM2D_POISSON_RECTANGLE, a C program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.

FEM2D_POISSON_RECTANGLE, a C++ program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.

FEM2D_POISSON_RECTANGLE, a FORTRAN77 program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.

FEM2D_POISSON_RECTANGLE, a FORTRAN90 program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.

FEM2D_POISSON_RECTANGLE, a MATLAB program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.

FEM2D_POISSON_RECTANGLE_LINEAR, a C program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.

FEM2D_POISSON_RECTANGLE_LINEAR, a C++ program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.

FEM2D_POISSON_RECTANGLE_LINEAR, a FORTRAN77 program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.

FEM2D_POISSON_RECTANGLE_LINEAR, a FORTRAN90 program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.

FEM2D_POISSON_RECTANGLE_LINEAR, a MATLAB program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.

FEM2D_POISSON_SPARSE, a C++ program which solves the steady (time independent) Poisson equation on an arbitrary 2D triangulated region using the finite element method (FEM) and a version of GMRES for a sparse solver.

FEM2D_POISSON_SPARSE, a FORTRAN90 program which solves the steady (time independent) Poisson equation on an arbitrary 2D triangulated region using the finite element method (FEM) and a version of GMRES for a sparse solver.

FEM2D_POISSON_SPARSE, a MATLAB program which solves the steady (time independent) Poisson equation on an arbitrary 2D triangulated region using the finite element method (FEM) and a version of GMRES for a sparse solver.

FEM2D_POISSON_SPARSE_BAFFLE, a C++ library which defines the geometry of a rectangular channel with 13 hexagonal baffles, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_BAFFLE, a FORTRAN90 library which defines the geometry of a rectangular channel with 13 hexagonal baffles, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_BAFFLE, a MATLAB library which defines the geometry of a rectangular channel with 13 hexagonal baffles, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_ELL, a C++ library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_ELL, a FORTRAN90 library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_ELL, a MATLAB library which defines the geometry of an L-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_LAKE, a C++ library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_LAKE, a FORTRAN90 library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_POISSON_SPARSE_LAKE, a MATLAB library which defines the geometry of a lake-shaped region, as well as boundary conditions for a given Poisson problem, and is called by fem2d_poisson_sparse as part of a solution procedure.

FEM2D_PROJECT, a C++ program which projects a function f(x,y), given as a data, into a given finite element space of piecewise linear triangular elements.

FEM2D_PROJECT, a FORTRAN90 program which projects a function f(x,y), given as a data, into a given finite element space of piecewise linear triangular elements.

FEM2D_PROJECT, a MATLAB program which projects a function f(x,y), given as data, into a given space associated with the finite element method (FEM) for piecewise linear triangular elements.

FEM2D_PROJECT_FUNCTION, a C++ program which projects a function f(x,y), given as a formula, into a given finite element space of piecewise linear triangular elements.

FEM2D_PROJECT_FUNCTION, a FORTRAN90 program which projects a function f(x,y), given as a formula, into a given finite element space of piecewise linear triangular elements.

FEM2D_PROJECT_FUNCTION, a MATLAB program which projects a function f(x,y), given as a formula, into a given finite element space of piecewise linear triangular elements.

FEM2D_SAMPLE, a C++ program which evaluates a finite element function defined on an order 3 or order 6 triangulation of a 2D region.

FEM2D_SAMPLE, a FORTRAN77 program which evaluates a finite element function defined on an order 3 or order 6 triangulation of a 2D region.

FEM2D_SAMPLE, a FORTRAN90 program which evaluates a finite element function defined on an order 3 or order 6 triangulation of a 2D region.

FEM2D_SAMPLE, a MATLAB program which evaluates a finite element function defined on an order 3 or order 6 triangulation of a 2D region.

FEM2D_SCALAR_DISPLAY, a MATLAB program which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a surface plot of U(X,Y), using the MATLAB graphics system.

FEM2D_SCALAR_DISPLAY_BRIEF, a MATLAB program which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a surface plot of U(X,Y), using the MATLAB graphics system, in 5 lines of code.

FEM2D_SCALAR_DISPLAY_GPL, a MATLAB program which reads information about nodes, elements and nodal values for a 2D finite element method (FEM) and creates a GPL file describing a surface plot of U(X,Y), which can be displayed by gnuplot.

FEM2D_STOKES, a C++ program which solves the 2D incompressible Stokes equations in an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_STOKES, a FORTRAN90 program which solves the 2D incompressible Stokes equations in an arbitrary triangulated region. In order to run, it requires user-supplied routines that define problem data.

FEM2D_STOKES_CAVITY, a C++ library which contains the user-supplied routines necessary to run fem2d_stokes on the cavity problem.

FEM2D_STOKES_CAVITY, a FORTRAN90 library which contains the user-supplied routines necessary to run fem2d_stokes on the cavity problem.

FEM2D_STOKES_CHANNEL, a C++ library which contains the user-supplied routines necessary to run fem2d_stokes on the channel problem.

FEM2D_STOKES_CHANNEL, a FORTRAN90 library which contains the user-supplied routines necessary to run fem2d_stokes on the channel problem.

FEM2D_STOKES_INOUT, a C++ library which contains the user-supplied routines necessary to run fem2d_stokes on the inout problem.

FEM2D_STOKES_INOUT, a FORTRAN90 library which contains the user-supplied routines necessary to run fem2d_stokes on the inout problem.

FEM2D_STOKES_INOUT, a MATLAB library which contains the user-supplied routines necessary to run fem2d_stokes on the inout problem.

FEM2D_STOKES_SPARSE, a MATLAB program which solves the steady (time independent) incompressible Stokes equations on an arbitrary triangulated region, using the finite element method (FEM) and MATLAB's sparse() function.

FEM2D_STOKES_SPARSE_BIG_CAVITY, a MATLAB library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the big cavity problem.

FEM2D_STOKES_SPARSE_CAVITY, a MATLAB library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the cavity problem.

FEM2D_STOKES_SPARSE_CHANNEL, a MATLAB library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the channel problem.

FEM2D_STOKES_SPARSE_INOUT, a MATLAB library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the inout problem.

FEM2D_STOKES_SPARSE_SPIRAL, a MATLAB library which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the spiral problem.

FEM3D, a data directory which contains examples of 3D FEM files, text files that describe a 3D finite element geometry and associated nodal values.

FEM3D_PACK, a C++ library which contains utilities for 3D finite element method (FEM) calculations.

FEM3D_PACK, a FORTRAN90 library which contains utilities for 3D finite element method (FEM) calculations.

FEM3D_PACK, a MATLAB library which contains utilities for 3D finite element method (FEM) calculations.

FEM3D_PROJECT, a C++ program which projects a function F(X,Y,Z), given as tabulated data, into a space of piecewise linear tetrahedral elements associated with the finite element method (FEM).

FEM3D_PROJECT, a FORTRAN90 program which projects a function F(X,Y,Z), given as tabulated data, into a space of piecewise linear tetrahedral elements associated with the finite element method (FEM).

FEM3D_PROJECT, a MATLAB program which projects a function F(X,Y,Z), given as tabulated data, into a space of piecewise linear tetrahedral elements associated with the finite element method (FEM).

FEM3D_SAMPLE, a C++ program which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).

FEM3D_SAMPLE, a FORTRAN90 program which evaluates a finite element function defined on 3D tetrahedral mesh.

FEM3D_SAMPLE, a MATLAB program which evaluates a finite element function defined on 3D tetrahedral mesh.

FENICS, examples which illustrate the use of FENICS, a collection of free software with an extensive list of features for automated, efficient solution of partial differential equations (PDE's).

FENICS_TO_FEM, a FENICS script which illustrates how a mesh or scalar function computed by the FENICS program can be written to FEM files, which can then be used to create images, or as input to meshing programs or other analysis tools.

FENICS_TO_TXYV, a FENICS script which illustrates how a mesh or scalar function computed by the FENICS program can be written to a "t" file (triangulation), a "v" file (a scalar field) and an "xy" file (spatial coordinates), which can then be used to create images, or as input to meshing programs or other analysis tools.

FENICS_TO_TXYZ, a FENICS script which illustrates how a mesh or scalar function computed by the FENICS program can be written to a "t" file (triangulation) and "xyz" file (spatial coordinates and associated scalar value), which can then be used to create images, or as input to meshing programs or other analysis tools.

FENICS_TO_FEM, a FENICS script which illustrates how a mesh or scalar function computed by the FENICS program can be written to FEM files, which can then be used to create images, or as input to meshing programs or other analysis tools.

FERN, a MATLAB program which uses MATLAB graphics to display the Barnsley fractal fern.

FERN_OPENGL, a C program which uses OpenGL to display the Barnsley fractal fern.

FERN_OPENGL, a C++ program which uses OpenGL to display the Barnsley fractal fern.

FEYNMAN_KAC_1D, a C program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.

FEYNMAN_KAC_1D, a C++ program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.

FEYNMAN_KAC_1D, a FORTRAN77 program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.

FEYNMAN_KAC_1D, a FORTRAN90 program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.

FEYNMAN_KAC_1D, a MATLAB program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.

FEYNMAN_KAC_2D, a C program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.

FEYNMAN_KAC_2D, a C++ program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.

FEYNMAN_KAC_2D, a FORTRAN77 program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.

FEYNMAN_KAC_2D, a FORTRAN90 program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.

FEYNMAN_KAC_2D, a MATLAB program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.

FEYNMAN_KAC_3D, a C program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.

FEYNMAN_KAC_3D, a C++ program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.

FEYNMAN_KAC_3D, a FORTRAN77 program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.

FEYNMAN_KAC_3D, a FORTRAN90 program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.

FEYNMAN_KAC_3D, a MATLAB program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.

FFMPEG, examples which illustrate the use of FFMPEG, which is a very fast video and audio converter that can also grab from a live audio/video source. The most common use for FFMPEG is simple to convert a sequence of still images into a movie.

FFT_OPENMP, a C program which demonstrates the computation of a Fast Fourier Transform (FFT) in parallel, using OpenMP.

FFT_OPENMP, a C++ program which demonstrates the computation of a Fast Fourier Transform (FFT) in parallel, using OpenMP.

FFT_OPENMP, a FORTRAN77 program which demonstrates the computation of a Fast Fourier Transform (FFT) in parallel, using OpenMP.

FFT_OPENMP, a FORTRAN90 program which demonstrates the computation of a Fast Fourier Transform (FFT) in parallel, using OpenMP.

FFT_SERIAL, a C program which demonstrates the computation of a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.

FFT_SERIAL, a C++ program which demonstrates the computation of a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.

FFT_SERIAL, a FORTRAN77 program which demonstrates the computation of a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.

FFT_SERIAL, a FORTRAN90 program which demonstrates the computation of a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.

FFT_SERIAL, a MATLAB program which demonstrates the computation of a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.

FFTPACK4, a C library which implements the Fast Fourier Transform (FFT) by Paul Swarztrauber and Dick Valent, translated by Andrew Fernandes;

FFTPACK5, a FORTRAN77 library which implements the Fast Fourier Transform (FFT) by Paul Swarztrauber and Dick Valent;

FFTPACK5, a FORTRAN90 library which implements the Fast Fourier Transform (FFT) by Paul Swarztrauber and Dick Valent;

FFTPACK5.1, a FORTRAN77 library which implements the Fast Fourier Transform (FFT) by Paul Swarztrauber and Dick Valent;

FFTPACK5.1, a FORTRAN90 library which implements the Fast Fourier Transform (FFT) using single precision arithmetic, by Paul Swarztrauber and Dick Valent;

FFTPACK5.1D, a FORTRAN90 library which implements the Fast Fourier Transform (FFT) using double precision arithmetic, by Paul Swarztrauber and Dick Valent;

FFTW, FORTRAN77 programs which illustrate the use of the FFTW library for Fast Fourier Transforms (FFT), by Matteo Frigo and Steven Johnson.

fftw_test, C programs which illustrate the use of the FFTW library for Fast Fourier Transforms (FFT), by Matteo Frigo and Steven Johnson.

fftw_test, FORTRAN90 programs which illustrate the use of the FFTW library for Fast Fourier Transforms (FFT), by Matteo Frigo and Steven Johnson.

FIBONACCI_SPIRAL, a MATLAB program which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.

FILE_COLUMN_REVERSE, a FORTRAN90 program which creates a copy of a file in which the columns are reverse, that is, the characters on each line appear in reverse order.

FILE_INCREMENT, a MATLAB program which makes a copy of a file containing an integer array, after incrementing each entry by a given value.

FILE_MERGE, a FORTRAN90 program which merges two sorted files.

FILE_NAME_SEQUENCE, a C program which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.

FILE_NAME_SEQUENCE, a C++ program which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.

FILE_NAME_SEQUENCE, a FORTRAN77 program which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.

FILE_NAME_SEQUENCE, a FORTRAN90 program which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.

FILE_NAME_SEQUENCE, a MATLAB program which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.

FILE_NAME_SEQUENCE, a Python program which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.

FILE_ROW_REVERSE, a FORTRAN90 program which makes a copy of a file with the lines (rows) in reverse order.

FILE_TRANSPOSE, a FORTRAN90 program which makes a transposed copy of a file, in which the I-th word of the J-th line becomes the J-th word of the I-th line.

FILES_MULTIPLE, a C program which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.

FILES_MULTIPLE, a C++ program which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.

FILES_MULTIPLE, a FORTRAN77 program which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.

FILES_MULTIPLE, a FORTRAN90 program which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.

FILES_MULTIPLE, a MATLAB program which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.

FILON, a C library which can approximate integrals in which the integrand includes an oscillatory factor of sin(k*x) or cos(k*x).

FILON, a C++ library which can approximate integrals in which the integrand includes an oscillatory factor of sin(k*x) or cos(k*x).

FILON, a FORTRAN77 library which can approximate integrals in which the integrand includes an oscillatory factor of sin(k*x) or cos(k*x).

FILON, a FORTRAN90 library which can approximate integrals in which the integrand includes an oscillatory factor of sin(k*x) or cos(k*x).

FILON, a MATLAB library which can approximate integrals in which the integrand includes an oscillatory factor of sin(k*x) or cos(k*x).

FILUM, a C library which can work with information in text files.

FILUM, a C++ library which can work with information in text files.

FILUM, a FORTRAN77 library which can work with information in text files.

FILUM, a FORTRAN90 library which can work with information in text files.

FILUM, a MATHEMATICA library which can work with information in text files.

FILUM, a MATLAB library which can work with information in text files.

FILUM, a Python library which can work with information in text files.

FINGERPRINTS, a dataset directory which contains a few images of fingerprints.

FIRE_SERIAL, a C program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.

FIRE_SERIAL, a C++ program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.

FIRE_SERIAL, a FORTRAN77program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.

FIRE_SERIAL, a FORTRAN90 program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.

FIRE_SERIAL, a MATLAB program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.

FIRE_SERIAL, a Python program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.

FISHPACK, a FORTRAN77 library which solves the Poisson, Laplace, or Helmholtz equation in 2D or 3D on a variety of geometries, by Paul Swarztrauber and Roland Sweet.

FIXCON, a FORTRAN90 program which reads a FORTRAN file using FORTRAN77 continuation statements, and makes a copy that uses FORTRAN90 continuation instead.

FLAME_ODE, a MATLAB library which considers an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process.

FLANN examples which illustrate the use of the FLANN package, which computes approximate nearest neighbors of multidimensional pointsets.

FLINT examples which illustrate the use of the FLINT library, which supports number theory using fast algorithms and arbitrarily large integer and rational values.

FLOOD_OPENGL, a C program which uses OpenGL to allow the user to select regions of a 2D image and flood them with color, by Art Wetzel.

FLORIDA_CVT_GEO, MATLAB programs which explore the creation of a centroidal Voronoi Tessellation (CVT) of the state of Florida, based solely on geometric considerations.

FLORIDA_CVT_GEO, Python functions which explore the creation of a centroidal Voronoi Tessellation (CVT) of the state of Florida, based solely on geometric considerations.

FLORIDA_CVT_POP, MATLAB programs which explore the creation of a centroidal Voronoi Tessellation (CVT) of the state of Florida, based on population density.

FLORIDA_CVT_POP, Python programs which explore the creation of a centroidal Voronoi Tessellation (CVT) of the state of Florida, based on population density.

FLOYD, a C library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.

FLOYD, a C++ library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.

FLOYD, a FORTRAN77 library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.

FLOYD, a FORTRAN90 library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.

FLOYD, a MATLAB library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.

FLOYD_PARALLEL, a MATLAB program which attempts to run a parallel implementation of Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.

FLUENT, examples which illustrate the use of FLUENT, which is a computational fluid dynamics solver that is part of the ANSYS suite.

FMINCON, MATLAB programs which illustrate the use of fmincon() in MATLAB's Optimization Toolbox which seeks the minimizer of a scalar function of multiple variables, within a region specified by linear constraints and bounds.

FMINCON_PARALLEL, a MATLAB program which demonstrates the use of MATLAB's fmincon() constrained minimization function, taking advantage of MATLAB's Parallel Computing Toolbox for faster execution.

FMM2D, a FORTRAN77 library which implements the fast multipole method, by Leslie Greengard and Zydrunas Gimbutas.

FN, a C library which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, Dawson's integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.

FN, a C++ library which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, Dawson's integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.

FN, a FORTRAN77 library which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, Dawson's integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.

FN, a FORTRAN90 library which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, Dawson's integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.

FN, a MATLAB library which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, Dawson's integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.

FN, a Python library which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, Dawson's integral, digamma (psi), error, exponential integral, gamma, hyperbolic cosine integral, hyperbolic sine integral, incomplete gamma, log gamma, logarithmic integral, Pochhammer, psi, sine integral, Spence;, by Wayne Fullerton.

FOOTBALL, a FORTRAN90 program which ranks college football teams.

FOREST_FIRE_SIMULATION, a C program which simulates the occurrence of fires and regrowth in a forest, displaying the results using X Windows, by Michael Creutz.

FOUR_FIFTHS, a Python library which searches for a solution to the problem of finding four fifth powers that sum to a fifth power, that is, integers a, b, c, d and e such that a^5+b^5+c^5+d^5=e^5. Euler conjectured that no solution was possible. The code is by Brian Hayes.

FREEFEM++, examples which illustrate the use of the FREEFEM++ package, a high-level integrated development environment for the numerical solution of nonlinear multiphysics partial differential equations (PDE's) in 2D and 3D.

FREEFEM++_MSH, a data directory which contains examples of the mesh files created by the FreeFem++ program, which use the extension ".msh".

FREEFEM++_MSH_IO, a C library which can read and write files used by the FreeFem++ finite element program to store mesh information.

FREEFEM++_MSH_IO, a C++ library which can read and write files used by the FreeFem++ finite element program to store mesh information.

FREEFEM++_MSH_IO, a FORTRAN77 library which can read and write files used by the FreeFem++ finite element program to store mesh information.

FREEFEM++_MSH_IO, a FORTRAN90 library which can read and write files used by the FreeFem++ finite element program to store mesh information.

FREEFEM++_MSH_IO, a Matlab library which can read and write files used by the FreeFem++ finite element program to store mesh information.

FREEFEM++_MSH_IO, a Python library which can read and write files used by the FreeFem++ finite element program to store mesh information.

FRIEZE, a FORTRAN90 program which demonstrates how to map a pattern repeatedly into a (distorted) 2D region to create a sort of wallpaper;

FROBENIUS, a MATHEMATICA library which is useful for the Froebenius problem, also known as the postage stamp problem.

FSU_DAKOTA, a C++ library which implements a variety of methods for the generation of Quasi Monte Carlo (QMC) numbers, submitted for inclusion in the Sandia Labs DAKOTA package;

FUNCTIONS_OPENMP, a C program which demonstrates the behavior of a few of the OpenMP library functions.

G++_INTRINSICS, a C++ program which illustrates the use of some of the intrinsic functions provided by the Gnu G++ compiler for C++.

G++_QUADMATH, a C++ program which illustrates the use of quadruple precision real arithmetic provided on some systems by the Gnu G++ compiler for C++.

G77_INTRINSICS, a FORTRAN77 program which illustrates the use of intrinsic functions provided by the Gnu G77 compiler for FORTRAN77.

G95_INTRINSICS, a FORTRAN90 program which illustrates the use of intrinsic functions provided by the G95 compiler for FORTRAN.

G95_QUADMATH, a FORTRAN90 program which illustrates the use of quadruple precision real arithmetic provided on some systems by the G95 compiler for FORTRAN.

GA, examples which illustrate the use of GA, which is the global arrays toolkit, which simulates shared memory in a distributed memory computation.

GAMBLERS_RUIN_SIMULATION, a MATLAB program which simulates the game of gambler's ruin.

GATB, examples which illustrate the use of GATB, which is a genome analysis toolbox.

GATK, examples which illustrate the use of GATK, which is a genome analsis toolkit for variant discovery in High Throughput Sequencing (HTS) data.

GAUSS_SEIDEL, a MATLAB library which implements the Gauss-Seidel iteration for linear systems.

GAUSS_SEIDEL_POISSON_1D, a MATLAB program which demonstrates how the linear system for a discretized version of the steady (time independent) 1D Poisson equation can be solved by the Gauss-Seidel iteration.

GAUSSIAN98, examples which illustrate the use of the Gaussian 98 quantum chemistry program.

GAUSSIAN03, examples which illustrate the use of the Gaussian 03 quantum chemistry program.

GAUSSIAN09, examples which illustrate the use of the Gaussian 09 quantum chemistry program.

GCC_INTRINSICS, a C program which demonstrates or tests some of the intrinsic functions made available by the Gnu GCC compiler for C.

GCC_QUADMATH, a C program which illustrates the use of quadruple precision real arithmetic provided on some systems by the Gnu GCC compiler for C.

GDAL examples which illustrate the use of GDAL, which is the Geospatial Data Abstraction Library, for reading and writing files of raster and vector geospatial data.

GDB, FORTRAN77 programs which illustrate the use of the GNU debugger program;

GDB, FORTRAN90 programs which illustrate the use of the GNU debugger program;

GDK examples which illustrate the use of GDK, which is the NVIDIA GPU Deployment kit.

GEGENBAUER_CC, a C library which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.

GEGENBAUER_CC, a C++ library which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.

GEGENBAUER_CC, a FORTRAN90 library which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.

GEGENBAUER_CC, a MATLAB library which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.

GEGENBAUER_CC, a Python library which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.

GEGENBAUER_EXACTNESS, a C++ program which tests the monomial exactness of Gauss-Gegenbauer quadrature rules.

GEGENBAUER_EXACTNESS, a FORTRAN90 program which tests the monomial exactness of Gauss-Gegenbauer quadrature rules.

GEGENBAUER_EXACTNESS, a MATLAB program which tests the monomial exactness of Gauss-Gegenbauer quadrature rules.

GEGENBAUER_POLYNOMIAL, a C library which evaluates the Gegenbauer polynomial and associated functions.

GEGENBAUER_POLYNOMIAL, a C++ library which evaluates the Gegenbauer polynomial and associated functions.

GEGENBAUER_POLYNOMIAL, a FORTRAN90 library which evaluates the Gegenbauer polynomial and associated functions.

GEGENBAUER_POLYNOMIAL, a MATLAB library which evaluates the Gegenbauer polynomial and associated functions.

GEGENBAUER_POLYNOMIAL, a Python library which evaluates the Gegenbauer polynomial and associated functions.

GEGENBAUER_RULE, a C++ program which can compute and print a Gauss-Gegenbauer quadrature rule.

GEGENBAUER_RULE, a FORTRAN90 program which can compute and print a Gauss-Gegenbauer quadrature rule.

GEGENBAUER_RULE, a MATLAB program which can compute and print a Gauss-Gegenbauer quadrature rule.

GEN_HERMITE_RULE, a C++ program which can compute and print a generalized Gauss-Hermite quadrature rule.

GEN_HERMITE_RULE, a FORTRAN90 program which can compute and print a generalized Gauss-Hermite quadrature rule.

GEN_HERMITE_RULE, a MATLAB program which can compute and print a generalized Gauss-Hermite quadrature rule.

GEN_LAGUERRE_RULE, a C++ program which can compute and print a generalized Gauss-Laguerre quadrature rule.

GEN_LAGUERRE_RULE, a FORTRAN90 program which can compute and print a generalized Gauss-Laguerre quadrature rule.

GEN_LAGUERRE_RULE, a MATLAB program which can compute and print a generalized Gauss-Laguerre quadrature rule.

GENE_CLUSTER, a FORTRAN90 program which clusters sets of genetic expression data;

GENERALIZED_ASSIGNMENT, a dataset directory which contains test data for the generalized assignment problem;

GEOMETRY, a C library which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.

GEOMETRY, a C++ library which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.

GEOMETRY, a FORTRAN77 library which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.

GEOMETRY, a FORTRAN90 library which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.

GEOMETRY, a MATLAB library which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.

GEOMETRY, a Python library which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.

GEOMPACK, a C library which can compute Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.

GEOMPACK, a C++ library which can compute Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.

GEOMPACK, a FORTRAN77 library which can compute Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.

GEOMPACK, a FORTRAN90 library which can compute Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.

GEOMPACK, a MATLAB library which can compute Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.

GEOMPACK2, a FORTRAN90 library which computes the Delaunay triangulation of 2D data, by Barry Joe.

GEOS examples which illustrate the use of GEOS, which is an open source geometry engine.

GEQP3, a FORTRAN77 library 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, a FORTRAN90 library 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.

GERMAN, a dataset directory which contains some short German texts;

GETWGT, a FORTRAN90 library which estimates the parameters of a Dirichlet mixture.

GFORTRAN, FORTRAN90 programs which investigate the use of the Gnu gfortran compiler for FORTRAN77.

GFORTRAN, FORTRAN90 programs which investigate the use of the Gnu gfortran compiler for FORTRAN90.

GFORTRAN_INTRINSICS, a FORTRAN77 program which illustrates the use of intrinsic functions provided by the Gnu gfortran compiler for FORTRAN77.

GFORTRAN_INTRINSICS, a FORTRAN90 program which illustrates the use of intrinsic functions provided by the Gnu gfortran compiler for FORTRAN90.

GFORTRAN_QUADMATH, a FORTRAN77 program which illustrates the use of quadruple precision real arithmetic provided on some systems by the Gnu gfortran compiler for FORTRAN77.

GFORTRAN_QUADMATH, a FORTRAN90 program which illustrates the use of quadruple precision real arithmetic provided on some systems by the Gnu gfortran compiler for FORTRAN90.

GIF, a data directory which contains examples of GIF files, a 2D graphics file format;

GL_DISPLAY, a MATLAB program which displays the points used in a 2D Gauss-Legendre quadrature rule;

GCC, examples which illustrate the use of GCC, which is the Gnu Compiler Collection, whose main component is the Gnu C Compiler gcc.

glacier, a FENICS script which sets up the 2D steady Stokes equations to model the movement of a glacier, by William Mitchell.

GLM, examples which illustrate the use of GLM, which is the OpenGL Mathematical Library.

GLOG, examples which illustrate the use of GLOG, which is the Google logging facility, which allows a C++ program, as it executes, to record incidents of INFO, WARNING, ERROR, or FATAL type, and to write corresponding messages to files. The user can control various aspects of the logging procedure, including limiting the total number of messages, or only printing messages during DEBUG runs, and so on. GLOG also provicdes a "check" feature, similar to the assert statement in C, which terminates execution if a given condition is not satisfied.

GMGSOLVE, a Python library which can apply one step of the V-cycle of the geometric multigrid method, by Mike Sussman.

GMSH, examples which illustrate the use of the Gmsh program, a 1D, 2D or 3D mesh generator that can create meshes suitable for use by the finite element method (FEM).

GMSH_IO, a C library which can read or write some of the files created by the Gmsh program for 1D, 2D or 3D meshes used by the finite element method (FEM).

GMSH_IO, a C++ library which can read or write some of the files created by the Gmsh program for 1D, 2D or 3D meshes used by the finite element method (FEM).

GMSH_IO, a FORTRAN77 library which can read or write some of the files created by the Gmsh program for 1D, 2D or 3D meshes used by the finite element method (FEM).

GMSH_IO, a FORTRAN90 library which can read or write some of the files created by the Gmsh program for 1D, 2D or 3D meshes used by the finite element method (FEM).

GMSH_IO, a MATLAB library which can read or write some of the files created by the Gmsh program for 1D, 2D or 3D meshes used by the finite element method (FEM).

GMSH_TO_FEM, a C program which reads a mesh data file created by the GMSH program and writes a pair of node and element files that correspond to the FEM format.

GMSH_TO_FEM, a C++ program which reads a mesh data file created by the GMSH program and writes a pair of node and element files that correspond to the FEM format.

GMSH_TO_FEM, a FORTRAN77 program which reads a mesh data file created by the GMSH program and writes a pair of node and element files that correspond to the FEM format.

GMSH_TO_FEM, a FORTRAN90 program which reads a mesh data file created by the GMSH program and writes a pair of node and element files that correspond to the FEM format.

GMSH_TO_FEM, a MATLAB program which reads a mesh data file created by the GMSH program and writes a pair of node and element files that correspond to the FEM format.

GMT, examples which illustrate the use of GMT, which is an open source collection of command-line tools for manipulating geographic and Cartesian data sets and producing PostScript images of the results.

GNUFOR, a FORTRAN77 library which provides an interface to the gnuplot graphics library.

GNUFOR, a FORTRAN90 library which provides an interface to the gnuplot graphics library.

GNUPLOT, examples which illustrate the use of the gnuplot graphics program.

gnuplot_test, C programs which illustrate how a program can write data and command files so that gnuplot can create plots of the program results.

gnuplot_test, C++ programs which illustrate how a program can write data and command files so that gnuplot can create plots of the program results.

GNUPLOT, FORTRAN77 programs which illustrate how a program can write data and command files so that gnuplot can create plots of the program results.

gnuplot_test, FORTRAN90 programs which illustrate how a program can write data and command files so that gnuplot can create plots of the program results.

gnuplot_test, MATLAB programs which illustrate how a program can write data and command files so that gnuplot can create plots of the program results.

GNUPLOT_I, a C library which allows an executing C or C++ program to interact with the gnuplot graphics program, by Nicholas Devillard.

GNUPLOT_I_EXAMPLES, C programs which demonstrate the use of the gnuplot_i library for interactive runtime gnuplot graphics.

GNUPLOT_I_EXAMPLES, C++ programs which demonstrate the use of the gnuplot_i library for interactive runtime gnuplot graphics.

GPL, a data directory which contains examples of GPL files, a graphics file format used by gnuplot;

GPL_DISPLAY, a MATLAB library which tries to read the data in a typical gnuplot GPL file, describing a 1D, 2D or 3D curve, or a surface Z(X,Y) defined on a regular grid, a triangular grid, or an irregular quadrilateral grid, displays it in a more attractive way than gnuplot is capable of.

gprof_test, C programs which illustrate the use of the gprof program performance monitor;

gprof_test, C++ programs which illustrate the use of the gprof program performance monitor;

gprof_test, FORTRAN77 programs which illustrate the use of the gprof program performance monitor;

gprof_test, FORTRAN90 programs which illustrate the use of the gprof program performance monitor;

GRAFFITI, a dataset directory which contains 195 abstract graphs, with adjacency and embedding information, stored in the grf format.

GRAFPACK, a FORTRAN90 library which carries out operations on abstract graphs.

GRAPH_PAPER, a FORTRAN90 library which makes PostScript (PS) graph paper using rectangular, triangular, or hexagonal grids.

GRAPH_REPRESENTATION, a data directory which contains various representations of abstract mathematical graphs.

GRAPH_REPRESENTATION, a MATLAB library which can express the representation of an abstract mathematical graph in several ways.

GRAPHICS_EXAMPLES, C programs which illustrate how various kinds of data can be displayed and analyzed graphically.

GRAPHICS_EXAMPLES, C++ programs which illustrate how various kinds of data can be displayed and analyzed graphically.

GRAPHICS_EXAMPLES, FORTRAN77 programs which illustrate how various kinds of data can be displayed and analyzed graphically.

GRAPHICS_EXAMPLES, FORTRAN90 programs which illustrate how various kinds of data can be displayed and analyzed graphically.

GRAPHICS_EXAMPLES, a dataset directory which contains examples of data used to illustrate or test various graphics procedures for presenting and analyzing data.

GRAPHICS_EXAMPLES, MATHEMATICA programs which illustrate how various kinds of data can be displayed and analyzed graphically.

GRAPHICS_EXAMPLES, MATLAB programs which illustrate how various kinds of data can be displayed and analyzed graphically.

GRAPHICS_EXAMPLES, Python programs which illustrate how various kinds of data can be displayed and analyzed graphically.

GRAPHICS_EXAMPLES_CONVERT, examples which illustrate how various kinds of data can be processed and modified using the ImageMagick program convert() and its related tools.

GRAPHICS_EXAMPLES_DISLIN, examples which illustrate how various kinds of data can be displayed and analyzed graphically using the graphics library dislin.

GRAPHICS_EXAMPLES_GNUPLOT, examples which illustrate how various kinds of data can be displayed and analyzed graphically using the interactive executable graphics program gnuplot().

GRAPHICS_EXAMPLES_GRACE, examples which illustrate how various kinds of data can be displayed and analyzed graphically using the interactive executable graphics program grace().

GRAPHICS_EXAMPLES_OCTAVE, examples which illustrate how various kinds of data can be displayed and analyzed graphically, using the interactive executable graphics program octave().

GRAPHICS_EXAMPLES_PLOTLY1, examples which illustrate how various kinds of data can be displayed and analyzed graphically, using the plotly() program (version 1) from a browser.

GRAY_CODE_DISPLAY, a MATLAB program which computes the Hamming distance tables for both the binary and Gray codes, and displays 3D plots that illustrate how the Gray code does a better job of providing nearby representations for nearby numbers.

GRF, a data directory which contains examples of GRF files, an abstract graph file format, 2D graphics;

GRF_DISPLAY, a MATLAB program which reads a GRF file defining a mathematical graph and displays it in the MATLAB graphics window.

GRF_DISPLAY_OPENGL, a C++ program which reads a GRF file defining a mathematical graph and displays it in an OpenGL graphics window.

GRF_IO, a C++ library which reads or writes a GRF file;

GRF_IO, a FORTRAN90 library which reads or writes a GRF file;

GRF_IO, a MATLAB library which reads or writes a GRF file;

GRF_TO_EPS, a FORTRAN90 program which converts a GRF file to Encapsulated PostScript (EPS) format;

GRF_TO_XYL, a FORTRAN90 program which converts information describing the adjacency and embedding of an abstract graph from GRF to XYL format.

GRID, a dataset directory which contains examples of sets of points on a uniform grid, with random holes;

GRID, a C library which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.

GRID, a C++ library which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.

GRID, a FORTRAN90 library which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.

GRID, a MATLAB library which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.

GRID, a Python library which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.

GRID_DISPLAY, a MATLAB program which reads a file of points on a grid or sparse grid, displays the grid and saves the image in a Portable Network Graphics (PNG) file;

GRID_TO_BMP, a C++ program which reads a text file of data on a rectangular grid and creates a BMP graphics file containing a color image of the data.

GRIDLINES, a MATLAB library which gives the user more control over drawing gridlines on a graph than the builtin grid command.

GRIDS_DISPLAY, a MATLAB program which reads two files of grids or sparse grids, displays the first with hollow blue dots, the second with red dots.

GROMACS, examples which illustrate the use of GROMACS, a program for molecular dynamics simulation and energy minimization.

GSHHG examples which illustrate the use of GSHHG, which is a global geographic database used by GMT.

gsl_test, C++ programs which illustrate the use of the Gnu Scientific Library (GSL), which includes functions to solve linear systems;

gsl, examples which illustrate the use of GSL, which is the Gnu Scientific Library;

guile, examples which illustrate the use of GUILE, which is the Gnu programming and extension language;

gurobi_solution_read, a MATLAB program which reads a file created by the optimization package GUROBI, representing the solution of a polyomino tiling problem, and writes out a simple ASCII file that can be read by load().

haar, a C library which computes the Haar transform of data.

haar, a C++ library which computes the Haar transform of data.

haar, a FORTRAN77 library which computes the Haar transform of data.

haar, a FORTRAN90 library which computes the Haar transform of data.

haar, a MATLAB library which computes the Haar transform of data.

haar, a Python library which computes the Haar transform of data.

HALTON, a dataset directory which contains examples of the Halton Quasi Monte Carlo (QMC) sequence;

HALTON, a C library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.

HALTON, a C++ library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.

HALTON, a FORTRAN90 library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.

HALTON, a MATLAB library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.

HALTON, a Python library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.

HALTON_ADVANCED, a C++ library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using an advanced interface with many input options.

HALTON_ADVANCED, a FORTRAN90 library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using an advanced interface with many input options.

HALTON_ADVANCED, a MATLAB library which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using an advanced interface with many input options.

HALTON_DATASET, a C++ program which creates a Halton Quasi Monte Carlo (QMC) sequence and writes it to a file.

HALTON_DATASET, a FORTRAN90 program which creates a Halton Quasi Monte Carlo (QMC) sequence and writes it to a file.

HALTON_DATASET, a MATLAB program which creates a Halton Quasi Monte Carlo (QMC) sequence and writes it to a file.

HAMMERSLEY, a dataset directory which contains examples of the Hammersley Quasi Monte Carlo (QMC) sequence.

HAMMERSLEY, a C library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.

HAMMERSLEY, a C++ library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.

HAMMERSLEY, a FORTRAN90 library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.

HAMMERSLEY, a MATLAB library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.

HAMMERSLEY, a Python library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.

HAMMERSLEY_ADVANCED, a C++ library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence using an advanced interface with many input options.

HAMMERSLEY_ADVANCED, a FORTRAN90 library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence using an advanced interface with many input options.

HAMMERSLEY_ADVANCED, a MATLAB library which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence using an advanced interface with many input options.

HAMMERSLEY_DATASET, a C++ program which creates a Hammersley sequence and writes it to a file.

HAMMERSLEY_DATASET, a FORTRAN90 program which creates a Hammersley sequence and writes it to a file.

HAMMERSLEY_DATASET, a MATLAB program which creates a Hammersley sequence and writes it to a file.

HAMMING, a MATLAB library which implements some simple versions of Hamming codes which can detect and correct errors in data.

HAND_AREA, a MATLAB program which estimates the area of a curve which outlines a person's hand.

HAND_DATA, MATLAB programs which carry out some numerical exercises based on data that came from tracing several points on a person's hand.

HANKEL_CHOLESKY, a C library which computes the upper Cholesky factor R of a nonnegative definite symmetric Hankel matrix H so that H = R' * R..

HANKEL_CHOLESKY, a C++ library which computes the upper Cholesky factor R of a nonnegative definite symmetric Hankel matrix H so that H = R' * R..

HANKEL_CHOLESKY, a FORTRAN90 library which computes the upper Cholesky factor R of a nonnegative definite symmetric Hankel matrix H so that H = R' * R..

HANKEL_CHOLESKY, a MATLAB library which computes the upper Cholesky factor R of a nonnegative definite symmetric Hankel matrix H so that H = R' * R..

HANKEL_CHOLESKY, a Python library which computes the upper Cholesky factor R of a nonnegative definite symmetric Hankel matrix H so that H = R' * R..

HANKEL_PDS, a C library which can compute a lower triangular matrix L which is the Cholesky factor of a positive definite (symmetric) Hankel matrix H, that is, H = L * L'.

HANKEL_PDS, a C++ library which can compute a lower triangular matrix L which is the Cholesky factor of a positive definite (symmetric) Hankel matrix H, that is, H = L * L'.

HANKEL_PDS, a FORTRAN library which can compute a lower triangular matrix L which is the Cholesky factor of a positive definite (symmetric) Hankel matrix H, that is, H = L * L'.

HANKEL_PDS, a MATLAB library which can compute a lower triangular matrix L which is the Cholesky factor of a positive definite (symmetric) Hankel matrix H, that is, H = L * L'.

HANKEL_PDS, a Python library which can compute a lower triangular matrix L which is the Cholesky factor of a positive definite (symmetric) Hankel matrix H, that is, H = L * L'.

HARFBUZZ: examples which illustrate the use of HARFBUZZ, which is a text-shaping engine.

HARTIGAN, a dataset directory which contains datasets for testing clustering algorithms;

HB, a data directory which contains examples of Harwell Boeing (HB) files, a sparse matrix file format;

HB_IO, a C library which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices. This library is intended to handle the full range of HB formats.

HB_IO, a C++ library which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices. This library is intended to handle the full range of HB formats.

HB_IO, a FORTRAN90 library which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices. This library is intended to handle the full range of HB formats.

HB_IO, a MATLAB library which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices. This library is intended to handle the full range of HB formats.

HB_IO_NEW, a C++ library which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices. This library is intended to handle the full range of HB formats. This is a version of HB_IO that has been revised and improved by Reinhard Resch.

HB_READ, a FORTRAN77 library 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, a FORTRAN90 library 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_TO_MM, a MATLAB program which converts a sparse matrix from Harwell Boeing (HB) to Matrix Market (MM) format.

HB_TO_MSM, a MATLAB program which converts a sparse matrix stored in a Harwell Boeing (HB) format to MATLAB sparse matrix format;

HB_TO_ST, a FORTRAN77 program which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.

HB_TO_ST, a FORTRAN90 program which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.

HB_TO_ST, a MATLAB program which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.

HBSMC, a dataset directory which contains the Harwell Boeing Sparse Matrix Collection (HBSMC);

HCELL, a FORTRAN77 program which solves the time-dependent 2D incompressible Navier Stokes equations (NSE) in an H-shaped region.

HCELL_FLOW_DISPLAY, a MATLAB program which plots the physical data, pressures or velocities, from a run of the hcell program;

HCELL_STEADY, a FORTRAN77 program which solves the steady (time independent) incompressible Navier Stokes equations (NSE) in a 2D H-shaped region, by Hyung-Chun Lee.

HDF, a data directory which contains examples of HDF files, a general scientific data file format;

HDF5, examples which illustrate the use of HDF5, a file format, library, and utility programs for efficiently managing large and complex datasets.

hdf5_test, C programs which demonstrate the use of the HDF5 library and file format.

hdf5_test, C++ programs which demonstrate the use of the HDF5 library and file format.

hdf5_test, FORTRAN90 programs which demonstrate the use of the HDF5 library and file format.

hdf5_test, Python scripts which demonstrate the use of the HDF5 library and file format.

heat_explicit, a FENICS script which uses the finite element method to solve a version of the time dependent heat equation over a rectangular region with a circular hole. Time steps are handled using an explicit method.

heat_implicit, a FENICS script which uses the finite element method to solve a version of the time dependent heat equation over a rectangular region with a circular hole. Time steps are handled using an implicit solver.

HEAT_MPI, a C program which solves the 1D time dependent heat equation in parallel, using the Message Passing Interface (MPI).

HEAT_MPI, a C++ program which solves the 1D time dependent heat equation in parallel, using MPI.

HEAT_MPI, a FORTRAN77 program which solves the 1D time dependent heat equation in parallel, using MPI.

HEAT_MPI, a FORTRAN90 program which solves the 1D time dependent heat equation in parallel, using MPI.

HEAT_ONED, a MATLAB program which solves the time-dependent 1D heat equation, using the finite element method in space, and the backward Euler method in time, by Jeff Borggaard.

heat_steady, FENICS scripts which set up the 2D steady heat equation in a rectangle.

HEATED_PLATE, a C program which solves the steady (time independent) heat equation in a 2D rectangular region, and is intended as a starting point for implementing a parallel version.

HEATED_PLATE, a C++ program which solves the steady (time independent) heat equation in a 2D rectangular region, and is intended as a starting point for implementing a parallel version.

HEATED_PLATE, a FORTRAN77 program which solves the steady (time independent) heat equation in a 2D rectangular region, and is intended as a starting point for implementing a parallel version.

HEATED_PLATE, a FORTRAN90 program which solves the steady (time independent) heat equation in a 2D rectangular region, and is intended as a starting point for implementing a parallel version.

HEATED_PLATE, a MATLAB program which solves the steady (time independent) heat equation in a 2D rectangular region, and is intended as a starting point for implementing a parallel version.

HEATED_PLATE_OPENMP, a C program which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.

HEATED_PLATE_OPENMP, a C++ program which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.

HEATED_PLATE_OPENMP, a FORTRAN77 program which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.

HEATED_PLATE_OPENMP, a FORTRAN90 program which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.

HEATED_PLATE_PARFOR, a MATLAB program which solves the steady (time independent) heat equation in a 2D rectangular region, using MATLAB's parfor facility to run in parallel.

HEATED_PLATE_WORKSHARE, a FORTRAN90 program which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP's WORKSHARE directive to run in parallel (however, the results suggest that WORKSHARE is not supported by the Gnu gfortran and Intel IFORT compilers!)

HECHT_FREEFEM++ examples which accompanied the standard reference paper for FREEFEM++, used by Frederic Hecht to illustrate special features of the program.

HELLO, a C program which prints out "Hello, world!".

HELLO, a C++ program which prints out "Hello, world!".

HELLO, a FORTRAN77 program which prints out "Hello, world!".

HELLO, a FORTRAN90 program which prints out "Hello, world!".

HELLO, a Julia program which prints out "Hello, world!".

HELLO, a MATLAB program which prints out "Hello, world!".

HELLO, a Python program which prints out "Hello, world!".

HELLO, an R function which prints out "Hello, world!".

HELLO_MPI, a C program which prints out "Hello, world!" using the MPI parallel programming environment.

HELLO_MPI, a C++ program which prints out "Hello, world!" using the MPI parallel programming environment.

HELLO_MPI, a FORTRAN77 program which prints out "Hello, world!" using the MPI parallel programming environment.

HELLO_MPI, a FORTRAN90 program which prints out "Hello, world!" using the MPI parallel programming environment.

HELLO_MPI, a Python program which prints out "Hello, world!" using the MPI parallel programming environment, under MPI4PY.

HELLO_OPENMP, a C program which prints out "Hello, world!" using the OpenMP parallel programming environment.

HELLO_OPENMP, a C++ program which prints out "Hello, world!" using the OpenMP parallel programming environment.

HELLO_OPENMP, a FORTRAN77 program which prints out "Hello, world!" using the OpenMP parallel programming environment.

HELLO_OPENMP, a FORTRAN90 program which prints out "Hello, world!" using the OpenMP parallel programming environment.

HELLO_PARFOR, a MATLAB program which prints out "Hello, world!" multiple times, using MATLAB's parfor command for parallel execution.

HERE_DOCUMENT, examples which illustrate the use of "here documents", little helper text files which can be created on the fly by a script.

HERMITE, a C library which computes the Hermite interpolant, a polynomial that matches function values and derivatives.

HERMITE, a C++ library which computes the Hermite interpolant, a polynomial that matches function values and derivatives.

HERMITE, a FORTRAN77 library which computes the Hermite interpolant, a polynomial that matches function values and derivatives.

HERMITE, a FORTRAN90 library which computes the Hermite interpolant, a polynomial that matches function values and derivatives.

HERMITE, a MATLAB library which computes the Hermite interpolant, a polynomial that matches function values and derivatives.

HERMITE_CUBIC, a C library which can compute the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.

HERMITE_CUBIC, a C++ library which can compute the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.

HERMITE_CUBIC, a FORTRAN77 library which can compute the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.

HERMITE_CUBIC, a FORTRAN90 library which can compute the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.

HERMITE_CUBIC, a MATLAB library which can compute the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.

HERMITE_EXACTNESS, a C program which tests the monomial exactness of quadrature rules for estimating Hermite-type integrals of a function f(x) with density rho(x)=exp(-x^2) over the interval (-oo,+oo).

HERMITE_EXACTNESS, a C++ program which tests the monomial exactness of quadrature rules for estimating Hermite-type integrals of a function f(x) with density rho(x)=exp(-x^2) over the interval (-oo,+oo).

HERMITE_EXACTNESS, a FORTRAN77 program which tests the monomial exactness of quadrature rules for estimating Hermite-type integrals of a function f(x) with density rho(x)=exp(-x^2) over the interval (-oo,+oo).

HERMITE_EXACTNESS, a FORTRAN90 program which tests the monomial exactness of quadrature rules for estimating Hermite-type integrals of a function f(x) with density rho(x)=exp(-x^2) over the interval (-oo,+oo).

HERMITE_EXACTNESS, a MATLAB program which tests the monomial exactness of quadrature rules for estimating Hermite-type integrals of a function f(x) with density rho(x)=exp(-x^2) over the interval (-oo,+oo).

HERMITE_POLYNOMIAL, a C library which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.

HERMITE_POLYNOMIAL, a C++ library which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.

HERMITE_POLYNOMIAL, a FORTRAN77 library which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.

HERMITE_POLYNOMIAL, a FORTRAN90 library which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.

HERMITE_POLYNOMIAL, a MATLAB library which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.

HERMITE_PRODUCT_DISPLAY, a MATLAB program which displays an image of a function created by the Cartesian product of two Hermite polynomials, such as f(x,y) = h(3,x) * h(1,y).

HERMITE_PRODUCT_POLYNOMIAL, a C library which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.

HERMITE_PRODUCT_POLYNOMIAL, a C++ library which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.

HERMITE_PRODUCT_POLYNOMIAL, a FORTRAN77 library which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.

HERMITE_PRODUCT_POLYNOMIAL, a FORTRAN90 library which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.

HERMITE_PRODUCT_POLYNOMIAL, a MATLAB library which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.

HERMITE_RULE, a C program which can compute and print a Gauss-Hermite quadrature rule for estimating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).

HERMITE_RULE, a C++ program which can compute and print a Gauss-Hermite quadrature rule for estimating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).

HERMITE_RULE, a FORTRAN77 program which can compute and print a Gauss-Hermite quadrature rule for estimating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).

HERMITE_RULE, a FORTRAN90 program which can compute and print a Gauss-Hermite quadrature rule for estimating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).

HERMITE_RULE, a MATLAB program which can compute and print a Gauss-Hermite quadrature rule for estimating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).

HERMITE_TEST_INT, a C library which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).

HERMITE_TEST_INT, a C++ library which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).

HERMITE_TEST_INT, a FORTRAN77 library which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).

HERMITE_TEST_INT, a FORTRAN90 library which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).

HERMITE_TEST_INT, a MATLAB library which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).

HEX_GRID_ANGLE is a FORTRAN90 library which produces a hexagonal grid of points in the unit square or an arbitrary box, allowing the user to specify an arbitrary center, angle, and grid density.

HEX_GRID_DATASET is a FORTRAN90 program which allows the user to interactively create a dataset of points on a hexagonal grid.

HEX_GRID_TRIANGULATE is a FORTRAN90 program which picks out those points on a hex grid which lie inside a given triangulation region.

HEXDUMP, a C++ program which produces a hexadecimal dump of a file;

HIGH_CARD_PARFOR, a MATLAB program which uses the parfor statement to compute in parallel the statistics for a card game in which you are required to guess the location of the highest card.

HIGH_CARD_SIMULATION, a C program which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; the program uses gnuplot for graphics.

HIGH_CARD_SIMULATION, a C++ program which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; the program uses gnuplot for graphics.

HIGH_CARD_SIMULATION, a FORTRAN77 program which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; the program uses gnuplot for graphics.

HIGH_CARD_SIMULATION, a FORTRAN90 program which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; the program uses gnuplot for graphics.

HIGH_CARD_SIMULATION, a MATLAB program which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop.

HILBERT_CURVE, a C library which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.

HILBERT_CURVE, a C++ library which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.

HILBERT_CURVE, a FORTRAN90 library which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.

HILBERT_CURVE, a MATLAB library which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.

HILBERT_CURVE, a Python library which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.

HILBERT_CURVE_DISPLAY, a MATLAB library which can display a Hilbert curve of given order.

HISTOGRAM_DATA_2D_SAMPLE, a C program which demonstrates how to construct a Probability Density Function (PDF) from a frequency table over a 2D domain, and then to use that PDF to create new samples.

HISTOGRAM_DATA_2D_SAMPLE, a C++ program which demonstrates how to construct a Probability Density Function (PDF) from a frequency table over a 2D domain, and then to use that PDF to create new samples.

HISTOGRAM_DATA_2D_SAMPLE, a FORTRAN77 program which demonstrates how to construct a Probability Density Function (PDF) from a frequency table over a 2D domain, and then to use that PDF to create new samples.

HISTOGRAM_DATA_2D_SAMPLE, a FORTRAN90 program which demonstrates how to construct a Probability Density Function (PDF) from a frequency table over a 2D domain, and then to use that PDF to create new samples.

HISTOGRAM_DATA_2D_SAMPLE, a MATLAB program which demonstrates how to construct a Probability Density Function (PDF) from a frequency table over a 2D domain, and then to use that PDF to create new samples.

HISTOGRAM_DISCRETE, a MATLAB library which tries to make a histogram of data without using bins.

HISTOGRAM_DISPLAY, a MATLAB program which makes a bar plot of a set of data stored as columns in a file; the first column is the X values, and all the other columns are Y values to be shown as a stack of bars;

HISTOGRAM_PDF_SAMPLE, a MATLAB library which demonstrates how sampling can be done by starting with the formula for a PDF, creating a histogram, constructing a histogram for the CDF, and then sampling.

HISTOGRAM_PDF_2D_SAMPLE, a MATLAB library which demonstrates how uniform sampling of a 2D region with respect to some known Probability Density Function (PDF) can be approximated by decomposing the region into rectangles, approximating the PDF by a piecewise constant function, constructing a histogram for the CDF, and then sampling.

HISTOGRAMIZE, a MATLAB program which takes a vector of data and organizes it into a histogram of a given number of bins with given width and range, which can be displayed as a bar chart.

HMMER, examples which illustrate the use of HMMER, which is a hidden Markov Model sequence homology search.

HOT_PIPE, a MATLAB program which uses FEM_50_HEAT to solve the heat equation for a pipe model, by Jochen Alberty, Carsten Carstensen, Stefan Funken.

HOT_POINT, a MATLAB program which uses FEM_50_HEAT to solve the heat equation for a 2D region with a hot point, by Jochen Alberty, Carsten Carstensen, Stefan Funken.

hpl, examples which illustrate the use of HPL, which is an implementation of the High Performance Linpack benchmark.

HTML_MISTAKE, programs which illustrate some simple but devious programming mistakes in HTML.

HTMLINDEX, a C++ program which reads a C, C++, FORTRAN77 or FORTRAN90 file and writes a skeleton HTML page describing it, assuming that each function in the file includes a specially marked description line.

HUMP, a Python program which defines the data for a simple ice sheet experiment called "hump", and writes that data to a netcdf file that can be used as input by a solver.

HYPERBALL_DISTANCE, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected in the unit hyperball in M dimensions.

HYPERBALL_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.

HYPERBALL_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.

HYPERBALL_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.

HYPERBALL_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.

HYPERBALL_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.

HYPERBALL_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.

HYPERBALL_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;

HYPERBALL_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;

HYPERBALL_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;

HYPERBALL_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;

HYPERBALL_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;

HYPERBALL_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;

HYPERBALL_VOLUME_MONTE_CARLO, a C program which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;

HYPERBALL_VOLUME_MONTE_CARLO, a C++ program which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;

HYPERBALL_VOLUME_MONTE_CARLO, a FORTRAN77 program which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;

HYPERBALL_VOLUME_MONTE_CARLO, a FORTRAN90 program which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;

HYPERBALL_VOLUME_MONTE_CARLO, a MATLAB program which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;

HYPERBALL_VOLUME_QUAD, a FORTRAN90 program which applies a quadrature rule to estimate the volume of the unit hyperball in M dimensions;

HYPERCUBE_EXACTNESS, a C program which measures the monomial exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.

HYPERCUBE_EXACTNESS, a C++ program which measures the monomial exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.

HYPERCUBE_EXACTNESS, a FORTRAN77 program which measures the monomial exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.

HYPERCUBE_EXACTNESS, a FORTRAN90 program which measures the monomial exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.

HYPERCUBE_EXACTNESS, a MATLAB program which measures the monomial exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.

HYPERCUBE_GRID, a C library which computes a grid of points over the interior of a hypercube in M dimensions.

HYPERCUBE_GRID, a C++ library which computes a grid of points over the interior of a hypercube in M dimensions.

HYPERCUBE_GRID, a FORTRAN77 library which computes a grid of points over the interior of a hypercube in M dimensions.

HYPERCUBE_GRID, a FORTRAN90 library which computes a grid of points over the interior of a hypercube in M dimensions.

HYPERCUBE_GRID, a MATLAB library which computes a grid of points over the interior of a hypercube in M dimensions.

HYPERCUBE_GRID, a Python library which computes a grid of points over the interior of a hypercube in M dimensions.

HYPERCUBE_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.

HYPERCUBE_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.

HYPERCUBE_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.

HYPERCUBE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.

HYPERCUBE_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.

HYPERCUBE_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.

HYPERCUBE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.

HYPERCUBE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.

HYPERCUBE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;

HYPERCUBE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;

HYPERCUBE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;

HYPERCUBE_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;

HYPERSPHERE_DISTANCE, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected on the unit hypersphere in M dimensions.

HYPERSPHERE_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.

HYPERSPHERE_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.

HYPERSPHERE_INTEGRALS, a FORTRAN77 library which dreturns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.

HYPERSPHERE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.

HYPERSPHERE_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.

HYPERSPHERE_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.

HYPERSPHERE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;

HYPERSPHERE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;

HYPERSPHERE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;

HYPERSPHERE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;

HYPERSPHERE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;

HYPERSPHERE_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;

HYPERSPHERE_PROPERTIES, a C library which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.

HYPERSPHERE_PROPERTIES, a C++ library which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.

HYPERSPHERE_PROPERTIES, a FORTRAN77 library which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.

HYPERSPHERE_PROPERTIES, a FORTRAN90 library which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.

HYPERSPHERE_PROPERTIES, a MATLAB library which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.

HYPERSPHERE_SURFACE, a MATLAB library which illustrates a procedure for estimating the location of a hypersurface defined by a characteristic function or a signed function.

I2_BINARY_TO_ASCII a C++ program which converts a file of short int (I2) data from binary to ASCII format.

I4LIB, a C library which contains many utility routines, using single precision integer (I4) arithmetic.

I4LIB, a C++ library which contains many utility routines, using single precision integer (I4) arithmetic.

I4LIB, a FORTRAN77 library which contains many utility routines, using single precision integer (I4) arithmetic.

I4LIB, a FORTRAN90 library which contains many utility routines, using single precision integer (I4) arithmetic.

I4LIB, a MATLAB library which contains many utility routines, using single precision integer (I4) arithmetic.

I4LIB, a Python library which contains many utility routines, using single precision integer (I4) arithmetic.

I8LIB, a C library which contains many utility routines, using double precision integer (I8) arithmetic.

I8LIB, a C++ library which contains many utility routines, using double precision integer (I8) arithmetic.

I8LIB, a FORTRAN77 library which contains many utility routines, using double precision integer (I8) arithmetic.

I8LIB, a FORTRAN90 library which contains many utility routines, using double precision integer (I8) arithmetic.

ICE, a data directory which contains examples of ICE files, which define a netcdf file format for icesheet grids.

ICE_IO, a C library which can read or write an ICE dataset, which defines a 3D grid, using the NETCDF file format.

ICE_IO, a C++ library which can read or write an ICE dataset, which defines a 3D grid, using the NETCDF file format.

ICE_IO, a FORTRAN90 library which can read or write an ICE dataset, which defines a 3D grid, using the NETCDF file format.

ICE_IO, a MATLAB library which can read or write an ICE dataset, which defines a 3D grid, using the NETCDF file format.

ICE_TO_MESH, a C program which reads a NETCDF file containing an ICE dataset and rewrites the information as a MESH file.

ICE_TO_MESH, a C++ program which reads a NETCDF file containing an ICE dataset and rewrites the information as a MESH file.

ICE_TO_MESH, a FORTRAN90 program which reads a NETCDF file containing an ICE dataset and rewrites the information as a MESH file.

ICE_TO_MESH, a MATLAB program which reads a NETCDF file containing an ICE dataset and rewrites the information as a MESH file.

IEEE_UNIFORM_SAMPLE, a FORTRAN90 library which tries to uniformly sample the discrete set of values that represent the legal IEEE real numbers;

IFISS, examples which illustrate the use of ifiss, software that can model the time-independent flow of a 2D fluid governed by the incompressible Navier Stokes equations (NSE), by Howard Elman, Alison Ramage, David Silvester.

IFISS3.3, a MATLAB program which embodies the ifiss software that can model the time-independent flow of a 2D fluid governed by the incompressible Navier Stokes equations (NSE), by Howard Elman, Alison Ramage, David Silvester.

IHS, a dataset directory which computes an Improved Hypercube Sampling (IHS) Quasi Monte Carlo (QMC) sequence;

IHS, a C++ library which computes an Improved Hypercube Sampling (IHS) Quasi Monte Carlo (QMC) sequence;

IHS, a FORTRAN90 library which computes an Improved Hypercube Sampling (IHS) Quasi Monte Carlo (QMC) sequence;

IHS, a MATLAB library which computes an Improved Hypercube Sampling (IHS) Quasi Monte Carlo (QMC) sequence;

IHS_DATASET, a C++ program which creates an Improved Hypercube Sampling (IHS) dataset and writes it to a file.

IHS_DATASET, a FORTRAN90 program which creates an Improved Hypercube Sampling (IHS) dataset and writes it to a file.

IHS_DATASET, a MATLAB program which creates an Improved Hypercube Sampling (IHS) dataset and writes it to a file.

IMAGE_BOUNDARY, a MATLAB library which reports the pixels which form the boundary between the black and white regions of a simple image.

IMAGE_COMPONENTS, a C library which seeks the connected nonzero or nonblack components or segments of an image or integer vector, array or 3D block.

IMAGE_COMPONENTS, a C++ library which seeks the connected nonzero or nonblack components or segments of an image or integer vector, array or 3D block.

IMAGE_COMPONENTS, a FORTRAN77 library which seeks the connected nonzero or nonblack components or segments of an image or integer vector, array or 3D block.

IMAGE_COMPONENTS, a FORTRAN90 library which seeks the connected nonzero or nonblack components or segments of an image or integer vector, array or 3D block.

IMAGE_COMPONENTS, a MATLAB library which seeks the connected nonzero or nonblack components or segments of an image or integer vector, array or 3D block.

IMAGE_CONTRAST, MATLAB programs which apply image processing techniques to increase the contrast in an image.

IMAGE_DECIMATE, a MATLAB library which compresses an image by dropping the even rows and columns of data.

IMAGE_DENOISE, a C library which applies simple filtering techniques to remove noise from an image.

IMAGE_DENOISE, a C++ library which applies simple filtering techniques to remove noise from an image.

IMAGE_DENOISE, a FORTRAN77 library which applies simple filtering techniques to remove noise from an image.

IMAGE_DENOISE, a FORTRAN90 library which applies simple filtering techniques to remove noise from an image.

IMAGE_DENOISE, a MATLAB library which applies simple filtering techniques to remove noise from an image.

IMAGE_DENOISE_OPENMP, a C library which applies simple filtering techniques to remove noise from an image, carrying out the operation in parallel using OpenMP.

IMAGE_DENOISE_SPMD, a MATLAB program which demonstrates the Single Program Multiple Data (SPMD) parallel programming feature for image operations; the client reads an image, the workers process portions of it, and the client assembles and displays the results.

IMAGE_DIFFUSE, a MATLAB library which uses diffusion to smooth out an image.

IMAGE_DOUBLE, a MATLAB library which doubles the height and width of an image by repeating each row and column.

IMAGE_EDGE, a C library which demonstrates a simple procedure for edge detection in images.

IMAGE_EDGE, a C++ library which demonstrates a simple procedure for edge detection in images.

IMAGE_EDGE, a FORTRAN77 library which demonstrates a simple procedure for edge detection in images.

IMAGE_EDGE, a FORTRAN90 library which demonstrates a simple procedure for edge detection in images.

IMAGE_EDGE, a MATLAB library which demonstrates a simple procedure for edge detection in images.

IMAGE_MATCH_GENETIC, a MATLAB program which tries to match a 256x256 jpeg image by blending 32 colored rectangles, using ideas from genetic algorithms, based on an example by Nick Berry.

IMAGE_NOISE, MATLAB programs which add noise to an image.

IMAGE_QUANTIZATION, a MATLAB library which demonstrates how the KMEANS algorithm can be used to reduce the number of colors or shades of gray in an image.

IMAGE_RGB_TO_GRAY, MATLAB programs which make a grayscale version of an RGB image.

IMAGE_THRESHOLD, MATLAB programs which make a black and white version of a grayscale image by setting all pixels below or above a threshold value to black or white.

IMAGEJ, a dataset directory which contains image data suitable for use with the ImageJ program.

IMAGEMAGICK, examples which illustrate the use of IMAGEMAGICK, which is a program that can create, edit, compose or convert graphical information as stored in many different file formats. IMAGEMAGICK can resize, flip, mirror, rotate, distort, shear and transform images, adjust image colors, apply various special effects, or draw text, lines, polygons, ellipses and Bézier curves.

IMPI, examples which illustrate the use of IMPI, which is the Intel implementation of the MPI interface for parallel programming.

IMSHOW_NUMERIC, a MATLAB program which accepts a numeric 2D array and displays it as a grayscale image.

INCLUDE_FILES, a FORTRAN90 program which reads a FORTRAN file with INCLUDE statements, and makes a copy in which the indicated files have been included;

INDEX, a C library which converts an M-dimensional vector index to a one-dimensional vector index; it can handle zero and one based indexing schemes, as well as column major and row major conventions.

INDEX, a C++ library which converts an M-dimensional vector index to a one-dimensional vector index; it can handle zero and one based indexing schemes, as well as column major and row major conventions.

INDEX, a FORTRAN77 library which converts an M-dimensional vector index to a one-dimensional vector index; it can handle zero and one based indexing schemes, as well as column major and row major conventions.

INDEX, a FORTRAN90 library which converts an M-dimensional vector index to a one-dimensional vector index; it can handle zero and one based indexing schemes, as well as column major and row major conventions.

INDEX, a MATLAB library which converts an M-dimensional vector index to a one-dimensional vector index; it can handle zero and one based indexing schemes, as well as column major and row major conventions.

INOUT, a FORTRAN77 program which computes the pressure and velocity for a flow governed by the Navier Stokes Equations (NSE) in a square 1D region with an inlet and an outlet.

INOUT_FLOW, a dataset directory which contains 500 time steps of flow governed by the Navier-Stokes Equations (NSE) in a region with specified inflow and outflow;

INOUT_FLOW_DISPLAY, a MATLAB library which displays a single velocity field solution for the inout flow;

INOUT_FLOW_MOVIE, a MATLAB library which creates an animation of the velocity solutions for the inout cell;

INOUT_FLOW2, a dataset directory which contains 800 time steps of flow governed by the Navier-Stokes Equations (NSE) in a region with specified inflow and outflow;

INT_EXACTNESS, a C++ program which checks the monomial exactness of a 1-dimensional quadrature rule for a finite interval.

INT_EXACTNESS, a FORTRAN90 program which checks the monomial exactness of a 1-dimensional quadrature rule for a finite interval.

INT_EXACTNESS, a MATLAB program which checks the monomial exactness of a 1-dimensional quadrature rule for a finite interval.

INT_EXACTNESS_CHEBYSHEV1, a C++ program which tests the monomial exactness of Gauss-Chebyshev type 1 quadrature rules.

INT_EXACTNESS_CHEBYSHEV1, a FORTRAN90 program which tests the monomial exactness of Gauss-Chebyshev type 1 quadrature rules.

INT_EXACTNESS_CHEBYSHEV1, a MATLAB program which tests the monomial exactness of Gauss-Chebyshev type 1 quadrature rules.

INT_EXACTNESS_CHEBYSHEV2, a C++ program which tests the monomial exactness of Gauss-Chebyshev type 2 quadrature rules.

INT_EXACTNESS_CHEBYSHEV2, a FORTRAN90 program which tests the monomial exactness of Gauss-Chebyshev type 2 quadrature rules.

INT_EXACTNESS_CHEBYSHEV2, a MATLAB program which tests the monomial exactness of Gauss-Chebyshev type 2 quadrature rules.

INT_EXACTNESS_GEN_HERMITE, a C++ program which tests the monomial exactness of generalized Gauss-Hermite quadrature rules.

INT_EXACTNESS_GEN_HERMITE, a FORTRAN90 program which tests the monomial exactness of generalized Gauss-Hermite quadrature rules.

INT_EXACTNESS_GEN_HERMITE, a MATLAB program which tests the monomial exactness of generalized Gauss-Hermite quadrature rules.

INT_EXACTNESS_GEN_LAGUERRE, a C++ program which tests the monomial exactness of generalized Gauss-Laguerre quadrature rules.

INT_EXACTNESS_GEN_LAGUERRE, a FORTRAN90 program which tests the monomial exactness of generalized Gauss-Laguerre quadrature rules.

INT_EXACTNESS_GEN_LAGUERRE, a MATLAB program which tests the monomial exactness of generalized Gauss-Laguerre quadrature rules.

INTEGRAL_TEST, a FORTRAN90 program which tests the suitability of a set of N points for use in an equal-weight quadrature rule over the M-dimensional unit hypercube.

INTEL, examples which demonstrate the use of the INTEL compilers, which include highly optimizing compilers for C, C++, and FORTRAN.

INTERP, a C library which can be used for parameterizing and interpolating data;

INTERP, a FORTRAN77 library which can be used for parameterizing and interpolating data;

INTERP, a FORTRAN90 library which can be used for parameterizing and interpolating data;

INTERP, a MATLAB library which can be used for parameterizing and interpolating data;

interpolant, a FENICS script which shows how to define a function in FENICS by supplying a mesh and the function values at the nodes of that mesh, so that FENICS works with the finite element interpolant of that data.

INTERPOLATION, a dataset directory which contains datasets to be interpolated.

INTLIB, a FORTRAN90 library which estimates the integral of a function over a one-dimensional interval.

IOZONE, examples which illustrate the use of IOZONE, which is a benchmark program that evaluates a computer system's ability to handle I/O operations involving files.

IPM, examples which illustrate the use of IPM, which is an integrated performance monitor for MPI programs.

IPP, examples which illustrate the use of IPP, which is the Intel Integrated Performance Primitives library.

IPYTHON examples which illustrate the use of IPYTHON, which is a command shell for interactive computing, originally created as an enhanced shell for Python;

IS_SERIAL, a C program which a serial version of the NAS Integer Sort (IS) Parallel Benchmark, which is intended as the starting point for the development of a parallel version.

ISBN, a C library which can determine the check digit for an International Standard Book Number or report whether a given ISBN is valid.

ISBN, a C++ library which can determine the check digit for an International Standard Book Number or report whether a given ISBN is valid.

ISBN, a FORTRAN90 library which can determine the check digit for an International Standard Book Number or report whether a given ISBN is valid.

ISBN, a MATLAB library which can determine the check digit for an International Standard Book Number or report whether a given ISBN is valid.

ISBN, a Python library which can determine the check digit for an International Standard Book Number or report whether a given ISBN is valid.

ISING_2D_SIMULATION, a C program which carries out a Monte Carlo simulation of an Ising model, a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors, using gnuplot to display the initial and final configurations.

ISING_2D_SIMULATION, a C++ program which carries out a Monte Carlo simulation of an Ising model, a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors, using gnuplot to make images of the initial and final configurations.

ISING_2D_SIMULATION, a FORTRAN77 program which carries out a Monte Carlo simulation of an Ising model, a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors, using gnuplot to make images of the initial and final configurations.

ISING_2D_SIMULATION, a FORTRAN90 program which carries out a Monte Carlo simulation of an Ising model, a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors, using gnuplot to make images of the initial and final configurations.

ISING_2D_SIMULATION, a MATLAB program which carries out a Monte Carlo simulation of an Ising model, a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors.

ISING_3D_SIMULATION, a FORTRAN90 program which carries out a Monte Carlo simulation of an Ising model, a 3D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors.

ISWR, a dataset directory which contains example datasets used for statistical analysis.

IVCON, a C++ program which can convert graphics information between various 3D formats.

IVREAD, a FORTRAN90 program which can convert graphics information between various 3D formats.

JACOBI, a C library which implements the Jacobi iteration for solving symmetric positive definite (SPD) systems of linear equations.

JACOBI, a C++ library which implements the Jacobi iteration for solving symmetric positive definite (SPD) systems of linear equations.

JACOBI, a FORTRAN77 library which implements the Jacobi iteration for solving symmetric positive definite (SPD) systems of linear equations.

JACOBI, a FORTRAN90 library which implements the Jacobi iteration for solving symmetric positive definite (SPD) systems of linear equations.

JACOBI, a MATLAB library which implements the Jacobi iteration for solving symmetric positive definite (SPD) systems of linear equations.

JACOBI, a Python library which implements the Jacobi iteration for solving symmetric positive definite (SPD) systems of linear equations.

JACOBI_EIGENVALUE, a C library which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.

JACOBI_EIGENVALUE, a C++ library which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.

JACOBI_EIGENVALUE, a FORTRAN77 library which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.

JACOBI_EIGENVALUE, a FORTRAN90 library which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.

JACOBI_EIGENVALUE, a MATLAB library which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.

JACOBI_EIGENVALUE, a Python library which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.

JACOBI_EXACTNESS, a C++ program which tests the monomial exactness of quadrature rules for integrals that include a Jacobi weight.

JACOBI_EXACTNESS, a FORTRAN90 program which tests the monomial exactness of quadrature rules for integrals that include a Jacobi weight.

JACOBI_EXACTNESS, a MATLAB program which tests the monomial exactness of quadrature rules for integrals that include a Jacobi weight.

JACOBI_OPENMP, a C program which illustrates the use of the OpenMP application program interface to parallelize a Jacobi iteration solving A*x=b.

JACOBI_OPENMP, a C++ program which illustrates the use of the OpenMP application program interface to parallelize a Jacobi iteration solving A*x=b.

JACOBI_OPENMP, a FORTRAN90 program which illustrates the use of the OpenMP application program interface to parallelize a Jacobi iteration solving A*x=b.

JACOBI_POISSON_1D, a MATLAB program which demonstrates how the linear system for a discretized version of the steady (time independent) 1D Poisson equation can be solved by the Jacobi iteration.

JACOBI_POLYNOMIAL, a C library which evaluates the Jacobi polynomial and associated functions.

JACOBI_POLYNOMIAL, a C++ library which evaluates the Jacobi polynomial and associated functions.

JACOBI_POLYNOMIAL, a FORTRAN77 library which evaluates the Jacobi polynomial and associated functions.

JACOBI_POLYNOMIAL, a FORTRAN90 library which evaluates the Jacobi polynomial and associated functions.

JACOBI_POLYNOMIAL, a MATLAB library which evaluates the Jacobi polynomial and associated functions.

JACOBI_RULE, a C++ program which can compute and print a Gauss-Jacobi quadrature rule.

JACOBI_RULE, a FORTRAN90 program which can compute and print a Gauss-Jacobi quadrature rule.

JACOBI_RULE, a MATLAB program which can compute and print a Gauss-Jacobi quadrature rule.

JAGS, examples which illustrate the use of JAGS, which is a program for the analysis of Bayesian graphical models using Markov Chain Monte Carlo (MCMC) simulation.

JBAR, a FORTRAN90 program which reads a data file and creates a bar graph.

JDK, examples which illustrate the use of JDK, which is the Java Development Kit, which enables Java programmers to compile and run programs.

JPG, a data directory which contains examples of JPG or JPEG files, a file format for high quality 2D graphics;

JULIA, examples which illustrate the use of JULIA, which is a programming language intended to achieve efficient performance on high performance computers, while offering the convenience of interactive languages like Python and MATLAB.

JULIA_OPENMP, a C program which produces an image of a Julia set, using OpenMP to carry out the computation in parallel.

JULIA_SET, a C program which generates a TGA or TARGA graphics file of a Julia set.

KELLEY, a MATLAB library which implements iterative methods for linear and nonlinear equations, by Tim Kelley;

KMEANS, a C library which contains several different algorithms for the K-Means problem, which organizes a set of N points in M dimensions into K clusters;

KMEANS, a C++ library which contains several different algorithms for the K-Means problem, which organizes a set of N points in M dimensions into K clusters;

KMEANS, a FORTRAN90 library which contains several different algorithms for the K-Means problem, which organizes a set of N points in M dimensions into K clusters;

KMEANS, a MATLAB library which contains several different algorithms for the K-Means problem, which organizes a set of N points in M dimensions into K clusters;

KMEANS_FAST, a MATLAB library which contains several different algorithms for the K-Means problem, which organizes a set of N points in M dimensions into K clusters, by Charles Elkan.

KMEDIAN, a FORTRAN77 program which handles the K-Median problem, by G Cornuejols, M L Fisher, G L Nemhauser.

KMEDIAN, a FORTRAN90 program which handles the K-Median problem, by G Cornuejols, M L Fisher, G L Nemhauser.

KNAPSACK, a FORTRAN77 library which solves a variety of knapsack problems, by Silvano Martelo and Paolo Toth.

KNAPSACK_01, a C library which uses brute force to solve small versions of the 0/1 knapsack problem;

KNAPSACK_01, a C++ library which uses brute force to solve small versions of the 0/1 knapsack problem;

KNAPSACK_01, a FORTRAN77 library which uses brute force to solve small versions of the 0/1 knapsack problem;

KNAPSACK_01, a FORTRAN90 library which uses brute force to solve small versions of the 0/1 knapsack problem;

KNAPSACK_01, a MATLAB library which uses brute force to solve small versions of the 0/1 knapsack problem;

KNAPSACK_01, a Python library which uses brute force to solve small versions of the 0/1 knapsack problem;

KNAPSACK_01, a dataset directory which contains test data for the 0/1 knapsack problem;

KNAPSACK_MULTIPLE, a dataset directory which contains test data for the multiple knapsack problem;

KRONROD, a C library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.

KRONROD, a C++ library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.

KRONROD, a FORTRAN77 library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.

KRONROD, a FORTRAN90 library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.

KRONROD, a MATLAB library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.

KRONROD, a Python library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.

L4LIB, a C library which contains many utility routines, using one byte logical (L4) variables.

L4LIB, a C++ library which contains many utility routines, using one byte logical (L4) variables.

L4LIB, a FORTRAN90 library which contains many utility routines, using one byte logical (L4) variables.

L4LIB, a MATLAB library which contains many utility routines, using one byte logical (L4) variables.

LADDERS, a C program which seeks to transform one five letter word into another, by changing one letter at a time, using only legitimate English words. This puzzle was invented by Lewis Carroll, who called it "Doublets", but it is also known as "Word Ladders" or "Word Gold". The program is by Donald Knuth.

LAGRANGE_APPROX_1D, a C library which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).

LAGRANGE_APPROX_1D, a C++ library which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).

LAGRANGE_APPROX_1D, a FORTRAN77 library which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).

LAGRANGE_APPROX_1D, a FORTRAN90 library which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).

LAGRANGE_APPROX_1D, a MATLAB library which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).

LAGRANGE_BASIS_DISPLAY, a MATLAB library which displays the basis functions associated with a given set of nodes used with the Lagrange interpolation scheme.

LAGRANGE_INTERP_1D, a C library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i).

LAGRANGE_INTERP_1D, a C++ library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i).

LAGRANGE_INTERP_1D, a FORTRAN77 library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i).

LAGRANGE_INTERP_1D, a FORTRAN90 library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i).

LAGRANGE_INTERP_1D, a MATLAB library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i).

LAGRANGE_INTERP_1D, a Python library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i).

LAGRANGE_INTERP_2D, a C library which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).

LAGRANGE_INTERP_2D, a C++ library which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).

LAGRANGE_INTERP_2D, a FORTRAN77 library which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).

LAGRANGE_INTERP_2D, a FORTRAN90 library which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).

LAGRANGE_INTERP_2D, a MATLAB library which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).

LAGRANGE_INTERP_ND, a C library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on an M-dimensional argument x that was evaluated on a product grid, so that p(x(i)) = z(i).

LAGRANGE_INTERP_ND, a C++ library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on an M-dimensional argument x that was evaluated on a product grid, so that p(x(i)) = z(i).

LAGRANGE_INTERP_ND, a FORTRAN77 library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on an M-dimensional argument x that was evaluated on a product grid, so that p(x(i)) = z(i).

LAGRANGE_INTERP_ND, a FORTRAN90 library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on an M-dimensional argument x that was evaluated on a product grid, so that p(x(i)) = z(i).

LAGRANGE_INTERP_ND, a MATLAB library which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on an M-dimensional argument x that was evaluated on a product grid, so that p(x(i)) = z(i).

LAGRANGE_ND, a C++ library which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.

LAGRANGE_ND, a FORTRAN90 library which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.

LAGRANGE_ND, a MATLAB library which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.

LAGUERRE_EXACTNESS, a C program which tests the monomial exactness of quadrature rules for estimating Laguerre-type integrals of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).

LAGUERRE_EXACTNESS, a C++ program which tests the monomial exactness of quadrature rules for estimating Laguerre-type integrals of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).

LAGUERRE_EXACTNESS, a FORTRAN77 program which tests the monomial exactness of quadrature rules for estimating Laguerre-type integrals of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).

LAGUERRE_EXACTNESS, a FORTRAN90 program which tests the monomial exactness of quadrature rules for estimating Laguerre-type integrals of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).

LAGUERRE_EXACTNESS, a MATLAB program which tests the monomial exactness of quadrature rules for estimating Laguerre-type integrals of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).

LAGUERRE_POLYNOMIAL, a C library which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.

LAGUERRE_POLYNOMIAL, a C++ library which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.

LAGUERRE_POLYNOMIAL, a FORTRAN77 library which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.

LAGUERRE_POLYNOMIAL, a FORTRAN90 library which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.

LAGUERRE_POLYNOMIAL, a MATLAB library which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.

LAGUERRE_RULE, a C program which can compute and print a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_RULE, a C++ program which can compute and print a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_RULE, a FORTRAN77 program which can compute and print a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_RULE, a FORTRAN90 program which can compute and print a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_RULE, a MATLAB program which can compute and print a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_TEST_INT, a C library which defines test integrands for quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_TEST_INT, a C++ library which defines test integrands for quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_TEST_INT, a FORTRAN77 library which defines test integrands for quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_TEST_INT, a FORTRAN90 library which defines test integrands for quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAGUERRE_TEST_INT, a MATLAB library which defines test integrands for quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).

LAME, examples which illustrate the use of LAME, which encodes audo information as an MP3 file.

LAMMPS, examples which illustrate the use of LAMMPS, a molecular dynamics simulator.

LAMP, a FORTRAN77 library which solves linear assignment and matching problems, by Rainer Burkard, Ulrich Derigs.

LAPACK_D, a FORTRAN90 library which is a FORTRAN90 version of the double precision real LAPACK + BLAS libraries.

LAPACK_F77, a FORTRAN90 program which calls the FORTRAN77 version of the LAPACK + BLAS libraries.

LAPACK_OSX, a FORTRAN90 program which demonstrates the use of the LAPACK linear algebra library available on Macintosh OSX systems, using the "-framework veclib" compiler option.

LAPACK_S, a FORTRAN90 library which is a FORTRAN90 version of the single precision real LAPACK + BLAS libraries.

LAPLACE_MPI, a C program which solves Laplace's equation on a rectangle, using MPI for parallel execution.

LAPLACE_RCC a FreeFem++ input file which sets up the steady Laplace equation in a circle, using serial or steady, local or batch processing on the FSU RCC HPC cluster.

LAPLACIAN, a C library which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.

LAPLACIAN, a C++ library which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.

LAPLACIAN, a FORTRAN77 library which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.

LAPLACIAN, a FORTRAN90 library which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.

LAPLACIAN, a MATLAB library which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.

LATIN_CENTER, a dataset directory which contains examples of the Latin Center Square Quasi Monte Carlo (QMC) sequence;

LATIN_CENTER, a C++ library which computes elements of a Latin Hypercube dataset, choosing center points.

LATIN_CENTER, a FORTRAN90 library which computes elements of a Latin Hypercube dataset, choosing center points.

LATIN_CENTER, a MATLAB library which computes elements of a Latin Hypercube dataset, choosing center points.

LATIN_CENTER_DATASET, a C++ program which creates a Latin Center Hypercube dataset;

LATIN_CENTER_DATASET, a FORTRAN90 program which creates a Latin Center Hypercube dataset;

LATIN_CENTER_DATASET, a MATLAB program which creates a Latin Center Hypercube dataset;

LATIN_COVER, a C library which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.

LATIN_COVER, a C++ library which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.

LATIN_COVER, a FORTRAN77 library which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.

LATIN_COVER, a FORTRAN90 library which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.

LATIN_COVER, a MATLAB library which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.

LATIN_EDGE, a dataset directory which contains examples of the Latin Edge Square Quasi Monte Carlo (QMC) sequence;

LATIN_EDGE, a C++ library which computes elements of a Latin Hypercube dataset, choosing edge points.

LATIN_EDGE, a FORTRAN90 library which computes elements of a Latin Hypercube dataset, choosing edge points.

LATIN_EDGE, a MATLAB library which computes elements of a Latin Hypercube dataset, choosing edge points.

LATIN_EDGE_DATASET, a C++ program which creates a Latin Edge Hypercube dataset;

LATIN_EDGE_DATASET, a FORTRAN90 program which creates a Latin Edge Hypercube dataset;

LATIN_EDGE_DATASET, a MATLAB program which creates a Latin Edge Hypercube dataset;

LATIN_RANDOM, a dataset directory which contains examples of the Latin Random Square Quasi Monte Carlo (QMC) sequence;

LATIN_RANDOM, a C library which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM, a C++ library which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM, a FORTRAN77 library which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM, a FORTRAN90 library which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM, a MATLAB library which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM, a Python library which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM_DATASET, a C program which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM_DATASET, a C++ program which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM_DATASET, a FORTRAN77 program which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM_DATASET, a FORTRAN90 program which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATIN_RANDOM_DATASET, a MATLAB program which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.

LATINIZE, a C library which adjusts N points in M dimensions to form a Latin hypercube.

LATINIZE, a C++ library which adjusts N points in M dimensions to form a Latin hypercube.

LATINIZE, a FORTRAN77 library which adjusts N points in M dimensions to form a Latin hypercube.

LATINIZE, a FORTRAN90 library which adjusts N points in M dimensions to form a Latin hypercube.

LATINIZE, a MATLAB library which adjusts N points in M dimensions to form a Latin hypercube.

LATTICE_RULE, a C++ library which approximates M-dimensional integrals using lattice rules.

LATTICE_RULE, a FORTRAN90 library which approximates M-dimensional integrals using lattice rules.

LATTICE_RULE, a MATLAB library which approximates M-dimensional integrals using lattice rules.

LAU_NP, a FORTRAN90 library which implements heuristic algorithms for various NP-hard combinatorial problems, including the integer linear programming problem, the K-center problem, the K-median problem, the 0-1 knapsack problem, the multiple knapsack problem, the graph matching problem, the graph partitioning problem, the minimal Steiner tree problem, and the traveling salesman problem;

LAUPACK, a FORTRAN90 library which carries out various operations on graphs.

LAWSON, a FORTRAN77 library which contains routines for solving linear least squares (LLS) problems and singular value decompositions (SVD), by Charles Lawson, Richard Hanson.

LAWSON, a FORTRAN90 library which contains routines for solving linear least squares (LLS) problems and singular value decompositions (SVD), by Charles Lawson, Richard Hanson.

LCVT, a dataset directory which contains examples of Latinized Centroidal Voronoi Tessellations (CVT);

LCVT, a C++ library which computes a Latinized Centroidal Voronoi Tessellation (CVT).

LCVT, a FORTRAN90 library which computes a Latinized Centroidal Voronoi Tessellation (CVT).

LCVT, a MATLAB library which computes a Latinized Centroidal Voronoi Tessellation (CVT).

LCVT_DATASET, a C++ program which computes a Latinized Centroidal Voronoi Tessellation (CVT) and writes it to a file.

LCVT_DATASET, a FORTRAN90 program which computes a Latinized Centroidal Voronoi Tessellation (CVT) and writes it to a file.

LCVT_DATASET, a MATLAB program which computes a Latinized Centroidal Voronoi Tessellation (CVT) and writes it to a file.

LCVTP, a dataset directory which contains examples of LCVTP's, that is, Latinized Centroidal Voronoi Tessellations (CVT) on a periodic region.

LEBESGUE, a C library which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation, and which uses gnuplot to make plots of the Lebesgue function.

LEBESGUE, a C++ library which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation, and which uses gnuplot to make plots of the Lebesgue function.

LEBESGUE, a FORTRAN77 library which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation, and which uses gnuplot to make plots of the Lebesgue function.

LEBESGUE, a FORTRAN90 library which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation, and which uses gnuplot to make plots of the Lebesgue function.

LEBESGUE, a MATLAB library which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation.

LEBESGUE, a Python library which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation.

LEGENDRE_EXACTNESS, a C program which tests the monomial exactness of quadrature rules for estimating Legendre-type integrals of a function f(x) with density rho(x)=1 over the interval [-1,+1].

LEGENDRE_EXACTNESS, a C++ program which tests the monomial exactness of quadrature rules for estimating Legendre-type integrals of a function f(x) with density rho(x)=1 over the interval [-1,+1].

LEGENDRE_EXACTNESS, a FORTRAN77 program which tests the monomial exactness of quadrature rules for estimating Legendre-type integrals of a function f(x) with density rho(x)=1 over the interval [-1,+1].

LEGENDRE_EXACTNESS, a FORTRAN90 program which tests the monomial exactness of quadrature rules for estimating Legendre-type integrals of a function f(x) with density rho(x)=1 over the interval [-1,+1].

LEGENDRE_EXACTNESS, a MATLAB program which tests the monomial exactness of quadrature rules for estimating Legendre-type integrals of a function f(x) with density rho(x)=1 over the interval [-1,+1].

LEGENDRE_POLYNOMIAL, a C library which evaluates the Legendre polynomial and associated functions.

LEGENDRE_POLYNOMIAL, a C++ library which evaluates the Legendre polynomial and associated functions.

LEGENDRE_POLYNOMIAL, a FORTRAN77 library which evaluates the Legendre polynomial and associated functions.

LEGENDRE_POLYNOMIAL, a FORTRAN90 library which evaluates the Legendre polynomial and associated functions.

LEGENDRE_POLYNOMIAL, a MATLAB library which evaluates the Legendre polynomial and associated functions.

LEGENDRE_POLYNOMIAL, a Python library which evaluates the Legendre polynomial and associated functions.

LEGENDRE_PRODUCT_POLYNOMIAL, a C library which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.

LEGENDRE_PRODUCT_POLYNOMIAL, a C++ library which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.

LEGENDRE_PRODUCT_POLYNOMIAL, a FORTRAN77 library which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.

LEGENDRE_PRODUCT_POLYNOMIAL, a FORTRAN90 library which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.

LEGENDRE_PRODUCT_POLYNOMIAL, a MATLAB library which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.

LEGENDRE_PRODUCT_POLYNOMIAL, a Python library which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.

LEGENDRE_RULE, a C program which computes Gauss-Legendre quadrature rules for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE, a C++ program which computes Gauss-Legendre quadrature rules for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE, a FORTRAN77 program which computes Gauss-Legendre quadrature rules for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE, a FORTRAN90 program which computes Gauss-Legendre quadrature rules for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE, a MATLAB program which computes Gauss-Legendre quadrature rules for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE_FAST, a C program which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE_FAST, a C++ program which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE_FAST, a FORTRAN77 program which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE_FAST, a FORTRAN90 program which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_RULE_FAST, a MATLAB program which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density 1 over the interval [-1,+1].

LEGENDRE_SHIFTED_POLYNOMIAL, a C library which evaluates the shifted Legendre polynomial, with domain [0,1].

LEGENDRE_SHIFTED_POLYNOMIAL, a C++ library which evaluates the shifted Legendre polynomial, with domain [0,1].

LEGENDRE_SHIFTED_POLYNOMIAL, a FORTRAN90 library which evaluates the shifted Legendre polynomial, with domain [0,1].

LEGENDRE_SHIFTED_POLYNOMIAL, a MATLAB library which evaluates the shifted Legendre polynomial, with domain [0,1].

LEGENDRE_SHIFTED_POLYNOMIAL, a Python library which evaluates the shifted Legendre polynomial, with domain [0,1].

LEMKE, a MATLAB library which implements Lemke's algorithm for the linear complementarity problem, by Paul Fackler, Mario Miranda.

LEVELS, a MATLAB library which makes a contour plot of a function Z=F(X,Y), choosing the contour levels using random sampling.

LEVENSHTEIN, a C library which returns the Levenshtein distance between two strings.

LEVENSHTEIN, a C++ library which returns the Levenshtein distance between two strings.

LEVENSHTEIN, a FORTRAN90 library which returns the Levenshtein distance between two strings.

LEVENSHTEIN, a MATLAB library which returns the Levenshtein distance between two strings.

LEVENSHTEIN, a Python library which returns the Levenshtein distance between two strings.

LF2CR, a C++ program which converts linefeeds to carriage returns in a file;

LF2CRLF, a C++ program which converts linefeeds to carriage return + linefeeds in a file;

LFRM, a C++ program which removes all linefeed characters from a file;

LHS, a dataset directory which contains datasets related to Latin Hypercube Sampling (LHS);

LIBGTEXTUTILS, examples which illustrate the use of LIBGTEXTUTILS, which is a text utilities library used by the FASTX toolkit.

LIBJPEG, examples which illustrate the use of LIBJPEG, which is a library for compression, storage, and decompression of graphics images using the JPEG format.

LIBJPEG-TURBO, examples which illustrate the use of LIBJPEG-TURBO, which is an accelerated version of the LIBJPEG library.

LIFE_OPENGL, a C program which uses OpenGL to display the evolution of John Conway's Game of Life, by Simon Green.

LIFE_OPENGL, a C++ program which uses OpenGL to display the evolution of John Conway's Game of Life.

LIFE_SERIAL, a C program which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.

LIFE_SERIAL, a C++ program which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.

LIFE_SERIAL, a FORTRAN77 program which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.

LIFE_SERIAL, a FORTRAN90 program which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.

LIFE_SERIAL, a MATLAB program which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.

LIGHTS_OUT_OPENGL, a C program which sets up a Lights Out game and allows the user to solve it, using the OpenGL graphics window.

LIGHTS_OUT_OPENGL, a C++ program which sets up a Lights Out game and allows the user to solve it, using the OpenGL graphics window.

LIGHTS_OUT, a MATLAB program which sets up the "Lights Out" game and allows a user to try to solve it.

LINE_CVT_LLOYD, a C library which applies Lloyd's iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.

LINE_CVT_LLOYD, a C++ library which applies Lloyd's iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.

LINE_CVT_LLOYD, a FORTRAN77 library which applies Lloyd's iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.

LINE_CVT_LLOYD, a FORTRAN90 library which applies Lloyd's iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.

LINE_CVT_LLOYD, a MATLAB library which applies Lloyd's iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.

line_distance, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected in the unit line segment.

LINE_FEKETE_RULE, a C library which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.

LINE_FEKETE_RULE, a C++ library which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.

LINE_FEKETE_RULE, a FORTRAN77 library which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.

LINE_FEKETE_RULE, a FORTRAN90 library which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.

LINE_FEKETE_RULE, a MATLAB library which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.

LINE_FELIPPA_RULE, a C library which returns the points and weights of a Felippa quadrature rule over the interior of a line segment in 1D.

LINE_FELIPPA_RULE, a C++ library which returns the points and weights of a Felippa quadrature rule over the interior of a line segment in 1D.

LINE_FELIPPA_RULE, a FORTRAN77 library which returns the points and weights of a Felippa quadrature rule over the interior of a line segment in 1D.

LINE_FELIPPA_RULE, a FORTRAN90 library which returns the points and weights of a Felippa quadrature rule over the interior of a line segment in 1D.

LINE_FELIPPA_RULE, a MATLAB library which returns the points and weights of a Felippa quadrature rule over the interior of a line segment in 1D.

LINE_GRID, a C library which computes a grid of points over the interior of a line segment in 1D.

LINE_GRID, a C++ library which computes a grid of points over the interior of a line segment in 1D.

LINE_GRID, a FORTRAN77 library which computes a grid of points over the interior of a line segment in 1D.

LINE_GRID, a FORTRAN90 library which computes a grid of points over the interior of a line segment in 1D.

LINE_GRID, a MATLAB library which computes a grid of points over the interior of a line segment in 1D.

LINE_GRID, a Python library which computes a grid of points over the interior of a line segment in 1D.

LINE_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.

LINE_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.

LINE_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.

LINE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.

LINE_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.

LINE_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.

LINE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line segment in 1D.

LINE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line segment in 1D.

LINE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line segment in 1D;

LINE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line segment in 1D;

LINE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line segment in 1D;

LINE_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line segment in 1D;

LINE_NCC_RULE, a C library which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

LINE_NCC_RULE, a C++ library which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

LINE_NCC_RULE, a FORTRAN77 library which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

LINE_NCC_RULE, a FORTRAN90 library which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

LINE_NCC_RULE, a MATLAB library which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

line_nco_rule, a C library which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

line_nco_rule, a C++ library which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

line_nco_rule, a FORTRAN77 library which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

line_nco_rule, a FORTRAN90 library which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

line_nco_rule, a MATLAB library which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.

LINEAR_SOLVE_DISTRIBUTED, a MATLAB program which solves a linear system A*x=b using MATLAB's spmd facility, so that the matrix A is distributed across multiple MATLAB workers.

LINPACK, a C library which solves linear systems for a variety of matrix storage schemes, real or complex arithmetic, and single or double precision. It includes a routine for computing 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, a C++ library which solves linear systems for a variety of matrix storage schemes, real or complex arithmetic, and single or double precision. It includes a routine for computing 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, a FORTRAN77 library which solves linear systems for a variety of matrix storage schemes, real or complex arithmetic, and single or double precision. It includes a routine for computing 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, a FORTRAN90 library which solves linear systems for a variety of matrix storage schemes, real or complex arithmetic, and single or double precision. It includes a routine for computing 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, a MATLAB library which solves linear systems for a variety of matrix storage schemes, real or complex arithmetic, and single or double precision. It includes a routine for computing 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_BENCH, a C program which measures the time taken by LINPACK to solve a particular linear system.

LINPACK_BENCH, a C++ program which measures the time taken by LINPACK to solve a particular linear system.

LINPACK_BENCH, a FORTRAN77 program which measures the time taken by LINPACK to solve a particular linear system.

LINPACK_BENCH, a FORTRAN90 program which measures the time taken by LINPACK to solve a particular linear system.

LINPACK_BENCH, a MATLAB program which measures the time taken by LINPACK to solve a particular linear system.

LINPACK_BENCH_BACKSLASH, a MATLAB program which measures the time taken by LINPACK to solve a particular linear system, and uses MATLAB's built in backslash operator to do the solving.

LINPACK_C, a C++ library which factors and solves linear systems using single precision complex arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_C, a FORTRAN77 library which factors and solves linear systems using single precision complex arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_C, a FORTRAN90 library which factors and solves linear systems using single precision complex arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_C, a MATLAB library which factors and solves linear systems using single precision complex arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_D, a C library which factors and solves linear systems using double precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_D, a C++ library which factors and solves linear systems using double precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_D, a FORTRAN77 library which factors and solves linear systems using double precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_D, a FORTRAN90 library which factors and solves linear systems using double precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_D, a MATLAB library which factors and solves linear systems using double precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_D, a Python library which factors and solves linear systems using double precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_Q, a FORTRAN90 library which implements a few of the LINPACK library of linear solvers, using quadruple precision.

LINPACK_S, a C library which factors and solves linear systems using single precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_S, a C++ library which factors and solves linear systems using single precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_S, a FORTRAN77 library which factors and solves linear systems using single precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_S, a FORTRAN90 library which factors and solves linear systems using single precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_S, a MATLAB library which factors and solves linear systems using single precision real arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_Z, a C++ library which factors and solves linear systems using double precision complex arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_Z, a FORTRAN77 library which factors and solves linear systems using double precision complex arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPACK_Z, a FORTRAN90 library which factors and solves linear systems using double precision complex arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.

LINPLUS_C8, a FORTRAN90 library which carries out various linear algebra operations on complex matrices for matrices in a variety of formats, including tridiagonal, circulant, general, and toeplitz.

LINPLUS_C8, a MATLAB library which carries out various linear algebra operations on complex matrices for matrices in a variety of formats, including tridiagonal, circulant, general, and toeplitz.

LINPLUS_C8, a Python library which carries out various linear algebra operations on complex matrices for matrices in a variety of formats, including tridiagonal, circulant, general, and toeplitz.

LISSAJOUS_OPENGL, a C++ program which computes a 2D Lissajous figure and displays it using OpenGL.

LLSQ, a C library which solves the simple linear least squares (LLS) problem of finding the formula of a straight line y=a*x+b which minimizes the root-mean-square (RMS) error to a set of N data points.

LLSQ, a C++ library which solves the simple linear least squares (LLS) problem of finding the formula of a straight line y=a*x+b which minimizes the root-mean-square (RMS) error to a set of N data points.

LLSQ, a FORTRAN77 library which solves the simple linear least squares (LLS) problem of finding the formula of a straight line y=a*x+b which minimizes the root-mean-square (RMS) error to a set of N data points.

LLSQ, a FORTRAN90 library which solves the simple linear least squares (LLS) problem of finding the formula of a straight line y=a*x+b which minimizes the root-mean-square (RMS) error to a set of N data points.

LLSQ, a MATLAB library which solves the simple linear least squares (LLS) problem of finding the formula of a straight line y=a*x+b which minimizes the root-mean-square (RMS) error to a set of N data points.

LLSQ, a Python library which solves the simple linear least squares (LLS) problem of finding the formula of a straight line y=a*x+b which minimizes the root-mean-square (RMS) error to a set of N data points.

LOBATTO_POLYNOMIAL, a C library which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.

LOBATTO_POLYNOMIAL, a C++ library which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.

LOBATTO_POLYNOMIAL, a FORTRAN77 library which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.

LOBATTO_POLYNOMIAL, a FORTRAN90 library which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.

LOBATTO_POLYNOMIAL, a MATLAB library which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.

LOCAL_MIN_RC, a C library which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.

LOCAL_MIN_RC, a C++ library which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.

LOCAL_MIN_RC, a FORTRAN90 library which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.

LOCAL_MIN_RC, a MATLAB library which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.

LOCAL_MIN_RC, a Python library which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.

LOG_NORMAL, a C library which returns quantities associated with the log normal Probability Distribution Function (PDF).

LOG_NORMAL, a C++ library which returns quantities associated with the log normal Probability Distribution Function (PDF).

LOG_NORMAL, a FORTRAN90 library which returns quantities associated with the log normal Probability Distribution Function (PDF).

LOG_NORMAL, a MATLAB library which returns quantities associated with the log normal Probability Distribution Function (PDF).

LOG_NORMAL, a Python library which returns quantities associated with the log normal Probability Distribution Function (PDF).

LOG_NORMAL_TRUNCATED_AB, a C library which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].

LOG_NORMAL_TRUNCATED_AB, a C++ library which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].

LOG_NORMAL_TRUNCATED_AB, a FORTRAN90 library which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].

LOG_NORMAL_TRUNCATED_AB, a MATLAB library which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].

LOG_NORMAL_TRUNCATED_AB, a Python library which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].

LORENZ_CLUSTER, a MATLAB library which takes a set of N points on a trajectory of solutions to the Lorenz equations, and applies the K-means algorithm to organize the data into K clusters.

LORENZ_EQUATIONS, a MATHEMATICA program which demonstrates how solutions to the Lorenz equations can be synchronized.

LORENZ_ODE, a C program which approximates solutions to the Lorenz system, creating output files that can be displayed by gnuplot.

LORENZ_ODE, a C++ program which approximates solutions to the Lorenz system, creating output files that can be displayed by gnuplot.

LORENZ_ODE, a FORTRAN77 program which approximates solutions to the Lorenz system, creating output files that can be displayed by gnuplot.

LORENZ_ODE, a FORTRAN90 program which approximates solutions to the Lorenz system, creating output files that can be displayed by gnuplot.

LORENZ_ODE, a MATLAB program which approximates solutions to the Lorenz system, creating output files that can be displayed by gnuplot.

LORENZ_ODE, a Python program which approximates solutions to the Lorenz system, creating graphics output using matplotlib.

LORENZ_SIMULATION, a MATLAB program which solves the Lorenz equations and displays the solution, for various starting conditions.

LSOPT examples which illustrate the use of LSOPT, which is a program which can optimize a design that is constructed with the LS-DYNA program.

LUA, examples which illustrate the use of LUA, which is a lightweight scripting language which supports procedural, object-oriented, functional and data-driven programming. It is widely used as the scripting language in games.

LUAJIT, examples which illustrate the use of LUAJIT, which is a Just-In-Time compiler for LUA.

LUHN, a C program which computes the Luhn check digit for a string, and can validate a string.

LUHN, a C++ program which computes the Luhn check digit for a string, and can validate a string.

LUHN, a FORTRAN90 program which computes the Luhn check digit for a string, and can validate a string.

LUHN, a MATLAB program which computes the Luhn check digit for a string, and can validate a string.

LUHN, a Python program which computes the Luhn check digit for a string, and can validate a string.

LYRICS_REMOTE, a MATLAB program which runs in parallel, using three workers which cooperate systolically, that is, as though they were on an assembly line. The output from worker 1 is passed to worker 2 for further processing, and so on. This includes instructions on how to run the job, via MATLAB's batch facility, on a remote system such as Virginia Tech's ithaca cluster.

MACHAR, a C library which computes the appropriate values of machine constants for a given machine, by William Cody.

MACHAR, a C++ library which computes the appropriate values of machine constants for a given machine, by William Cody.

MACHAR, a FORTRAN77 library which computes the appropriate values of machine constants for a given machine, by William Cody.

MACHAR, a FORTRAN90 library which computes the appropriate values of machine constants for a given machine, by William Cody.

MACHAR, a MATLAB library which computes the appropriate values of machine constants for a given machine, by William Cody.

MACHAR, a Python library which computes the appropriate values of machine constants for a given machine, by William Cody.

MACHINE, a C library which stores the appropriate values of machine constants for a given machine.

MACHINE, a C++ library which stores the appropriate values of machine constants for a given machine.

MACHINE, a FORTRAN77 library which stores the appropriate values of machine constants for a given machine.

MACHINE, a FORTRAN90 library which stores the appropriate values of machine constants for a given machine.

MACHINE, a MATLAB library which stores the appropriate values of machine constants for a given machine.

MACHINE, a Python library which stores the appropriate values of machine constants for a given machine.

MAKEFILES, C programs which illustrate the use of MAKEFILES for maintaining a software project;

MAKEFILES, C++ programs which illustrate the use of MAKEFILES for maintaining a software project;

MAKEFILES, FORTRAN77 programs which illustrate the use of MAKEFILES for maintaining a software project;

MAKEFILES, FORTRAN90 programs which illustrate the use of MAKEFILES for maintaining a software project;

MANDELBROT, a C program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;

MANDELBROT, a C++ program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;

MANDELBROT, examples which illustrate the computation of the MANDELBROT set, which is defined as the set of points which remain bounded under a given iteration.

MANDELBROT, a FORTRAN77 program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;

MANDELBROT, a FORTRAN90 program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;

MANDELBROT, a MATLAB program which generates an image of the Mandelbrot fractal set;

MANDELBROT, a Python program which generates a Portable Network Graphics (PNG) image of the Mandelbrot set;

MANDELBROT_ASCII, a C program which generates an ASCII text image of the Mandelbrot fractal set using just two lines of (very obscure) C.

MANDELBROT_OPENMP, a C program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.

MANDELBROT_OPENMP, a C++ program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.

MANDELBROT_OPENMP, a FORTRAN77 program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.

MANDELBROT_OPENMP, a FORTRAN90 program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.

MANDELBROT_PPM, a C program which generates a binary Portable Pixel Map (PPM) image of the Mandelbrot fractal set, by Eric Weeks.

MANDELBROT_PPM, a C++ program which generates a binary Portable Pixel Map (PPM) image of the Mandelbrot fractal set, by Eric Weeks.

MAPLE_AREA, a MATLAB library which takes the list of pixels that form the boundary of the image of a maple leaf within a picture, and uses grid, Monte Carlo, and Quasi Monte Carlo sampling to estimate the area of the leaf.

MAPLE_BOUNDARY, a MATLAB library which reads an image of a maple leaf and extracts the list of pixels that form the boundary.

MARIO, a C program which creates a file of commands to gnuplot() that can be used to plot a sort of "needlepoint" image of Mario, as an array of colored squares.

MARIO, a C++ program which creates a file of commands to gnuplot that can be used to plot a sort of "needlepoint" image of Mario, as an array of colored squares.

MARIO, a FORTRAN90 program which creates a file of commands to gnuplot() that can be used to plot a sort of "needlepoint" image of Mario, as an array of colored squares.

MARIO, a MATLAB program which creates a sort of "needlepoint" image of Mario, as an array of colored squares.

MARIO, a Python program which creates a sort of "needlepoint" image of Mario, as an array of colored squares.

MARTINEZ, a dataset directory which contains datasets for computational statistics, including cluster analysis;

MASS, a FORTRAN90 program which verifies the computation of the mass matrix associated with a finite element method (FEM) solution to a 2D fluid flow problem governed by the Navier Stokes equations (NSE).

MATALG, a FORTRAN90 program which carries out matrix calculations;

MATH2070, MATLAB programs which were used for a numerical analysis laboratory class.

MATH2071, MATLAB programs which were used for a numerical analysis laboratory class.

MATHEMATICA, examples which illustrate the use of MATHEMATICA, which is an interactive program for symbolic calculation.

MATHJAX, examples which illustrate the use of MATHJAX, which is a system for displaying mathematical notation in a web page.

MATLAB, examples which illustrate the use of MATLAB, which is a programming language for engineering, numerical, and scientific problems.

MATLAB, MATLAB programs which illustrate the use of the MATLAB programming language;

MATLAB_CALLS_C, MATLAB programs which call a C function using MATLAB's mex compiler;

MATLAB_CALLS_C++, MATLAB programs which call a C++ function using MATLAB's mex compiler;

MATLAB_CALLS_F77, MATLAB programs which call a FORTRAN77 function using MATLAB's mex compiler;

MATLAB_CALLS_F90, MATLAB programs which call a FORTRAN90 function using MATLAB's mex compiler;

MATLAB_COMMANDLINE, MATLAB programs which illustrate how MATLAB can be run from the UNIX command line, that is, not with the usual MATLAB command window.

MATLAB_COMPILER, MATLAB programs which illustrate the use of the Matlab compiler, which allows you to run a Matlab application outside the Matlab environment.

MATLAB_CONDOR, MATLAB programs which illustrate how MATLAB can be run in batch mode using the condor queueing system.

MATLAB_DISTCOMP, a MATLAB program which remotely runs a set of 5 jobs on Virginia Tech's Ithaca cluster.

MATLAB_GRAPHICS, MATLAB programs which demonstrate a few issues that arise when producing graphic images with MATLAB.

MATLAB_KMEANS, MATLAB programs which illustrate the use of MATLAB's kmeans() function for clustering N sets of M-dimensional data into K clusters.

MATLAB_MAP, MATLAB programs which illustrate the use of the MATLAB Mapping Toolbox.

MATLAB_MISTAKE, programs which illustrate some simple but devious programming mistakes in MATLAB.

MATLAB_MOVIES, MATLAB programs which illustrate making movies using MATLAB;

MATLAB_OS, MATLAB programs which illustrate how the system() command can be used to allow MATLAB to issue commands to the computer operating system (UNIX or DOS);

MATLAB_PARALLEL, examples which illustrate local parallel programming on a single computer with MATLAB's Parallel Computing Toolbox.

MATLAB_RANDOM, MATLAB programs which illustrate the use of Matlab's random number generator (RNG) functions.

MATLAB_RANDOM_PARALLEL, MATLAB programs which illustrate the use of Matlab's random number generator (RNG) functions when using parallel features such as parfor or spmd.

MATLAB_REMOTE, MATLAB programs which illustrate the use of remote job execution, in which a desktop copy of MATLAB sends programs and data to a remote machine for execution. Included is information needed to properly configure the local machine.

MATLAB_RETURN, MATLAB programs which illustrate that explicitly invoking the MATLAB RETURN statment can be surprisingly costly;

MATLAB_SURF, a MATLAB library which demonstrates the MATLAB surf() function for displaying a 3D surface of the form Z=F(X,Y).

MATMAN, a FORTRAN77 program which manipulates matrices;

MATMAN, a FORTRAN90 program which manipulates matrices;

MATMUL, a C program which an interactive matrix multiplication benchmark.

MATMUL, a FORTRAN77 program which an interactive matrix multiplication benchmark.

MATMUL, a FORTRAN90 program which an interactive matrix multiplication benchmark.

MATPLOTLIB, examples which illustrate the use of MATPLOTLIB, which is a graphics library for Python.

MATRIX_ASSEMBLE_PARFOR, a MATLAB program which demonstrates the parfor parallel programming feature by assembling the Hilbert matrix in a parallel loop.

MATRIX_ASSEMBLE_SPMD, a MATLAB program which demonstrates the Single Program Multiple Data (SPMD) parallel programming feature by having each worker assemble part of the Hilbert matrix, which is then combined into one array by the client program.

MATRIX_EXPONENTIAL, a C library which demonstrates some simple approaches to the problem of computing the exponential of a matrix.

MATRIX_EXPONENTIAL, a C++ library which demonstrates some simple approaches to the problem of computing the exponential of a matrix.

MATRIX_EXPONENTIAL, a FORTRAN77 library which demonstrates some simple approaches to the problem of computing the exponential of a matrix.

MATRIX_EXPONENTIAL, a FORTRAN90 library which demonstrates some simple approaches to the problem of computing the exponential of a matrix.

MATRIX_EXPONENTIAL, a MATLAB library which demonstrates some simple approaches to the problem of computing the exponential of a matrix.

MATRIX_EXPONENTIAL, a Python library which demonstrates some simple approaches to the problem of computing the exponential of a matrix.

MATT_MESSAGE a C program which simulates the operation of a satellite warning system which communicates by a series of formatted messages indicating the location and type of various threats.

MD, a C program which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.

MD, a C++ program which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.

MD, a FORTRAN77 program which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.

MD, a FORTRAN90 program which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.

MD, a MATLAB program which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.

MD, a Python program which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.

MD_FAST, a MATLAB program which carries out a molecular dynamics simulation; it is a version of MD that has been revised to take advantage of MATLAB's vector abilities.

MD_OPENMP, a C program which carries out a molecular dynamics simulation in parallel, using OpenMP.

MD_OPENMP, a C++ program which carries out a molecular dynamics simulation in parallel, using OpenMP.

MD_OPENMP, a FORTRAN77 program which carries out a molecular dynamics simulation in parallel, using OpenMP.

MD_OPENMP, a FORTRAN90 program which carries out a molecular dynamics simulation in parallel, using OpenMP.

MD_PARFOR, a MATLAB program which carries out a molecular dynamics simulation, running in parallel using MATLAB's parfor feature.

MD1, a FORTRAN90 program which carries out a molecular dynamics simulation, and which writes graphics files for processing by gnuplot().

MD2, a FORTRAN90 program which carries out a molecular dynamics simulation.

MD3, a FORTRAN90 program which carries out a molecular dynamics simulation.

MD3GLUE, a FORTRAN90 program which carries out a molecular dynamics simulation.

MDS, a dataset directory which contains datasets for M-dimensional scaling;

MEDIT, a data directory which contains examples of files which can be used by the MEDIT program to define a 2D or 3D mesh for use by the finite element method (FEM), using triangles, quadrilaterals, tetrahedrons or hexahedrons.

MEDIT, examples which illustrate the use of medit, an interactive graphics program developed to visualize numerical simulation results on unstructured meshes in two and three dimensions. Scalar, vector and tensor fields can be easily associated and displayed with meshes. The program is by Pascal Frey.

MEDIT_IO, a C library which can read or write files used by the MEDIT program, which can be used to define the a mesh associated with the finite element method (FEM) in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.

MEDIT_IO, a C++ library which can read or write files used by the MEDIT program, which can be used to define the a mesh associated with the finite element method (FEM) in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.

MEDIT_IO, a FORTRAN77 library which can read or write files used by the MEDIT program, which can be used to define the a mesh associated with the finite element method (FEM) in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.

MEDIT_IO, a FORTRAN90 library which can read or write files used by the MEDIT program, which can be used to define the a mesh associated with the finite element method (FEM) in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.

MEDIT_IO, a MATLAB library which can read or write files used by the MEDIT program, which can be used to define the a mesh associated with the finite element method (FEM) in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.

MEDIT_TO_FEM, a C program which reads a mesh file created by the MEDIT program and writes a corresponding pair of node and element files that correspond to the FEM format.

MEDIT_TO_FEM, a C++ program which reads a mesh file created by the MEDIT program and writes a corresponding pair of node and element files that correspond to the FEM format.

MEDIT_TO_FEM, a FORTRAN77 program which reads a mesh file created by the MEDIT program and writes a corresponding pair of node and element files that correspond to the FEM format.

MEDIT_TO_FEM, a FORTRAN90 program which reads a mesh file created by the MEDIT program and writes a corresponding pair of node and element files that correspond to the FEM format.

MEDIT_TO_FEM, a MATLAB program which reads a mesh file created by the MEDIT program and writes a corresponding pair of node and element files that correspond to the FEM format.

membrane, a FENICS script which models the deflection of a circular elastic membrane subject to a perpendicular pressure modeled as a Gaussian function.

MEMORY_TEST, a C program which declares and uses a sequence of larger and larger vectors, to see how big a vector can be used on a given machine and compiler.

MEMORY_TEST, a C++ program which declares and uses a sequence of larger and larger vectors, to see how big a vector can be used on a given machine and compiler.

MEMORY_TEST, a FORTRAN90 program which declares and uses a sequence of larger and larger vectors, to see how big a vector can be used on a given machine and compiler.

MEMORY_TEST, a MATLAB program which declares and uses a sequence of larger and larger vectors, to see how big a vector can be used on a given machine and compiler.

MESH, a data directory which contains examples of MESH files, which define a finite element mesh.

MESH_BANDWIDTH, a C program which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.

MESH_BANDWIDTH, a C++ program which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.

MESH_BANDWIDTH, a FORTRAN77 program which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.

MESH_BANDWIDTH, a FORTRAN90 program which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.

MESH_BANDWIDTH, a MATLAB program which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.

MESH_DISPLAY, a MATLAB program which plots the nodes and elements of a polygonal mesh, with optional numbering.

MESH_DISPLAY_OPENGL, a C++ program which reads the name of two data files defining a polygonal mesh, reads the data, and displays the mesh using OPENGL.

MESH_ETOE, a MATLAB program which uses ETOV, the mesh element-to-vertex connectivity, to construct ETOE, the element-to-element connectivity.

MESH_IO, a C library which reads or writes MESH files defining a finite element mesh.

MESH_IO, a C++ library which reads or writes MESH files defining a finite element mesh.

MESH_IO, a FORTRAN90 library which reads or writes MESH files defining a finite element mesh.

MESH_IO, a MATLAB library which reads or writes MESH files defining a finite element mesh.

mesh_test, a FENICS script which demonstrates some properties of the objects created by the various FEniCS meshing functions.

MESH_TO_ICE, a C program which reads a MESH file containing an ICE dataset and rewrites the information as a NETCDF file.

MESH_TO_ICE, a C++ program which reads a MESH file containing an ICE dataset and rewrites the information as a NETCDF file.

MESH_TO_ICE, a FORTRAN90 program which reads a MESH file containing an ICE dataset and rewrites the information as a NETCDF file.

MESH_TO_ICE, a MATLAB program which reads a MESH file containing an ICE dataset and rewrites the information as a NETCDF file.

MESH_VTOE, a MATLAB program which uses ETOV, the mesh element-to-vertex connectivity, to construct VTOE, the vertex-to-element connectivity.

MESH2D, a MATLAB library which can automatically create a triangular mesh for a given polygonal region, by Darren Engwirda.

MESH2D_HAND, a MATLAB program which reads in a set of 59 points which outline a human hand, and calls MESH2D, which is able to create a fine triangular mesh of the region outlined by the points.

MESH2D_TO_MEDIT, a MATLAB program which accepts the nodes and triangles of a mesh created by MESH2D and creates a corresponding file that is in MEDIT format.

MESH2D_WRITE, a MATLAB program which demonstrates how MESH2D node and element data can be written to files.

meshes, a FENICS script which generates and plots the simple built-in mesh types that FENICS provides.

MESHFACES, a MATLAB library which can automatically create a triangular mesh for a given polygonal region that has been subdivided into multiple faces, by Darren Engwirda.

MESHLAB, a data directory of examples of files that can be used by the MESHLAB program.

MESHLAB, examples which illustrate the use of the meshlab program, an advanced mesh processing system for automatic or user-assisted editing, cleaning, filtering, converting and rendering of large unstructured 3D triangular meshes. MESHLAB can read and write 3DS, OBJ, OFF, PLY, and STL graphics files.

MESHLESS, a FORTRAN90 library which computes a meshless grid by using a centroidal Voronoi tessellation (CVT), by Lili Ju.

MET, a data directory which contains examples of MET files, a graphics file format used by the DISLIN plotting package of Helmut Michels.

metis_test, C programs which demonstrate the use of the metis library, which can partition unstructured graphs or meshes, and compute fill-reducing reorderings of sparse matrices.

metis_test, C++ programs which demonstrate the use of the metis library, which can partition unstructured graphs or meshes, and compute fill-reducing reorderings of sparse matrices.

metis_test, FORTRAN90 programs which demonstrate the use of the metis library, which can partition unstructured graphs or meshes, and compute fill-reducing reorderings of sparse matrices.

METIS, examples which illustrate the use of the METIS programs gpmetis, graphchk, m2gmetis, mpmetis, ndmetis, to partition the nodes of a graph or the elements of a mesh, for division among a number of parallel processes, or to reorder the variables in a sparse matrix to minimize fillin, by George Karypis.

METIS_GRAPH, a data directory which contains examples of METIS GRAPH files, the format for graphs to be read by METIS, which can partition a graph;

METIS_MESH, a data directory which contains examples of METIS MESH files, the format for meshes associated with the finite element method (FEM), to be read by METIS, which can partition the elements of such a mesh;

MEX, MATLAB programs which call lower-level functions written in traditional languages such as C, C++, FORTRAN77 or FORTRAN90, compiled with MATLAB's mex compiler.

MG_SERIAL, a FORTRAN77 program which is a serial version of the NAS MultiGrid (MG) Parallel Benchmark.

MGMRES, a C library which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using compressed row (CR) or sparse triplet (ST) format, by Lili Ju.

MGMRES, a C++ library which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using compressed row (CR) or sparse triplet (ST) format, by Lili Ju.

MGMRES, a FORTRAN77 library which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using compressed row (CR) or sparse triplet (ST) format, by Lili Ju.

MGMRES, a FORTRAN90 library which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using compressed row (CR) or sparse triplet (ST) format, by Lili Ju.

MGMRES, a MATLAB library which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using compressed row (CR) or sparse triplet (ST) format, by Lili Ju.

MGS, a C library which is an example of legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.

MGS, a C++ library which is an example of legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.

MGS, a FORTRAN77 library which is an example of legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.

MGS, a FORTRAN90 library which is an example of legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.

MGS, a MATLAB library which is an example of legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.

MHD_CONTROL, a dataset directory which contains datasets from the control of a magnetic hydrodynamic (MHD) 2D flow;

MHD_CONTROL, a FORTRAN90 program which controls the evolution of a magnetic hydrodynamic (MHD) system so that a particular state is achieved.

MHD_CONTROL_MOVIE, a MATHEMATICA program which displays and animates the output data from a magnetic hydrodynamic (MHD) control problem.

MHD_FLOW, a FORTRAN90 program which simulates the evolution of a system governed by the equations for 2D magnetohydrodynamics (MHD).

MINESWEEPER, a C++ program which is a text-based implementation of the Minesweeper game, by Detelina Stoyanova.

MINIA, examples which illustrate the use of MINIA, which is a short read assembler based on a de Bruijn graph.

MINPACK, a C++ library which solves systems of nonlinear equations, or the least squares minimization of the residual of a set of linear or nonlinear equations.

MINPACK, a FORTRAN77 library which solves systems of nonlinear equations, or the least squares minimization of the residual of a set of linear or nonlinear equations.

MINPACK, a FORTRAN90 library which solves systems of nonlinear equations, or the least squares minimization of the residual of a set of linear or nonlinear equations.

MITCHELL_DEALII, examples which illustrate the implementation of the Mitchell 2D elliptic partial differential equation (PDE) test problems using DEAL.II.

MITCHELL, FENICS scripts which illustrate the implementation of the Mitchell 2D elliptic partial differential equation (PDE) test problems using FENICS.

MITCHELL_FREEFEM++, examples which illustrate the implementation of the Mitchell 2D elliptic partial differential equation (PDE) test problems using FREEFEM++.

MITTAG_LEFFLER_GARAPPA, a MATLAB library which evaluates the Mittag-Leffler function of one, two, or three parameters, with the Z argument allowed to be complex, by Roberto Garappa.

MITTAG_LEFFLER_PODLUBNY, a MATLAB library which evaluates the two-parameter Mittag-Leffler function of real arguments, by Igor Podlubny and Martin Kacenak.

MITTAG_LEFFLER_ZONGZE, a MATLAB library which evaluates the Mittag-Leffler function of one or two parameters, with the Z argument allowed to be complex, by Yang Zongze.

MIXED, C programs which call a function written in another programming language.

MIXED, C++ programs which call a function written in another programming language.

MIXED, FORTRAN77 programs which call a function written in another programming language.

MIXED, FORTRAN90 programs which call a function written in another programming language.

MIXTURE, a FORTRAN90 program which simulates a process governed by a Dirichlet mixture distribution.

MKL, examples which illustrate the use of MKL, the Intel Math Kernel Library, which provides a library of mathematical functions that are highly optimized for Intel hardware and compilers. This includes a version of the Basic Linear Algebra Subprograms (BLAS) and LAPACK.

MM, a data directory which contains examples of the Matrix Market (MM) Sparse Matrix File Format;

MM_IO, a C library which reads and writes sparse linear systems stored in the Matrix Market (MM) format.

MM_IO, a FORTRAN77 library which reads and writes sparse linear systems stored in the Matrix Market (MM) format.

MM_IO, a FORTRAN90 library which reads and writes sparse linear systems stored in the Matrix Market (MM) format.

MM_IO, a MATLAB library which reads and writes sparse linear systems stored in the Matrix Market (MM) format.

MM_TO_HB, a MATLAB program which reads the sparse matrix information from an Matrix Market (MM) file and writes a corresponding Harwell Boeing (HB) file.

MM_TO_MSM, a MATLAB program which reads a Matrix Market (MM) file defining a sparse matrix, and creates a corresponding MATLAB sparse matrix data structure.

MM_TO_ST, a MATLAB program which reads the sparse matrix information from a Matrix Market (MM) file and writes a corresponding Sparse Triplet (ST) file.

MOAB, examples which illustrate the use of the MOAB job scheduler for batch execution of jobs on a computer cluster.

MOC_DISPLAY, a MATLAB program which estimates and displays the modulus of continuity function for a given function F(X) over a finite interval [A,B], using N sample values.

MODULE_MARK, a FORTRAN90 program which replaces bare "END" statements by "END (module name)" statements in a FORTRAN90 file.

MONOALPHABETIC, a MATLAB library which can apply a monoalphabetic substitution cipher to a string of text.

MONOMIAL, a C library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.

MONOMIAL, a C++ library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.

MONOMIAL, a FORTRAN77 library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.

MONOMIAL, a FORTRAN90 library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.

MONOMIAL, a MATLAB library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.

MONOMIAL, a Python library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.

MONOMIAL_VALUE, a C library which evaluates a monomial in M dimensions.

MONOMIAL_VALUE, a C++ library which evaluates a monomial in M dimensions.

MONOMIAL_VALUE, a FORTRAN77 library which evaluates a monomial in M dimensions.

MONOMIAL_VALUE, a FORTRAN90 library which evaluates a monomial in M dimensions.

MONOMIAL_VALUE, a MATLAB library which evaluates a monomial in M dimensions.

MONOMIAL_VALUE, a Python library which evaluates a monomial in M dimensions.

MONTE_CARLO_RULE, a C program which uses a random number generator (RNG) to create 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, a C++ program which uses a random number generator (RNG) to create 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, a FORTRAN77 program which uses a random number generator (RNG) to create 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, a FORTRAN90 program which uses a random number generator (RNG) to create 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, a MATLAB program which uses a random number generator (RNG) to create 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.

MOTHUR, examples which illustrate the use of MOTHUR, which is a Python-based bioinformatics tool for analyzing 16S rRNA gene sequences and is focussed on the microbial ecology community.

MOVIE_DATA_REFORMAT, a FORTRAN90 program which reformats movie data, copied from THE NUMBERS movie data web page, into a CSV format suitable for input to Excel or a statistical analysis package such as R.

MPAS_DRAW, a C++ program which reads information from a netcdf file written by the MPAS program, containing the grid information and computed solution values, some of which may be time dependent, or organized in vertical atmospheric levels, and then displays graphic images of data using OpenGL.

MPAS_GRID_DISPLAY_OPENGL, C++ programs which read information from an MPAS Grid file, stored in NETCDF format, and display the main (mainly hexagonal) mesh or the dual triangulation, using OpenGL.

MPAS_GRID_DISPLAY, MATLAB programs which read information from an MPAS Grid file, stored in NETCDF format, and display the main (mainly hexagonal) mesh or the dual triangulation.

MPE2, examples which illustrate the use of MPE2, the MPI parallel environment, a set of libraries and tools for timing, collecting and visualizing the performance of an MPI program.

MPI, C programs which illustrate the use of the MPI application program interface for parallel computations in a distributed memory environment.

MPI, C++ programs which illustrate the use of the MPI application program interface for parallel computations in a distributed memory environment.

MPI, FORTRAN77 programs which illustrate the use of the MPI application program interface for parallel computations in a distributed memory environment.

MPI, FORTRAN90 programs which illustrate the use of the MPI application program interface for parallel computations in a distributed memory environment.

MPI_STUBS, a C library which contains stub MPI routines, allowing a user to compile, load, and possibly run an MPI program on a serial machine.

MPI_STUBS, a C++ library which contains stub MPI routines, allowing a user to compile, load, and possibly run an MPI program on a serial machine.

MPI_STUBS, a FORTRAN77 library which contains stub MPI routines, allowing a user to compile, load, and possibly run an MPI program on a serial machine.

MPI_STUBS, a FORTRAN90 library which contains stub MPI routines, allowing a user to compile, load, and possibly run an MPI program on a serial machine.

MPI4PY, examples which illustrate the use of MPI4PY, which allows Python programs to run in parallel under MPI.

MPIBLAST, examples which illustrate the use of MPIBLAST, which is a version of the basic local alignment search tool that runs in parallel using MPI.

MPICH, examples which illustrate the use of MPICH, which is one of several implementations of the MPI interface for parallel programming with distributed memory.

MPIP, examples which illustrate the use of MPIP, which is a lightweight utility for monitoring and reporting the performance of programs running in parallel under MPI.

MPS, a dataset directory which contains linear programming datasets;

MPSC, a dataset directory which contains linear programming datasets in compressed format;

MRBAYES, examples which illustrate the use of MRBAYES, which is a program for Bayesian inference and model choice across a large space of evolutionary and phylogenetic models, using Markov Chain Monte Carlo (MCMC) methods. The program has a command-line interface and should run on a variety of computer platforms, including large computer clusters and multicore machines.

MRI_TO_ASCII, a C program which converts the binary data in a magnetic resonance imaging (MRI) file to ASCII text.

MRI_TO_PGM, a C program which converts the binary data in a magnetic resonance imaging (MRI) file to a sequence of Portable Gray Map (PGM) image files.

MSH, a data directory of examples of MSH files, the native 3D mesh format used by Gmsh.

MSM_TO_HB, a MATLAB program which writes a MATLAB sparse matrix to a Harwell Boeing (HB) file, by Xiaoye Li.

MSM_TO_MM, a MATLAB program which writes a MATLAB sparse matrix to a Matrix Market (MM) file;

MSM_TO_ST, a MATLAB program which writes a MATLAB sparse matrix to a Sparse Triplet (ST) file;

MULTIGRID_POISSON_1D, a C library which applies the multigrid method to a discretized version of the 1D Poisson equation.

MULTIGRID_POISSON_1D, a C++ library which applies the multigrid method to a discretized version of the 1D Poisson equation.

MULTIGRID_POISSON_1D, a FORTRAN77 library which applies the multigrid method to a discretized version of the 1D Poisson equation.

MULTIGRID_POISSON_1D, a FORTRAN90 library which applies the multigrid method to a discretized version of the 1D Poisson equation.

MULTIGRID_POISSON_1D, a MATLAB library which applies the multigrid method to a discretized version of the 1D Poisson equation.

MULTITASK_MPI, a C program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using MPI for parallel execution.

MULTITASK_MPI, a C++ program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using MPI for parallel execution.

MULTITASK_MPI, a FORTRAN77 program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using MPI for parallel execution.

MULTITASK_MPI, a FORTRAN90 program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using MPI for parallel execution.

MULTITASK_OPENMP, a C program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.

MULTITASK_OPENMP, a C++ program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.

MULTITASK_OPENMP, a FORTRAN77 program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.

MULTITASK_OPENMP, a FORTRAN90 program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.

mumps_test, FORTRAN90 programs which call mumps for the solution of large linear systems.

MUS, a FORTRAN77 library which implements the multiple shooting method for two point boundary value problems (BVP's), for linear or nonlinear cases, by Robert Mattheij and G Staarink.

MVAPICH2, examples which illustrate the use of MVAPICH2, which is one of several implementations of the MPI interface for parallel programming with distributed memory.

MVAPICH2-TEST, examples which illustrate the use of MVAPICH2-TEST, which is one of several implementations of the MPI interface for parallel programming with distributed memory. This is a variant test version of MVAPICH2.

MXM, a C program which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.

MXM, a C++ program which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.

MXM, a FORTRAN77 program which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.

MXM, a FORTRAN90 program which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.

MXM, a MATLAB program which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.

MXM_OPENMP, a C program which computes a dense matrix product C=A*B, using OpenMP for parallel execution.

MXM_OPENMP, a C++ program which computes a dense matrix product C=A*B, using OpenMP for parallel execution.

MXM_OPENMP, a FORTRAN77 program which computes a dense matrix product C=A*B, using OpenMP for parallel execution.

MXM_OPENMP, a FORTRAN90 program which computes a dense matrix product C=A*B, using OpenMP for parallel execution.

MXM_SERIAL, a C program which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.

MXM_SERIAL, a C++ program which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.

MXM_SERIAL, a FORTRAN77 program which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.

MXM_SERIAL, a FORTRAN90 program which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.

MY_CALENDAR, a C++ program which checks a calendar file and prints any line containing the current date;

NACA, a C library which can take the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data can be displayed with gnuplot().

NACA, a C++ library which can take the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data can be displayed with gnuplot().

NACA, a FORTRAN77 library which can take the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data can be displayed with gnuplot().

NACA, a FORTRAN90 library which can take the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data can be displayed with gnuplot().

NACA, a MATLAB library which can take the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data can be displayed with MATLAB graphics.

NACA, a Python library which can take the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data can be displayed with MATPLOTLIB graphics.

NAMD, examples which illustrate the use of NAMD, a molecular dynamics program for large biomolecular systems, running in parallel under MPI.

NAMD-GPU, examples which illustrate the use of NAMD-GPU, which is a GPU version of the NAMD molecular dynamics program for large biomolecular systems.

NAPACK, a FORTRAN77 library which includes many routines for applied numerical linear algebra tasks, including the matrix condition number, by William Hager.

NAS, a C program which runs the NASA kernel benchmark.

NAS, a C++ program which runs the NASA kernel benchmark.

NAS, a FORTRAN77 program which runs the NASA kernel benchmark.

NAS, a FORTRAN90 program which runs the NASA kernel benchmark.

NAS, a MATLAB program which runs the NASA kernel benchmark.

NAS, a Python program which runs the NASA kernel benchmark.

NASTRAN, examples which illustrate the use of NASTRAN, which is a structural analysis program based on the finite element method.

NAVIER_STOKES_2D_EXACT, a C library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.

NAVIER_STOKES_2D_EXACT, a C++ library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.

NAVIER_STOKES_2D_EXACT, a FORTRAN77 library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.

NAVIER_STOKES_2D_EXACT, a FORTRAN90 library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.

NAVIER_STOKES_2D_EXACT, a MATLAB library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.

NAVIER_STOKES_2D_EXACT, a Python library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.

NAVIER_STOKES_3D_EXACT, a C library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.

NAVIER_STOKES_3D_EXACT, a C++ library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.

NAVIER_STOKES_3D_EXACT, a FORTRAN77 library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.

NAVIER_STOKES_3D_EXACT, a FORTRAN90 library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.

NAVIER_STOKES_3D_EXACT, a MATLAB library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.

NAVIER_STOKES_3D_EXACT, a Python library which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.

NAVIER_STOKES_MESH2D, MATLAB data files which define triangular meshes for several 2D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.

NAVIER_STOKES_MESH3D, MATLAB data files which define tetrahedral meshes for several 3D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.

NCARG, FORTRAN77 programs which illustrate the use of the NCAR graphics library;

NCBI-BLAST+, examples which illustrate the use of NCBI BLAST+, a Basic Local Alignment Search Tool.

NCL, examples which illustrate the use of NCL, which is the NCAR Command Language, a simple scripting language that can read data, define graphics attributes, and create maps, contour plots, line drawings, and other graphical output, to be displayed on the terminal or saved in a graphics file.

NCM, MATLAB programs which accompany Cleve Moler's textbook "Numerical Computing with MATLAB".

NCO, examples which illustrate the use of NCO, which is a collection of programs that can work with data stored in netcdf files.

NCVIEW, examples which illustrate the use of NCVIEW, which can read the data in a NETCDF file, and allow the user to see the identifiers and properties of the various sets of data, to examine individual data values, to view the data along various dimensions, or to see color contour plots of the data.

NEAREST_INTERP_1D, a C library which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().

NEAREST_INTERP_1D, a C++ library which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().

NEAREST_INTERP_1D, a FORTRAN77 library which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().

NEAREST_INTERP_1D, a FORTRAN90 library which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().

NEAREST_INTERP_1D, a MATLAB library which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion.

NEAREST_INTERP_1D, a Python library which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion.

NEAREST_NEIGHBOR, a MATLAB library which works in a given M-dimensional space, seeking, for each point in a set S, the nearest point in a set R, by Richard Brown.

NEIGHBORS_TO_METIS_GRAPH, a C++ program which reads a file describing the neighbor structure of a triangulation or tet mesh, and writes a metis graph file suitable for input to one of the family of programs based on metis.

NEIGHBORS_TO_METIS_GRAPH, a FORTRAN90 program which reads a file describing the neighbor structure of a triangulation or tet mesh, and writes a metis graph file suitable for input to one of the family of programs based on metis.

NEIGHBORS_TO_METIS_GRAPH, a MATLAB program which reads a file describing the neighbor structure of a triangulation or tet mesh, and writes a metis graph file suitable for input to one of the family of programs based on metis.

NELDER_MEAD, a MATLAB program which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by Jeff Borggaard.

NESTED_SEQUENCE_DISPLAY, a MATLAB program which displays a set of nested sequences.

NETCDF, a data directory which contains examples of netcdf files, a format for the interchange of scientific data.

netcdf_test, C programs which read and write netcdf files.

netcdf_test, C++ programs which read and write netcdf files.

NETCDF, examples which illustrate the use of NETCDF, which is the NETCDF portable datafile library.

NETCDF, FORTRAN77 programs which read and write netcdf files.

netcdf_test, FORTRAN90 programs which read and write netcdf files.

netcdf_test, MATLAB programs which read and write netcdf files.

NETCDF-C, examples which illustrate the use of NETCDF-C, which is the C interface to the NETCDF portable datafile library.

NETCDF-C-PAR, examples which illustrate the use of NETCDF-C-PAR, which is the C interface to the parallel NETCDF library.

NETCDF-CXX, examples which illustrate the use of NETCDF-CXX, which is the C++ interface to the NETCDF portable datafile library.

NETCDF-F90, examples which illustrate the use of the FORTRAN90 interface to the NETCDF portable datafile library.

NETCDF_MPAS a C++ library which reads MPAS grid files, stored using the NETCDF format.

NETCDF_MPAS a MATLAB library which reads MPAS grid files, stored using the NETCDF format.

NETCDF_MPAS a data directory which contains examples of MPAS grid files, stored using the NETCDF format.

NETCDF-PAR, examples which illustrate the use of NETCDF-PAR, which is the interface to the parallel NETCDF library.

NETODE, a FORTRAN77 program which models the time-dependent behavior of a two-phase fluid in an abstract network of nodes and links.

neumann, a FENICS script which solves a boundary value problem in the unit square, for which homogeneous Neumann conditions are imposed, adapted from a program by Doug Arnold.

NEWTON, a Python library which uses Newton's method to solve a single nonlinear equation f(x)=0.

NEWTON_COTES, a Mathematica library which computes the points and weights for Newton-Cotes quadrature.

NEWTON_INTERP_1D, a C library which finds a polynomial interpolant to data using Newton divided differences.

NEWTON_INTERP_1D, a C++ library which finds a polynomial interpolant to data using Newton divided differences.

NEWTON_INTERP_1D, a FORTRAN90 library which finds a polynomial interpolant to data using Newton divided differences.

NEWTON_INTERP_1D, a MATLAB library which finds a polynomial interpolant to data using Newton divided differences.

NEWTON_INTERP_1D, a Python library which finds a polynomial interpolant to data using Newton divided differences.

NEWTON_RC, a FORTRAN77 program which demonstrates the use of Newton's method to solve a system of nonlinear equations, using reverse communication (RC).

NGRAMS, a Python library which can analyze a string or text against the observed frequency of "ngrams" (particular sequences of n letters) in English text.

NGRAMS, a dataset directory which contains information about the observed frequency of "ngrams" (particular sequences of n letters) in English text.

NIEDERREITER, a C++ library which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence, for an arbitrary base.

NIEDERREITER, a FORTRAN90 library which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence, for an arbitrary base.

NIEDERREITER2, a dataset directory which contains examples of the Niederreiter Quasi Monte Carlo (QMC) sequence using a base of 2;

NIEDERREITER2, a C++ library which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.

NIEDERREITER2, a FORTRAN90 library which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.

NIEDERREITER2, a MATLAB library which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.

NIEDERREITER2_DATASET, a C++ program which creates a Niederreiter Quasi Monte Carlo (QMC) dataset with base 2;

NIEDERREITER2_DATASET, a FORTRAN90 program which creates a Niederreiter Quasi Monte Carlo (QMC) dataset with base 2;

NIEDERREITER2_DATASET, a MATLAB program which creates a Niederreiter Quasi Monte Carlo (QMC) dataset with base 2;

NINT_EXACTNESS_MIXED, a C++ program which measures the monomial exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.

NINT_EXACTNESS_MIXED, a FORTRAN90 program which measures the monomial exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.

NINT_EXACTNESS_MIXED, a MATLAB program which measures the monomial exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.

NINTLIB, a C library which estimates integrals over M-dimensional regions.

NINTLIB, a C++ library which estimates integrals over M-dimensional regions.

NINTLIB, a FORTRAN77 library which estimates integrals over M-dimensional regions.

NINTLIB, a FORTRAN90 library which estimates integrals over M-dimensional regions.

NINTLIB, a MATLAB library which estimates integrals over M-dimensional regions.

NL2SOL, a FORTRAN77 library which implements an adaptive nonlinear least squares (NLS) algorithm, by John Dennis, David Gay, and Roy Welsch.

NL2SOL, a FORTRAN90 library which implements an adaptive nonlinear least squares (NLS) algorithm, by John Dennis, David Gay, and Roy Welsch.

NMS, a FORTRAN77 library which includes a wide variety of numerical software, including solvers for linear systems of equations, a Piecewise Cubic Hermite Interpolation Package (PCHIP), numerical quadrature, linear least squares data fitting, the solution of nonlinear equations, ordinary differential equations (ODE's), optimization and nonlinear least squares (NLS), simulation and random numbers, trigonometric approximation and Fast Fourier Transforms (FFT).

NMS, a FORTRAN90 library which includes a wide variety of numerical software, including solvers for linear systems of equations, a Piecewise Cubic Hermite Interpolation Package (PCHIP), numerical quadrature, linear least squares data fitting, the solution of nonlinear equations, ordinary differential equations (ODE's), optimization and nonlinear least squares (NLS), simulation and random numbers, trigonometric approximation and Fast Fourier Transforms (FFT).

NORMAL, a C library which contains random number generators (RNG's) for normally distributed values.

NORMAL, a C++ library which contains random number generators (RNG's) for normally distributed values.

NORMAL, a FORTRAN77 library which contains random number generators (RNG's) for normally distributed values.

NORMAL, a FORTRAN90 library which contains random number generators (RNG's) for normally distributed values.

NORMAL, a MATLAB library which contains random number generators (RNG's) for normally distributed values.

NORMAL, a Python library which contains random number generators (RNG's) for normally distributed values.

NORMAL_DATASET, a C++ program which uses a normal random number generator (RNG) to create a dataset of M-dimensional values and writes them to a file.

NORMAL_DATASET, a FORTRAN90 program which uses a normal random number generator (RNG) to create a dataset of M-dimensional values and writes them to a file.

NORMAL_DATASET, a MATLAB program which uses a normal random number generator (RNG) to create a dataset of M-dimensional values and writes them to a file.

NOSE, examples which illustrate the use of NOSE, which is a program which automatically finds, runs, and reports on unit tests for Python packages.

NS3D_FEM, a MATLAB program which sets up and solves a finite element method (FEM) formulation of the steady (time independent) incompressible 3D Navier Stokes equations (NSE) on a user-defined geometry. The program can output graphics files for TECPLOT, VU or the VTK format used by the paraview interactive visualization program. The program is by Jeff Borggaard.

NSASM, a C library which computes the jacobian matrix associated with a finite element method (FEM) approximation of the incompressible steady (time independent) Navier-Stokes equations (NSE) in 2D, and to store these as a sparse matrix. It is designed to be compiled with MATLAB's mex compiler and called from a MATLAB main program. The program is by Per-Olof Persson.

NSASM, a FORTRAN90 library which computes the jacobian matrix associated with a finite element method (FEM) approximation of the incompressible steady (time independent) Navier-Stokes equations (NSE) in 2D, stored as a sparse matrix.

NSPCG, a FORTRAN77 library 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.

NSPCG, a FORTRAN90 library 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.

NSWC, a FORTRAN90 library which includes an extensive set of routines for a wide range of computational activities, compiled by Alfred Morris.

NUMPY, examples which illustrate the use of NUMPY, which is a Python library of numerical algorithms very commonly used in scientific programs.

OBJ, a data directory which contains examples of OBJ files, a Wavefront file format for 3D graphics;

OBJ_DISPLAY, a MATLAB program which reads an OBJ 3D graphics file and displays it on the screen.

OBJ_IO, a C++ library which reads and writes the 3D graphics information in an Alias OBJ file;

OBJ_IO, a FORTRAN90 library which reads and writes the 3D graphics information in an Alias OBJ file;

OBJ_IO, a MATLAB library which reads and writes the 3D graphics information in an Alias OBJ file;

OBJ_TO_PLY, a C program which reads an OBJ file and writes similar information to a PLY file, by Greg Turk.

OBJ_TO_TRI_SURFACE, a MATLAB program which reads an OBJ file and extracts the surface mesh data as a tri_surface dataset.

OCTAVE, examples which illustrate the use of OCTAVE, which is an interactive program for numerical and scientific calculation.

ODE, a C library which solves a system of ordinary differential equations (ODE's), by Shampine and Gordon.

ODE, a C++ library which solves a system of ordinary differential equations (ODE's), by Shampine and Gordon.

ODE, a FORTRAN77 library which solves a system of ordinary differential equations (ODE's), by Shampine and Gordon.

ODE, a FORTRAN90 library which solves a system of ordinary differential equations (ODE's), by Shampine and Gordon.

ODE_MOSHIER, a C library which implements the Adams-Bashforth-Moulton and Runge-Kutta (RK) methods of solving systems of ordinary differential equations (ODE's), by Steven Moshier.

ODE_SWEEP_PARFOR, a MATLAB program which demonstrates how MATLAB's parfor command can be used to parallelize the computation of a grid of solutions to a parameterized system of ordinary differential equations (ODE's).

ODE_SWEEP_SERIAL, a MATLAB program which computes a grid of solutions to a parameterized system of ordinary differential equations (ODE's).

ODEPACK, a FORTRAN77 library which contains nine solvers for ordinary differential equations (ODE's), including LSODE, LSODES, LSODA, LSODAR, LSODPK, LSODKR, LSODI, LSOIBT, and LSODIS, by Alan Hindmarsh.

ONED, a MATLAB library which contains functions useful for 1D finite element method (FEM) calculations, by Jeff Borggaard.

OPENBLAS, examples which illustrate the use of the OPENBLAS library, an optimized Basic Linear Algebra Subprogram (BLAS) package based on the GotoBLAS2.

OPENCV, examples which illustrate the use of OPENCV, which is a C++ library for real-time applications involving computer vision. It includes many features for image input, conversion, and output, various kinds of image manipulation and processing, structural analysis, calibration, motion tracking, and object recognition.

OPENFOAM, examples which illustrate the use of OPENFOAM, a free, open source CFD package which can solve anything from complex fluid flows involving chemical reactions, turbulence and heat transfer, to acoustics, solid mechanics and electromagnetics.

opengl_test, C programs which illustrate the use of the OpenGL graphics library;

OPENGL, C++ programs which illustrate the use of the OpenGL graphics library;

OPENMP, C programs which illustrate the use of the OpenMP application program interface for carrying out parallel computations in a shared memory environment.

OPENMP, C++ programs which illustrate the use of the OpenMP application program interface for carrying out parallel computations in a shared memory environment.

OPENMP, FORTRAN77 programs which illustrate the use of the OpenMP application program interface for carrying out parallel computations in a shared memory environment.

OPENMP, FORTRAN90 programs which illustrate the use of the OpenMP application program interface for carrying out parallel computations in a shared memory environment.

OPENMP_RCC, C programs which illustrate how a C program, using OpenMP, can be compiled and run in batch mode on the FSU High Performance Computing (HPC) cluster operated by the Research Computing Center (RCC).

OPENMP_RCC, C++ programs which illustrate how a C program, using OpenMP, can be compiled and run in batch mode on the FSU High Performance Computing (HPC) cluster operated by the Research Computing Center (RCC).

OPENMP_RCC, FORTRAN90 programs which illustrate how a FORTRAN90 program, using OpenMP, can be compiled and run in batch mode on the FSU High Performance Computing (HPC) cluster operated by the Research Computing Center (RCC).

OPENMP_STUBS, a C library which implements a stub version of OpenMP, so that an OpenMP program can be compiled, linked and executed on a system that does not have OpenMP installed.

OPENMP_STUBS, a C++ library which implements a stub version of OpenMP, so that an OpenMP program can be compiled, linked and executed on a system that does not have OpenMP installed.

OPENMP_STUBS, a FORTRAN77 library which implements a stub version of OpenMP, so that an OpenMP program can be compiled, linked and executed on a system that does not have OpenMP installed.

OPENMP_STUBS, a FORTRAN90 library which implements a stub version of OpenMP, so that an OpenMP program can be compiled, linked and executed on a system that does not have OpenMP installed.

OPENMPI, examples which illustrate the use of OPENMPI, which is an implementation of the MPI interface for parallel programming.

OPENMPI-TEST: examples which illustrate the use of OPENMPI_TEST, which is one of several implementations of the MPI interface for parallel programming with distributed memory.

OPENSEES, examples which illustrate the use of OPENSEES, which is a software framework for developing applications to simulate the performance of structural and geotechnical systems subjected to earthquakes.

OPTIMAL_CONTROL_1D, a MATLAB program which seeks the optimal control function for a 1-dimensional system which is represented using the finite element method (FEM);

OPTIMIZE, a C program which looks at the use of automatic optimization by the compiler to make the executable code run faster.

OPTIMIZE, a C++ program which looks at the use of automatic optimization by the compiler to make the executable code run faster.

OPTIMIZE, a FORTRAN77 program which looks at the use of automatic optimization by the compiler to make the executable code run faster.

OPTIMIZE, a FORTRAN90 program which looks at the use of automatic optimization by the compiler to make the executable code run faster.

ORNSTEIN_UHLENBECK, a C library which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SODE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().

ORNSTEIN_UHLENBECK, a C++ library which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SODE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().

ORNSTEIN_UHLENBECK, a FORTRAN77 library which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SODE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().

ORNSTEIN_UHLENBECK, a FORTRAN90 library which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SODE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().

ORNSTEIN_UHLENBECK, a MATLAB library which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SODE) using the Euler method and the Euler-Maruyama method.

OUTLIERS, a MATLAB library which uses the isoutlier() function, and other techniques, to identify outliers in data.

OWENS, a C library which evaluates Owen's T function.

OWENS, a C++ library which evaluates Owen's T function.

OWENS, a FORTRAN77 library which evaluates Owen's T function.

OWENS, a FORTRAN90 library which evaluates Owen's T function.

OWENS, a MATLAB library which evaluates Owen's T function.

OWENS, a Python library which evaluates Owen's T function.

p_laplacian, a FENICS script which sets up and solves the nonlinear p-Laplacian PDE in the unit square.

P2FA, examples which illustrate the use of P2FA, which is the University of Pennsylvania Phonetics Lab Forced Aligner, which can align a transcript text with a sound recording file.

P4EST, examples which illustrate the use of P4EST, which is a library which can dynamically manage a collection of octrees, typically generated by repeated subdivisions of a geometric region. P4EST is designed to work in parallel, in particular with MPI.

P7ZIP, examples which illustrate the use of P7ZIP, which is a program for the lossless compression or uncompression of data, and is a version of the 7-ZIP program that runs on Windows.

PADUA, a C library which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points in gnuplot graphics files.

PADUA, a C++ library which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points in gnuplot graphics files.

PADUA, a FORTRAN77 library which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points in gnuplot graphics files.

PADUA, a FORTRAN90 library which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points in gnuplot graphics files.

PADUA, a MATLAB library which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points in graphics files.

PADUA, a Python library which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points in graphics files.

PAGERANK, a MATLAB library which illustrates the eigenvalue (power method) and surfer (Markov chain) approaches to ranking web pages.

PAGES, a C++ program which counts the number of pages (sets of 60 lines) in a file;

PANGO, examples which illustrate the use of PANGO, which is a library designed for the arrangement and display of text, including international fonts.

PAPI, examples which illustrate the use of PAPI, which is the performance application programming interface.

PARALLEL, examples which illustrate the use of GNU PARALLEL, which is the GNU parallel command for executing shell shell scripts in parallel.

PARALLEL_MATLAB, examples which illustrate the use of the MATLAB Parallel Computing Toolbox.

PARANOIA, a C program which checks the accuracy of floating point arithmetic on a given computer, by William Kahan.

PARANOIA, a FORTRAN77 program which checks the accuracy of floating point arithmetic on a given computer, by William Kahan.

PARANOIA, a FORTRAN90 program which checks the accuracy of floating point arithmetic on a given computer, by William Kahan.

PARAVIEW, examples which illustrate the use of the paraview interactive visualization program.

PARMETIS, a C program which uses the METIS library to partition the nodes of a graph in a balanced way, useful for parallel processing;

PARMETIS, examples which illustrate the use of PARMETIS, which is a library, and a collection of programs, which partition the nodes of a graph or reorder the variables in a sparse matrix to minimize fillin, by George Karypis.

PARTIAL_DIGEST, a C library which solves the partial digest problem.

PARTIAL_DIGEST, a C++ library which solves the partial digest problem.

PARTIAL_DIGEST, a FORTRAN90 library which solves the partial digest problem.

PARTIAL_DIGEST, a MATLAB library which solves the partial digest problem.

PARTIAL_DIGEST, a Python library which solves the partial digest problem.

PARTITION_PROBLEM, a C library which seeks solutions of the partition problem, splitting a set of integers into two subsets with equal sum.

PARTITION_PROBLEM, a C++ library which seeks solutions of the partition problem, splitting a set of integers into two subsets with equal sum.

PARTITION_PROBLEM, a dataset directory which contains examples of the partition problem, in which a set of numbers is given, and it is desired to break the set into two subsets with equal sum.

PARTITION_PROBLEM, a FORTRAN77 library which seeks solutions of the partition problem, splitting a set of integers into two subsets with equal sum.

PARTITION_PROBLEM, a FORTRAN90 library which seeks solutions of the partition problem, splitting a set of integers into two subsets with equal sum.

PARTITION_PROBLEM, a MATLAB library which seeks solutions of the partition problem, splitting a set of integers into two subsets with equal sum.

PARTITION_PROBLEM, a Python library which seeks solutions of the partition problem, splitting a set of integers into two subsets with equal sum.

PATTERSON_RULE, a C program which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.

PATTERSON_RULE, a C++ program which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.

PATTERSON_RULE, a FORTRAN77 program which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.

PATTERSON_RULE, a FORTRAN90 program which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.

PATTERSON_RULE, a MATLAB program which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.

PATTERSON_RULE_COMPUTE, a FORTRAN90 program which computes the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.

PBDR, examples which illustrate the use of PBDR, which is a set of highly scalable R packages for distributed computing and profiling in data science.

PBLAS, a FORTRAN90 library which embodies the Parallel Basic Linear Algebra Subprograms (BLAS).

PBMA, a data directory which contains examples of ASCII Portable Bit Map (PBM) files 2D graphics, black and white;

PBMA_IO a C library which handles the ASCII Portable Bit Map (PBM) format.

PBMA_IO a C++ library which handles the ASCII Portable Bit Map (PBM) format.

PBMA_IO a FORTRAN77 library which handles the ASCII Portable Bit Map (PBM) format.

PBMA_IO a FORTRAN90 library which handles the ASCII Portable Bit Map (PBM) format.

PBMA_IO a MATLAB library which handles the ASCII Portable Bit Map (PBM) format.

PBMA_IO a Python library which handles the ASCII Portable Bit Map (PBM) format.

PBMA_TO_PBMB, a C++ program which converts an ASCII Portable Bit Map (PBM) file to a binary PBM file;

PBMB, a data directory which contains examples of binary Portable Bit Map (PBM) files, 2D graphics, black and white;

PBMB_IO, a C library which handles the binary Portable Bit Map (PBM) format.

PBMB_IO, a C++ library which handles the binary Portable Bit Map (PBM) format.

PBMB_IO, a Python library which handles the binary Portable Bit Map (PBM) format.

PBMB_TO_PBMA, a C++ program which converts a binary Portable Bit Map (PBM) file to an ASCII PBM file;

PBMLIB, a C library which reads or writes graphics files in the Portable Bit Map (PBM) format;

PBMLIB, a FORTRAN90 library which reads or writes graphics files in the Portable Bit Map (PBM) format;

PBS, examples which illustrate the use of PBS, the Portable Batch Scheduler, as implemented at the Pittsburgh Supercomputing Center.

PCD, a data directory which contains examples of PCD files, which is the Point Cloud Data format, developed in particular for the Point Cloud Library (PCL).

PCE_BURGERS, a C program which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion in terms of Hermite polynomials, by Gianluca Iaccarino.

PCE_BURGERS, a C++ program which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion in terms of Hermite polynomials, by Gianluca Iaccarino.

PCE_BURGERS, a FORTRAN77 program which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion in terms of Hermite polynomials, by Gianluca Iaccarino.

PCE_BURGERS, a FORTRAN90 program which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion in terms of Hermite polynomials, by Gianluca Iaccarino.

PCE_BURGERS, a MATLAB program which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion in terms of Hermite polynomials, by Gianluca Iaccarino.

PCE_ODE_HERMITE, a C program which sets up a simple scalar stochastic ordinary differential equation (SODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion in terms of Hermite polynomials.

PCE_ODE_HERMITE, a C++ program which sets up a simple scalar stochastic ordinary differential equation (SODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion in terms of Hermite polynomials.

PCE_ODE_HERMITE, a FORTRAN77 program which sets up a simple scalar stochastic ordinary differential equation (SODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion in terms of Hermite polynomials.

PCE_ODE_HERMITE, a FORTRAN90 program which sets up a simple scalar stochastic ordinary differential equation (SODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion in terms of Hermite polynomials.

PCE_ODE_HERMITE, a MATLAB program which sets up a simple scalar stochastic ordinary differential equation (SODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion in terms of Hermite polynomials.

PCE_LEGENDRE, a MATLAB program which assembles the system matrix of a 2D stochastic partial differential equation (SPDE), using a polynomal chaos expansion in terms of Legendre polynomials;

PCHIP, a FORTRAN77 library which can construct a piecewise cubic Hermite interpolant to data, and carry out various related operations, by Fred Fritsch.

PCHIP, a FORTRAN90 library which can construct a piecewise cubic Hermite interpolant to data, and carry out various related operations, by Fred Fritsch.

PCL, examples which illustrate the use of PCL, which is a C++ library for handling 2D and 3D point clouds, that is, very large and initially unorganized collections of point coordinates which might come from geographic data, medical scans, or imaging software.

PCL, a dataset directory which contains datasets from a gene expression experiment on Arabidopsis, which are candidates for data cluster analysis;

PCL_READ, a C program which reads a PCL file and extracts the numeric data;

PCL_READ, a C++ program which reads a PCL file and extracts the numeric data;

PCX, a data directory which contains examples of PCX files, which is a format originally developed for images created by the PC Paintbrush program.

PDB, a data directory which contains examples of Protein Data Base (PDB) files;

PDB_EXTRACT, a FORTRAN90 program which can select records from a Protein Data Base (PDB) file, and extract columns from those records;

PDB_READ, a FORTRAN90 library which reads a Protein Data Base (PDB) file;

PDB_TO_XYZ, a FORTRAN90 program which copies the coordinates from the ATOM records of a Protein Data Base (PDB) file into an XYZ file;

PDEPE, MATLAB programs which illustrate how MATLAB's pdepe() function can be used to solve initial boundary value problems (IBVP's) in one spatial dimension.

PDF, a data directory which contains examples of PDF files, the Portable Document Format, 2D text and graphics;

PDFLIB, a C library which evaluates Probability Density Functions (PDF's) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.

PDFLIB, a C++ library which evaluates Probability Density Functions (PDF's) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.

PDFLIB, a FORTRAN77 library which evaluates Probability Density Functions (PDF's) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.

PDFLIB, a FORTRAN90 library which evaluates Probability Density Functions (PDF's) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.

PDFLIB, a MATLAB library which evaluates Probability Density Functions (PDF's) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.

PDFLIB, a Python library which evaluates Probability Density Functions (PDF's) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.

PEAK_MOVIE, a MATLAB program which creates the pieces of an animation, one frame at a time. Each frame is independently created and saved as a JPEG file.

PENDULUM_ODE, a MATLAB library which looks at some simple topics involving the linear and nonlinear ordinary differential equations (ODEs) that represent the behavior of a pendulum of length L under a gravitational force of strength G.

PENTOMINOES, a C library which provides some utilities for manipulating pentominoes.

PENTOMINOES, a C++ library which provides some utilities for manipulating pentominoes.

PENTOMINOES, a FORTRAN90 library which provides some utilities for manipulating pentominoes.

PENTOMINOES, a MATLAB library which provides some utilities for manipulating pentominoes.

PENTOMINOES, a Python library which provides some utilities for manipulating pentominoes.

PERI1D, a C program which sets up and solves a 1D time-dependent peridynamics problem, by Miroslav Stoyanov;

PERI2D, a C program which sets up and solves a 2D time-dependent peridynamics problem, by Miroslav Stoyanov;

PERIDYNAMICS_1D_STEADY, a MATLAB library which solves a 1D steady (time independent) version of the Poisson equation, using the non-local peridynamics model, by Marta D'Elia.

PERL, examples which illustrate the use of PERL, which is a high level dynamic programming language.

PETSC, examples which illustrate the use of PETSC, a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations. It supports MPI, and GPU's through CUDA or OpenCL, as well as hybrid MPI-GPU parallelism.

petsc_test, C programs which illustrate the use of PETSC, a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations. It supports MPI, and GPU's through CUDA or OpenCL, as well as hybrid MPI-GPU parallelism.

petsc_test, C++ programs which illustrate the use of PETSC, a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations. It supports MPI, and GPU's through CUDA or OpenCL, as well as hybrid MPI-GPU parallelism.

petsc_test, FORTRAN90 programs which illustrate the use of PETSC, a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations. It supports MPI, and GPU's through CUDA or OpenCL, as well as hybrid MPI-GPU parallelism.

PFORT, a FORTRAN77 program which checks a program for compliance with the FORTRAN66 standard.

PGH_MRI, a data directory which contains examples of PGH MRI files, a format for storing brain scan data gathered by magnetic resonance imaging (MRI);

PGI, examples which illustrate the use of PGI compilers, which are the Portland Group set of optimizing compilers for Fortran, C, and C++. These compilers are specifically enhanced for scientific and engineering applications. They include extensions for OpenMP, MPI, and GPU computing using OpenACC. They have special optimizations for specific hardware platforms.

PGMA, a data directory which contains examples of ASCII Portable Gray Map (PGM) files for 2D graphics;

PGMA_IO a C library which handles the ASCII Portable Gray Map (PGM) format.

PGMA_IO a C++ library which handles the ASCII Portable Gray Map (PGM) format.

PGMA_IO a FORTRAN90 library which handles the ASCII Portable Gray Map (PGM) format.

PGMA_IO a FORTRAN90 library which handles the ASCII Portable Gray Map (PGM) format.

PGMA_IO a MATLAB library which handles the ASCII Portable Gray Map (PGM) format.

PGMA_IO a Python library which handles the ASCII Portable Gray Map (PGM) format.

PGMA_TO_PGMB, a C++ program which converts an ASCII Portable Gray Map (PGM) file to a binary PGM file;

PGMB, a data directory which contains examples of binary Portable Gray Map (PGM) files for 2D graphics;

PGMB_IO a C library which handles the binary Portable Gray Map (PGM) format.

PGMB_IO a C++ library which handles the binary Portable Gray Map (PGM) format.

PGMB_IO a Python library which handles the binary Portable Gray Map (PGM) format.

PGMB_TO_PGMA, a C++ program which converts a binary Portable Gray Map (PGM) file to an ASCII PGM file;

PHDF5 examples which ilustrate the use of PHDF5, the Parallel HDF5 library, for dealing with large, complex data files with MPI.

PIC_SERIAL, a MATLAB program which uses the Particle In Cell (PIC) method to simulate the motion of electrically charged particles past a plate, and is intended as a starting point for implementing a parallel version.

PICARD, examples which illustrate the use of PICARD, which is a collection of tools for manipulating high throughput sequencing data.

PIECEWISE_LINEAR_PRODUCT_INTEGRAL, a C library which calculates the exact value of the integral of the product of two piecewise linear functions F(X) and G(X).

PIECEWISE_LINEAR_PRODUCT_INTEGRAL, a C++ library which calculates the exact value of the integral of the product of two piecewise linear functions F(X) and G(X).

PIECEWISE_LINEAR_PRODUCT_INTEGRAL, a FORTRAN77 library which calculates the exact value of the integral of the product of two piecewise linear functions F(X) and G(X).

PIECEWISE_LINEAR_PRODUCT_INTEGRAL, a FORTRAN90 library which calculates the exact value of the integral of the product of two piecewise linear functions F(X) and G(X).

PIECEWISE_LINEAR_PRODUCT_INTEGRAL, a MATLAB library which calculates the exact value of the integral of the product of two piecewise linear functions F(X) and G(X).

PIG_LATIN, a C program which converts its input to Pig Latin; a winner of the International Obfuscated C Code Competition in the Most Humorous category, by Don Dodson.

PIGZ examples which ilustrate the use of PIGZ, which is a data compression program which can take advantage of multiple processors to execute in parallel, and which produces files in the GZIP or ZLIB compression format.

PINK_NOISE, a C library which computes a pink noise signal obeying a 1/f power law.

PINK_NOISE, a C++ library which computes a pink noise signal obeying a 1/f power law.

PINK_NOISE, a FORTRAN77 library which computes a pink noise signal obeying a 1/f power law.

PINK_NOISE, a FORTRAN90 library which computes a pink noise signal obeying a 1/f power law.

PINK_NOISE, a MATLAB library which computes a pink noise signal obeying a 1/f power law.

PINK_NOISE, a Python library which computes a pink noise signal obeying a 1/f power law.

PITCON66, a FORTRAN77 library which seeks to produce a sequence of points that satisfy a set of nonlinear equations with one degree of freedom; this is version 6.6 of ACM TOMS algorithm 596.

PITCON7, a FORTRAN90 library which seeks to produce a sequence of points that satisfy a set of nonlinear equations with one degree of freedom; this is version 7.0 of ACM TOMS algorithm 596.

PLASMA_MATRIX, a MATLAB library which demonstrates how a large sparse MATLAB matrix can be written to or read from a Harwell-Boeing sparse matrix file.

PLATO_PLY, a C program which writes a PLY graphics file for any Platonic solid, by Greg Turk.

PLC, a data directory of files used to describe a piecewise linear complex (PLC), a surface that bounds a 3D region that is to be meshed.

PLINTH, a MATLAB library which carries out tasks associated with the interpolation of data or a function by a hierarchical set of piecewise linear functions.

PLOT_POINTS, a FORTRAN90 program which can make an Encapsulated PostScript (EPS) plot of a set of points in 2D.

PLOT_SPMD, a MATLAB library which demonstrates the Single Program Multiple Data (SPMD) parallel programming feature, by having a number of labs compute parts of a sine plot, which is then displayed by the client process.

PLOT_TO_PS, a FORTRAN90 program which reads simple text commands and creates a PostScript (PS) image;

PLOT3D, a data directory which contains examples of PLOT3D files, a variety of formats used by the PLOT3D program;

PLOT3D_IO, a FORTRAN90 library which reads or writes a PLOT3D graphics file;

PLOT3D_TO_AVS, a FORTRAN90 program which reads data describing a fluid flow governed by the Navier-Stokes equations (NSE), as created by PLOT3D, and writes the data to files suitable for input to the AVS graphics system.

PLTMG, a FORTRAN77 library which solves elliptic partial differential equations (PDE's) using the finite element method (FEM) with piecewise linear triangles and the multigrid approach, by Randy Bank.

PLY, a data directory which contains examples of PLY files, a format for objects defined as a collection of polygons, 3D graphics;

PLY_DISPLAY, a MATLAB program which displays an image of a 3D graphics file in PLY format;

PLY_IO, a C library which reads or writes a 3D graphics file in PLY format, by Greg Turk;

PLY_IO, a MATLAB library which reads or writes a 3D graphics file in PLY format, by Greg Turk;

PLY_TO_IV, a C program which converts a 3D graphics file from PLY format to Inventor (IV) format, by Greg Turk.

PLY_TO_OBJ, a C program which reads a PLY 3D graphics file and writes an equivalent OBJ graphics file, by Greg Turk.

PLY_TO_TRI_SURFACE, a MATLAB program which reads a PLY file and extracts the surface mesh data as a TRI_SURFACE dataset.

PNG, a data directory which contains examples of Portable Network Graphics (PNG) files, 2D graphics;

PNG_CRC, a C++ program which computes the cyclic redundancy checksum (CRC) for a Portable Network Graphics (PNG) file, or any other file, for that matter;

PNG_IO, a C library which reads and writes files in the Portable Network Graphics (PNG) format.

POD_BASIS_FLOW, a FORTRAN90 program which extracts dominant solution modes from a set of solutions of fluid flow governed by the Navier Stokes equations (NSE) using Proper Orthogonal Decomposition (POD).

POINT_MERGE, a C library which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.

POINT_MERGE, a C++ library which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.

POINT_MERGE, a FORTRAN77 library which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.

POINT_MERGE, a FORTRAN90 library which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.

POINT_MERGE, a MATLAB library which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.

poisson, a FENICS script which solves the Poisson equation on the unit square, adapted from the FENICS tutorial by Langtangen and Logg.

POISSON_MPI, a C program which computes a solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and MPI to carry out the Jacobi iteration in parallel.

poisson_nonlinear, a FENICS script which uses the finite element method to solve a version of the nonlinear Poisson equation over the unit square.

POISSON_OPENMP, a C program 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, a C++ program 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, a FORTRAN77 program 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, a FORTRAN90 program 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_SERIAL, a C program which computes an approximate solution to the Poisson equation in a rectangle, intended as the starting point for the creation of a parallel version.

POISSON_SERIAL, a C++ program which computes an approximate solution to the Poisson equation in a rectangle, intended as the starting point for the creation of a parallel version.

POISSON_SERIAL, a FORTRAN77 program which computes an approximate solution to the Poisson equation in a rectangle, intended as the starting point for the creation of a parallel version.

POISSON_SERIAL, a FORTRAN90 program which computes an approximate solution to the Poisson equation in a rectangle, intended as the starting point for the creation of a parallel version.

POISSON_SERIAL, a MATLAB program which computes an approximate solution to the Poisson equation in a rectangle, intended as the starting point for the creation of a parallel version.

POISSON_SIMULATION, a C library which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating output for graphics by gnuplot.

POISSON_SIMULATION, a C++ library which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating output for graphics by gnuplot.

POISSON_SIMULATION, a FORTRAN77 library which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating output for graphics by gnuplot.

POISSON_SIMULATION, a FORTRAN90 library which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating output for graphics by gnuplot.

POISSON_SIMULATION, a MATLAB library which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda.

poisson_source_symbolic, a FENICS script which shows how the symbolic package can be used to determine the right hand side f(x,y) of a Poisson equation, given the desired exact solution u(x,y).

POLPAK, a C library which evaluates a variety of mathematical functions, including Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials, and the Collatz sequence.

POLPAK, a C++ library which evaluates a variety of mathematical functions, including Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials, and the Collatz sequence.

POLPAK, a FORTRAN77 library which evaluates a variety of mathematical functions, including Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials, and the Collatz sequence.

POLPAK, a FORTRAN90 library which evaluates a variety of mathematical functions, including Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials, and the Collatz sequence.

POLPAK, a MATLAB library which evaluates a variety of mathematical functions, including Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials, and the Collatz sequence.

POLPAK, a Python library which evaluates a variety of mathematical functions, including Chebyshev, Gegenbauer, Hermite, Jacobi, Laguerre, Legendre polynomials, and the Collatz sequence.

POLY, a data directory which contains examples of POLY files, a 2D format used by triangle and showme, for Planar Straight Line Graphs.

POLY_3D, a data directory which contains examples of 3D POLY files, a 3D format used by tetgen and tetview, for a Piecewise Linear Complex (PLC).

POLY_IO, a FORTRAN90 library which contains routines to read or write a POLY file.

POLYGON, a dataset directory which contains examples of polygons.

POLYGON_AVERAGE, a MATLAB library which demonstrates a process of repeatedly averaging and normalizing the vertices of a polygon, illustrating a property of the power method.

POLYGON_GRID, a C library which generates a grid of points over the interior of a polygon in 2D.

POLYGON_GRID, a C++ library which generates a grid of points over the interior of a polygon in 2D.

POLYGON_GRID, a FORTRAN77 library which generates a grid of points over the interior of a polygon in 2D.

POLYGON_GRID, a FORTRAN90 library which generates a grid of points over the interior of a polygon in 2D.

POLYGON_GRID, a MATLAB library which generates a grid of points over the interior of a polygon in 2D.

POLYGON_GRID, a Python library which generates a grid of points over the interior of a polygon in 2D.

POLYGON_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.

POLYGON_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.

POLYGON_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.

POLYGON_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.

POLYGON_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.

POLYGON_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.

POLYGON_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.

POLYGON_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.

POLYGON_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.

POLYGON_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.

POLYGON_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.

POLYGON_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.

POLYGON_PROPERTIES, a C library which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling.

POLYGON_PROPERTIES, a C++ library which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling.

POLYGON_PROPERTIES, a FORTRAN77 library which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling.

POLYGON_PROPERTIES, a FORTRAN90 library which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling.

POLYGON_PROPERTIES, a MATLAB library which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling.

POLYGON_PROPERTIES, a Python library which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling.

POLYGON_TRIANGULATE, a C library which triangulates a possibly nonconvex polygon, and which can use gnuplot to display the external edges and internal diagonals of the triangulation.

POLYGON_TRIANGULATE, a C++ library which triangulates a possibly nonconvex polygon, and which can use gnuplot to display the external edges and internal diagonals of the triangulation.

POLYGON_TRIANGULATE, a FORTRAN77 library which triangulates a possibly nonconvex polygon, and which can use gnuplot to display the external edges and internal diagonals of the triangulation.

POLYGON_TRIANGULATE, a FORTRAN90 library which triangulates a possibly nonconvex polygon, and which can use gnuplot to display the external edges and internal diagonals of the triangulation.

POLYGON_TRIANGULATE, a MATLAB library which triangulates a possibly nonconvex polygon.

POLYGON_TRIANGULATE, a Python library which triangulates a possibly nonconvex polygon.

POLYGONAL_SURFACE, a data directory which contains examples of polygonal_surface files, a simple file format comprising two files, suitable for storing the definition of a surface that is made up of a set of polygons of a fixed order, 3D graphics;

POLYGONAL_SURFACE_DISPLAY, a MATLAB program which displays a surface in 3D described as a set of polygons;

POLYGONAL_SURFACE_DISPLAY_OPENGL, a C++ program which displays a surface in 3D described as a set of polygons, using OpenGL.

POLYNOMIAL, a C library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.

POLYNOMIAL, a C++ library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.

POLYNOMIAL, a FORTRAN77 library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.

POLYNOMIAL, a FORTRAN90 library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.

POLYNOMIAL, a MATLAB library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.

POLYNOMIAL, a Python library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.

POLYNOMIALS, a FORTRAN90 library which defines multivariate polynomials over rectangular domains, for which certain information is to be determined, such as the maximum and minimum values.

POLYNOMIALS, a MATLAB library which defines multivariate polynomials over rectangular domains, for which certain information is to be determined, such as the maximum and minimum values.

POLYNOMIALS, a Python library which defines multivariate polynomials over rectangular domains, for which certain information is to be determined, such as the maximum and minimum values.

POLYOMINO_CONDENSE, a C program which cleans up a matrix that represents a polyomino by setting all nonzero entries to 1, and removing initial and final rows and columns of zeros.

POLYOMINO_CONDENSE, a C++ program which cleans up a matrix that represents a polyomino by setting all nonzero entries to 1, and removing initial and final rows and columns of zeros.

POLYOMINO_CONDENSE, a FORTRAN90 program which cleans up a matrix that represents a polyomino by setting all nonzero entries to 1, and removing initial and final rows and columns of zeros.

POLYOMINO_CONDENSE, a MATLAB program which cleans up a matrix that represents a polyomino by setting all nonzero entries to 1, and removing initial and final rows and columns of zeros.

POLYOMINO_CONDENSE, a Python program which cleans up a matrix that represents a polyomino by setting all nonzero entries to 1, and removing initial and final rows and columns of zeros.

POLYOMINO_EMBED, a C library which is given matrices defining a region R and a polyomino P, and determines the number of possible embeddings of the polyomino into the region, and the translations necessary to achieve them.

POLYOMINO_EMBED, a C++ library which is given matrices defining a region R and a polyomino P, and determines the number of possible embeddings of the polyomino into the region, and the translations necessary to achieve them.

POLYOMINO_EMBED, a FORTRAN90 library which is given matrices defining a region R and a polyomino P, and determines the number of possible embeddings of the polyomino into the region, and the translations necessary to achieve them.

POLYOMINO_EMBED, a MATLAB library which is given matrices defining a region R and a polyomino P, and determines the number of possible embeddings of the polyomino into the region, and the translations necessary to achieve them.

POLYOMINO_EMBED, a Python library which is given matrices defining a region R and a polyomino P, and determines the number of possible embeddings of the polyomino into the region, and the translations necessary to achieve them.

POLYOMINO_ENUMERATE, a C library which enumerates chiral, fixed and free polyominoes up to a moderate order.

POLYOMINO_ENUMERATE, a C++ library which enumerates chiral, fixed and free polyominoes up to a moderate order.

POLYOMINO_ENUMERATE, a FORTRAN90 library which enumerates chiral, fixed and free polyominoes up to a moderate order.

POLYOMINO_ENUMERATE, a MATLAB library which enumerates chiral, fixed and free polyominoes up to a moderate order.

POLYOMINO_ENUMERATE, a Python library which enumerates chiral, fixed and free polyominoes up to a moderate order.

POLYOMINO_INDEX, a C library which is given a matrix defining a polyomino P, and determines a correspondingly shaped matrix which contains an index for each nonzero entry in P.

POLYOMINO_INDEX, a C++ library which is given a matrix defining a polyomino P, and determines a correspondingly shaped matrix which contains an index for each nonzero entry in P.

POLYOMINO_INDEX, a FORTRAN90 library which is given a matrix defining a polyomino P, and determines a correspondingly shaped matrix which contains an index for each nonzero entry in P.

POLYOMINO_INDEX, a MATLAB library which is given a matrix defining a polyomino P, and determines a correspondingly shaped matrix which contains an index for each nonzero entry in P.

POLYOMINO_INDEX, a Python library which is given a matrix defining a polyomino P, and determines a correspondingly shaped matrix which contains an index for each nonzero entry in P.

POLYOMINO_LP_WRITE, a C program which writes an LP file describing a (binary) integer programming problem related to the tiling of a region R by copies of polyomino shapes, with possible reflections and rotations.

POLYOMINO_LP_WRITE, a C++ program which writes an LP file describing a (binary) integer programming problem related to the tiling of a region R by copies of polyomino shapes, with possible reflections and rotations.

POLYOMINO_LP_WRITE, a FORTRAN90 program which writes an LP file describing a (binary) integer programming problem related to the tiling of a region R by copies of polyomino shapes, with possible reflections and rotations.

POLYOMINO_LP_WRITE, a MATLAB program which writes an LP file describing a (binary) integer programming problem related to the tiling of a region R by copies of polyomino shapes, with possible reflections and rotations.

POLYOMINO_LP_WRITE, a Python program which writes an LP file describing a (binary) integer programming problem related to the tiling of a region R by copies of polyomino shapes, with possible reflections and rotations.

POLYOMINO_MATRIXSPAN, a MATLAB program which assembles a matrix associated with a polyomino tiling problem.

POLYOMINO_MONOHEDRAL, a MATLAB program which is given matrices defining a region R and a polyomino P; it sets up the corresponding linear system, and solves for binary solutions x that represent possible tilings of the region R by the polyomino P.

POLYOMINO_MONOHEDRAL_EXAMPLE_REID, a MATLAB program which sets up and solves the Reid example of a polyomino tiling problem, using copies of a single polyomino P to tile a region R.

POLYOMINO_MONOHEDRAL_MATRIX, a MATLAB program which is given matrices defining a region R and a polyomino P, and returns the linear system A*x=b that must be solved for binary solutions x, that represent possible tilings of the region R by the polyomino P.

POLYOMINO_MONOHEDRAL_TILING_PLOT, a MATLAB library which is given matrices defining a region R and a polyomino P, and a vector X, computed by POLYOMINO_MONOHEDRAL, which represents a tiling of R by P, and creates a graphic plot representation of that tiling.

POLYOMINO_MONOHEDRAL_TILING_PRINT, a MATLAB library which is given matrices defining a region R and a polyomino P, and a vector X, computed by POLYOMINO_MONOHEDRAL, which represents a tiling of R by P, and prints out a representation of that tiling.

POLYOMINO_MONOHEDRAL_VARIANTS, a MATLAB program which computes the distinct variants of a polyomino under reflection and 90 degree rotations.

POLYOMINO_MULTIHEDRAL, a MATLAB library which is given matrices defining a region R and a set of polyominoes P; it sets up the corresponding linear system, and solves for binary solutions x that represent possible tilings of the region R by the polyominoes of P.

POLYOMINO_MULTIHEDRAL_EXAMPLE_2X4, a MATLAB program which is given matrices defining a region R and a set of polyomino P; it sets up the corresponding linear system, and solves for a 2x4 rectangle R is to be tiled using several different polyominoes.

POLYOMINO_MULTIHEDRAL_EXAMPLE_OCTOMINO, a MATLAB program which sets up a problem in which an 8x8 square is to be tiled by 8 distinct octominoes.

POLYOMINO_MULTIHEDRAL_EXAMPLE_PENT18X30, a MATLAB program which sets up a problem in which an 18x30 rectangle is to be tiled by 9 copies of each of the 12 distinct pentominoes, and plots a solution computed by GUROBI.

POLYOMINO_MULTIHEDRAL_EXAMPLE_PENTOMINO, a MATLAB program which sets up a problem in which an 8x8 square with 2x2 central hole is to be tiled by the 12 distinct pentominoes.

POLYOMINO_MULTIHEDRAL_MATRIX, a MATLAB library which is given matrices defining a region R and a set of several polyominoes P, and returns the linear system A*x=b that must be solved for binary solutions x, that represent possible tilings of the region R by the polyominoes in P.

POLYOMINO_MULTIHEDRAL_TILING_PLOT, a MATLAB library which is given matrices defining a region R and a set of several polyominoes P, and a vector X which represents a tiling of R by the elements of P, and creates a plot of that tiling.

POLYOMINO_MULTIHEDRAL_TILING_PRINT, a MATLAB library which is given matrices defining a region R and a set of polyominoes P, and a vector X, computed by POLYOMINO_MULTIHEDRAL, which represent a tiling of R by the polyominoes in P. The task is to print out a representation of that tiling.

POLYOMINO_MULTIHEDRAL_VARIANTS, a MATLAB program which computes the distinct variants of one or more polyominoes under reflection and 90 degree rotations.

POLYOMINO_PLOT, a MATLAB program which displays a region which has been tiled by polyominos.

POLYOMINO_TRANSFORM, a C program which applies reflection and rotation transforms to the matrix that represents a polyomino.

POLYOMINO_TRANSFORM, a C++ program which applies reflection and rotation transforms to the matrix that represents a polyomino.

POLYOMINO_TRANSFORM, a FORTRAN90 program which applies reflection and rotation transforms to the matrix that represents a polyomino.

POLYOMINO_TRANSFORM, a MATLAB program which applies reflection and rotation transforms to the matrix that represents a polyomino.

POLYOMINO_TRANSFORM, a Python program which applies reflection and rotation transforms to the matrix that represents a polyomino.

POLYOMINOES, a MATLAB library which defines, solves, and plots a variety of polyomino tiling problems, which are solved by a direct algebraic approach involving the reduced row echelon form (RREF) of a specific matrix, instead of the more typical brute-force or backtracking methods.

POLYOMINOES_PRINT, a MATLAB program which prints an array of polyominoes.

POPULATION, a dataset directory which contains population counts for various regions.

POV, a data directory which contains examples of the Persistence of Vision (POV) 3D graphics file format;

POWER_METHOD, a C library which carries out the power method for finding a dominant eigenvalue and its eigenvector.

POWER_METHOD, a C++ library which carries out the power method for finding a dominant eigenvalue and its eigenvector.

POWER_METHOD, a FORTRAN77 library which carries out the power method for finding a dominant eigenvalue and its eigenvector.

POWER_METHOD, a FORTRAN90 library which carries out the power method for finding a dominant eigenvalue and its eigenvector.

POWER_METHOD, a MATLAB library which carries out the power method for finding a dominant eigenvalue and its eigenvector.

POWER_RULE, a C program which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.

POWER_RULE, a C++ program which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.

POWER_RULE, a FORTRAN77 program which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.

POWER_RULE, a FORTRAN90 program which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.

POWER_RULE, a MATLAB program which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.

ppc_xmalloc, a library which manages the allocation of memory, from Rostamian's "Programming Projects in C";

PPMA, a data directory which contains examples of ASCII Portable Pixel Map (PPM) 2D graphics files;

PPMA_IO a C library which can read or write ASCII Portable Pixel Map (PPM) graphics files.

PPMA_IO a C++ library which can read or write ASCII Portable Pixel Map (PPM) graphics files.

PPMA_IO a FORTRAN90 library which can read or write ASCII Portable Pixel Map (PPM) graphics files.

PPMA_IO a FORTRAN90 library which can read or write ASCII Portable Pixel Map (PPM) graphics files.

PPMA_IO a MATLAB library which can read or write ASCII Portable Pixel Map (PPM) graphics files.

PPMA_IO a Python library which can read or write ASCII Portable Pixel Map (PPM) graphics files.

PPMA_TO_BMP, a C++ program which converts an ASCII Portable Pixel Map (PPM) graphics file to a BMP graphics file;

PPMA_TO_PPMB, a C++ program which converts an ASCII Portable Pixel Map (PPM) graphics file to a binary PPM file;

PPMA_TO_PPMB, a FORTRAN90 program which converts an ASCII Portable Pixel Map (PPM) graphics file to a binary PPM file;

PPMB, a data directory which contains examples of binary Portable Pixel Map (PPM) files, 2D graphics, color;

PPMB_IO a C library which reads and writes binary Portable Pixel Map (PPM) graphics files.

PPMB_IO a C++ library which reads and writes binary Portable Pixel Map (PPM) graphics files.

PPMB_IO a Python library which reads and writes binary Portable Pixel Map (PPM) graphics files.

PPMB_TO_BMP, a C++ program which converts a binary Portable Pixel Map (PPM) file to a BMP graphics file;

PPMB_TO_PPMA, a C++ program which converts a binary Portable Pixel Map (PPM) to an ASCII PPM graphics file;

PPPACK, a FORTRAN77 library which computes piecewise polynomial functions, including cubic splines, by Carl deBoor.

PPPACK, a FORTRAN90 library which computes piecewise polynomial functions, including cubic splines, by Carl deBoor.

PRAXIS, a C library which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.

PRAXIS, a C++ library which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.

PRAXIS, a FORTRAN77 library which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.

PRAXIS, a FORTRAN90 library which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.

PRAXIS, a MATLAB library which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.

PRAXIS, a Python library which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.

PREDATOR_PREY_ODE, a MATLAB program which solves a pair of predator prey ordinary differential equations (ODE's) using MATLAB's ode23() solver.

PRESIDENTS, a dataset directory which contains data related to US presidents.

PRIME_MPI, a C program which counts the number of primes between 1 and N, using MPI for parallel execution.

PRIME_MPI, a C++ program which counts the number of primes between 1 and N, using MPI for parallel execution.

PRIME_MPI, a FORTRAN77 program which counts the number of primes between 1 and N, using MPI for parallel execution.

PRIME_MPI, a FORTRAN90 program which counts the number of primes between 1 and N, using MPI for parallel execution.

PRIME_MPI, a Python program which counts the number of primes between 1 and N, using MPI for parallel execution.

PRIME_OPENMP, a C program which counts the number of primes between 1 and N, using OpenMP for parallel execution.

PRIME_OPENMP, a C++ program which counts the number of primes between 1 and N, using OpenMP for parallel execution.

PRIME_OPENMP, a FORTRAN77 program which counts the number of primes between 1 and N, using OpenMP for parallel execution.

PRIME_OPENMP, a FORTRAN90 program which counts the number of primes between 1 and N, using OpenMP for parallel execution.

PRIME_PARFOR, a MATLAB program which counts the number of primes between 1 and N, running in parallel using MATLAB's parfor feature.

PRIME_PLOT a MATLAB program which displays a box plot of the prime and composite numbers.

PRIME_SERIAL, a C program which counts the number of primes between 1 and N, intended as a starting point for the creation of a parallel version.

PRIME_SERIAL, a C++ program which counts the number of primes between 1 and N, intended as a starting point for the creation of a parallel version.

PRIME_SERIAL, a FORTRAN77 program which counts the number of primes between 1 and N, intended as a starting point for the creation of a parallel version.

PRIME_SERIAL, a FORTRAN90 program which counts the number of primes between 1 and N, intended as a starting point for the creation of a parallel version.

PRIME_SERIAL, a MATLAB program which counts the number of primes between 1 and N, intended as a starting point for the creation of a parallel version.

PRIME_SERIAL, a Python program which counts the number of primes between 1 and N, intended as a starting point for the creation of a parallel version.

PRIME_SPMD, a MATLAB program which counts the number of primes between 1 and N; running in parallel using MATLAB's Single Program Multiple Data (SPMD) feature.

PROB, a C library which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF's) and Cumulative Density Functions (CDF's), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.

PROB, a C++ library which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF's) and Cumulative Density Functions (CDF's), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.

PROB, a FORTRAN77 library which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF's) and Cumulative Density Functions (CDF's), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.

PROB, a FORTRAN90 library which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF's) and Cumulative Density Functions (CDF's), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.

PROB, a MATLAB library which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF's) and Cumulative Density Functions (CDF's), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.

PROB, a Python library which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF's) and Cumulative Density Functions (CDF's), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.

PRODUCT_RULE, a C program which constructs a product quadrature rule from distinct 1D factor rules.

PRODUCT_RULE, a C++ program which constructs a product quadrature rule from distinct 1D factor rules.

PRODUCT_RULE, a FORTRAN77 program which constructs a product quadrature rule from distinct 1D factor rules.

PRODUCT_RULE, a FORTRAN90 program which constructs a product quadrature rule from distinct 1D factor rules.

PRODUCT_RULE, a MATLAB program which constructs a product quadrature rule from distinct 1D factor rules.

PRODUCT_RULE_GL, a dataset directory which contains M-dimensional quadrature rules formed as products of 1D Gauss-Legendre rules.

PROFILE, MATLAB programs which illustrate the use of the MATLAB profile utlity, which monitors the execution of a series of MATLAB commands, and then produces a performance profile report afterwards.

PROJ, examples which illustrate the use of PROJ, which is a program to convert between geographic longitude and latitude coordinates and a cartesian coordinate system.

PROPACK, a dataset directory which contains matrices in Harwell-Boeing format, used for testing the SVD package propack();

PS, a data directory which contains PostScript (PS) files, 2D graphics;

PS_WRITE, a FORTRAN90 library which can be used to create PostScript (PS) graphics files.

pthreads_test, C programs which test pthreads, the posix thread library, to carry out parallel program execution.

pthreads_test, C++ programs which test pthreads, the posix thread library, to carry out parallel program execution.

PUZZLES, FORTRAN90 programs which were used to solve various puzzles.

PUZZLES, MATLAB programs which were used to solve various puzzles.

pvbatch, examples which illustrate the use of PVBATCH, which is a Python interface to the ParaView graphics program, which can run as a noninteractive batch job, in parallel under MPI.

PWC_PLOT, a MATLAB library which converts the definition of a piecewise constant function into plottable data.

PWL_APPROX_1D, a C library which approximates a set of data using a piecewise linear function.

PWL_APPROX_1D, a C++ library which approximates a set of data using a piecewise linear function.

PWL_APPROX_1D, a FORTRAN77 library which approximates a set of data using a piecewise linear function.

PWL_APPROX_1D, a FORTRAN90 library which approximates a set of data using a piecewise linear function.

PWL_APPROX_1D, a MATLAB library which approximates a set of data using a piecewise linear function.

PWL_INTERP_1D, a C library which interpolates a set of data using a piecewise linear function, creating graphics files for processing by gnuplot.

PWL_INTERP_1D, a C++ library which interpolates a set of data using a piecewise linear function, creating graphics files for processing by gnuplot.

PWL_INTERP_1D, a FORTRAN77 library which interpolates a set of data using a piecewise linear function, creating graphics files for processing by gnuplot.

PWL_INTERP_1D, a FORTRAN90 library which interpolates a set of data using a piecewise linear function, creating graphics files for processing by gnuplot.

PWL_INTERP_1D, a MATLAB library which interpolates a set of data using a piecewise linear function.

PWL_INTERP_1D, a Python library which interpolates a set of data using a piecewise linear function.

PWL_INTERP_2D, a C library which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.

PWL_INTERP_2D, a C++ library which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.

PWL_INTERP_2D, a FORTRAN77 library which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.

PWL_INTERP_2D, a FORTRAN90 library which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.

PWL_INTERP_2D, a MATLAB library which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.

PWL_INTERP_2D, a Python library which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.

PWL_INTERP_2D_SCATTERED, a C library which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.

PWL_INTERP_2D_SCATTERED, a C++ library which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.

PWL_INTERP_2D_SCATTERED, a FORTRAN77 library which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.

PWL_INTERP_2D_SCATTERED, a FORTRAN90 library which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.

PWL_INTERP_2D_SCATTERED, a MATLAB library which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.

PY, Python programs which illustrate certain features of the language.

PYCUDA, examples which illustrate the use of PYCUDA, which is an interface which allows Python programs to execute CUDA kernels on the GPU.

PYRAMID_EXACTNESS, a C program which investigates the monomial exactness of a quadrature rule over the interior of a pyramid in 3D.

PYRAMID_EXACTNESS, a C++ program which investigates the monomial exactness of a quadrature rule over the interior of a pyramid in 3D.

PYRAMID_EXACTNESS, a FORTRAN77 program which investigates the monomial exactness of a quadrature rule over the interior of a pyramid in 3D.

PYRAMID_EXACTNESS, a FORTRAN90 program which investigates the monomial exactness of a quadrature rule over the interior of a pyramid in 3D.

PYRAMID_EXACTNESS, a MATLAB program which investigates the monomial exactness of a quadrature rule over the interior of a pyramid in 3D.

PYRAMID_FELIPPA_RULE, a C library which returns Felippa's quadratures rules for approximating integrals over the interior of a pyramid in 3D.

PYRAMID_FELIPPA_RULE, a C++ library which returns Felippa's quadratures rules for approximating integrals over the interior of a pyramid in 3D.

PYRAMID_FELIPPA_RULE, a FORTRAN77 library which returns Felippa's quadratures rules for approximating integrals over the interior of a pyramid in 3D.

PYRAMID_FELIPPA_RULE, a FORTRAN90 library which returns Felippa's quadratures rules for approximating integrals over the interior of a pyramid in 3D.

PYRAMID_FELIPPA_RULE, a MATLAB library which returns Felippa's quadratures rules for approximating integrals over the interior of a pyramid in 3D.

PYRAMID_GRID, a C library which computes a grid of points over the interior of the unit pyramid in 3D;

PYRAMID_GRID, a C++ library which computes a grid of points over the interior of the unit pyramid in 3D;

PYRAMID_GRID, a FORTRAN77 library which computes a grid of points over the interior of the unit pyramid in 3D;

PYRAMID_GRID, a FORTRAN90 library which computes a grid of points over the interior of the unit pyramid in 3D;

PYRAMID_GRID, a MATLAB library which computes a grid of points over the interior of the unit pyramid in 3D;

PYRAMID_GRID, a Python library which computes a grid of points over the interior of the unit pyramid in 3D;

PYRAMID_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.

PYRAMID_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.

PYRAMID_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.

PYRAMID_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.

PYRAMID_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.

PYRAMID_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.

PYRAMID_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;

PYRAMID_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;

PYRAMID_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;

PYRAMID_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;

PYRAMID_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;

PYRAMID_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;

PYRAMID_RULE, a C program which computes a quadrature rule over the interior of the unit pyramid in 3D;

PYRAMID_RULE, a C++ program which computes a quadrature rule over the interior of the unit pyramid in 3D;

PYRAMID_RULE, a FORTRAN77 program which computes a quadrature rule over the interior of the unit pyramid in 3D;

PYRAMID_RULE, a FORTRAN90 program which computes a quadrature rule over the interior of the unit pyramid in 3D;

PYRAMID_RULE, a MATLAB program which computes a quadrature rule over the interior of the unit pyramid in 3D;

PYTHON-UCS2 examples which illustrate the use of PYTHON-UCS2, which is a programming language.

PYTHON3GDAL examples which illustrate the use of PYTHON3GDAL, which is the Geospatial Data Abstraction Library, for reading and writing files of raster and vector geospatial data.

QR_SOLVE, a C library which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b.

QR_SOLVE, a C++ library which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b.

QR_SOLVE, a FORTRAN77 library which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b.

QR_SOLVE, a FORTRAN90 library which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b.

QR_SOLVE, a MATLAB library which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b.

QUAD_MESH, a data directory which defines a format for storing meshes of quadrilaterals over a 2D region.

QUAD_MESH, a C++ library which handles meshes of quadrilaterals over a 2D region;

QUAD_MESH, a FORTRAN90 library which handles meshes of quadrilaterals over a 2D region;

QUAD_MESH, a MATLAB library which handles meshes of quadrilaterals over a 2D region;

QUAD_MESH_ORDER1, a data directory of QUAD_MESH files, a quadrilateral mesh in 2D, with an associated data value that is constant over each element of the mesh;

QUAD_MESH_ORDER1_DISPLAY, a MATLAB program which plots piecewise constant data associated with a mesh of quadrilaterals;

QUAD_MESH_RCM, a C++ program which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.

QUAD_MESH_RCM, a FORTRAN90 program which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.

QUAD_MESH_RCM, a MATLAB program which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.

QUAD_MPI, a C program which approximates an integral using a quadrature rule, and carries out the computation in parallel using MPI.

QUAD_MPI, a C++ program which approximates an integral using a quadrature rule, and carries out the computation in parallel using MPI.

QUAD_MPI, a FORTRAN77 program which approximates an integral using a quadrature rule, and carries out the computation in parallel using MPI.

QUAD_MPI, a FORTRAN90 program which approximates an integral using a quadrature rule, and carries out the computation in parallel using MPI.

QUAD_MPI, a Python program which approximates an integral using a quadrature rule, and carries out the computation in parallel using MPI.

QUAD_OPENMP, a C program which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.

QUAD_OPENMP, a C++ program which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.

QUAD_OPENMP, a FORTRAN77 program which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.

QUAD_OPENMP, a FORTRAN90 program which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.

QUAD_PARFOR, a MATLAB program which estimates an integral using quadrature; running in parallel using MATLAB's parfor feature.

QUAD_SERIAL, a C program which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD_SERIAL, a C++ program which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD_SERIAL, a FORTRAN77 program which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD_SERIAL, a FORTRAN90 program which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD_SERIAL, a MATLAB program which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD_SERIAL, a Python program which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD_SPMD, a MATLAB program which estimates an integral using quadrature; running in parallel using MATLAB's Single Program Multiple Data (SPMD) feature.

QUAD_SURFACE, a data directory which contains QUAD_SURFACE files, a quadrilateral mesh in 3D, used to define a surface.

QUAD_SURFACE_DISPLAY, a MATLAB program which plots piecewise bilinear data associated with a QUAD_SURFACE, that is, a 3D surface defined by a quadrilateral mesh;

QUAD_TASKS, a MATLAB program which estimates an integral using quadrature; running in parallel using MATLAB's task feature.

QUAD2D_OPENMP, a C program which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.

QUAD2D_OPENMP, a C++ program which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.

QUAD2D_OPENMP, a FORTRAN77 program which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.

QUAD2D_OPENMP, a FORTRAN90 program which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.

QUAD2D_SERIAL, a C program which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD2D_SERIAL, a C++ program which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD2D_SERIAL, a FORTRAN77 program which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD2D_SERIAL, a FORTRAN90 program which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.

QUAD2D_SERIAL, a MATLAB program which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.

QUADMOM, a C library which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).

QUADMOM, a C++ library which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).

QUADMOM, a FORTRAN77 library which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).

QUADMOM, a FORTRAN90 library which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).

QUADMOM, a MATLAB library which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).

QUADPACK, a FORTRAN77 library which estimates integrals using numerical quadrature, using double precision arithmetic, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.

QUADPACK, a FORTRAN90 library which estimates integrals using numerical quadrature, using single precision arithmetic, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.

QUADPACK_DOUBLE, a FORTRAN90 library which estimates integrals using numerical quadrature, using double precision arithmetic, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.

QUADRATURE_GOLUB_WELSCH, a C library which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.

QUADRATURE_GOLUB_WELSCH, a C++ library which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.

QUADRATURE_GOLUB_WELSCH, a FORTRAN77 library which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.

QUADRATURE_GOLUB_WELSCH, a FORTRAN90 library which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.

QUADRATURE_GOLUB_WELSCH, a MATLAB library which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.

QUADRATURE_LEAST_SQUARES, a C library which computes weights for "sub-interpolatory" quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.

QUADRATURE_LEAST_SQUARES, a C++ library which computes weights for "sub-interpolatory" quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.

QUADRATURE_LEAST_SQUARES, a FORTRAN77 library which computes weights for "sub-interpolatory" quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.

QUADRATURE_LEAST_SQUARES, a FORTRAN90 library which computes weights for "sub-interpolatory" quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.

QUADRATURE_LEAST_SQUARES, a MATLAB library which computes weights for "sub-interpolatory" quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.

QUADRATURE_RULES, a dataset directory which contains quadrature rules for 1-dimensional intervals, 2D rectangles or M-dimensional rectangular regions, stored as a file of abscissas, a file of weights, and a file of region limits.

QUADRATURE_RULES_CCN, a dataset directory which contains quadrature rules for integration on [-1,+1], using a Clenshaw Curtis Nested (CCN) rule.

QUADRATURE_RULES_CHEBYSHEV1, a dataset directory which contains quadrature rules for integration on [-1,+1], using a Gauss-Chebyshev type 1 rule.

QUADRATURE_RULES_CHEBYSHEV2, a dataset directory which contains quadrature rules for integration on [-1,+1], using a Gauss-Chebyshev type 2 rule.

QUADRATURE_RULES_CLENSHAW_CURTIS, a dataset directory which contains quadrature rules for integration on [-1,+1], using a Clenshaw Curtis rule.

QUADRATURE_RULES_GEGENBAUER, a dataset directory which contains quadrature rules for integration on [-1,+1], using a Gauss-Gegenbauer rule.

QUADRATURE_RULES_GEN_HERMITE, a dataset directory which contains quadrature rules for integration on an infinite interval, using a generalized Gauss-Hermite rule.

QUADRATURE_RULES_GEN_LAGUERRE, a dataset directory which contains quadrature rules for integration on a semi-infinite interval, using a generalized Gauss-Laguerre rule.

QUADRATURE_RULES_HALTON, a dataset directory which contains quadrature rules for M-dimensional unit cubes, based on a Halton Quasi Monte Carlo (QMC) sequence. stored as a file of abscissas, a file of weights, and a file of region limits.

QUADRATURE_RULES_HERMITE_PHYSICIST, a dataset directory which contains Gauss-Hermite quadrature rules, for integration on the interval (-oo,+oo), with weight function exp(-x^2).

QUADRATURE_RULES_HERMITE_PROBABILIST, a dataset directory which contains Gauss-Hermite quadrature rules, for integration on the interval (-oo,+oo), with weight function exp(-x^2/2).

QUADRATURE_RULES_HERMITE_UNWEIGHTED, a dataset directory which contains Gauss-Hermite quadrature rules, for integration on the interval (-oo,+oo), with weight function 1.

QUADRATURE_RULES_JACOBI, a dataset directory which contains Gauss-Jacobi quadrature rules for the interval [-1,+1] with weight function (1-x)^ALPHA * (1+x)^BETA.

QUADRATURE_RULES_LAGUERRE, a dataset directory which contains Gauss-Laguerre quadrature rules for integration on the interval [A,+oo), with weight function exp(-x).

QUADRATURE_RULES_LATIN_CENTER, a dataset directory which contains quadrature rules for M-dimensional unit cubes, based on centered Latin hypercubes. stored as a file of abscissas, a file of weights, and a file of region limits.

QUADRATURE_RULES_LEGENDRE, a dataset directory which contains Gauss-Legendre quadrature rules for the interval [-1,+1].

QUADRATURE_RULES_PATTERSON, a dataset directory which contains Gauss-Patterson quadrature rules for the interval [-1,+1].

QUADRATURE_RULES_PYRAMID, a dataset directory which contains quadrature rules for a pyramid with a square base.

QUADRATURE_RULES_TET, a dataset directory which contains quadrature rules for tetrahedrons, stored as a file of abscissas, a file of weights, and a file of vertices.

QUADRATURE_RULES_TRI, a dataset directory which contains quadrature rules for triangles, stored as a file of abscissas, a file of weights, and a file of vertices.

QUADRATURE_RULES_UNIFORM, a dataset directory which contains quadrature rules for M-dimensional unit cubes, based on a uniform pseudorandom sequence. stored as a file of abscissas, a file of weights, and a file of region limits.

QUADRATURE_RULES_WEDGE, a dataset directory which contains quadrature rules for a wedge ( triangle x a line ).

QUADRATURE_TEST, a C++ program which reads files defining a M-dimensional quadrature rule, and applies them to all the test integrals defined by test_nint.

QUADRATURE_TEST, a FORTRAN90 program which reads files defining a M-dimensional quadrature rule, and applies them to all the test integrals defined by test_nint.

QUADRATURE_TEST, a MATLAB program which reads files defining a M-dimensional quadrature rule, and applies them to all the test integrals defined by test_nint.

QUADRATURE_TEST_2D, a C++ program which reads files defining a 2D quadrature rule, and applies them to all the test integrals defined by test_int_2d.

QUADRATURE_TEST_2D, a FORTRAN90 program which reads files defining a 2D quadrature rule, and applies them to all the test integrals defined by test_int_2d.

QUADRATURE_TEST_2D, a MATLAB program which reads files defining a 2D quadrature rule, and applies them to all the test integrals defined by test_int_2d.

QUADRATURE_TEST_GENZ, a FORTRAN90 program which reads the definition of a M-dimensional quadrature rule from three files, applies the rule to the Genz test integrals, and prints the results. (This is a version of quadrature_test() that is restricted to the Genz problems).

QUADRATURE_WEIGHTS_VANDERMONDE, a C library which computes the weights of a 1D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE, a C++ library which computes the weights of a 1D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE, a FORTRAN77 library which computes the weights of a 1D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE, a FORTRAN90 library which computes the weights of a 1D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE, a MATLAB library which computes the weights of a 1D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE_2D, a C library which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE_2D, a C++ library which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE_2D, a FORTRAN77 library which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE_2D, a FORTRAN90 library which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

QUADRATURE_WEIGHTS_VANDERMONDE_2D, a MATLAB library which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.

quadrilateral, a FENICS script which solves the Poisson equation on the unit square, using a quadrilateral mesh.

QUADRULE, a C library which defines quadrature rules for approximating an integral over a 1D domain.

QUADRULE, a C++ library which defines quadrature rules for approximating an integral over a 1D domain.

QUADRULE, a FORTRAN77 library which defines quadrature rules for approximating an integral over a 1D domain.

QUADRULE, a FORTRAN90 library which defines quadrature rules for approximating an integral over a 1D domain.

QUADRULE, a MATHEMATICA library which contains some scripts used to evaluate quadrature rules needed for the C, C++, FORTRAN90 and MATLAB quadrule libraries.

QUADRULE, a MATLAB library which defines quadrature rules for approximating an integral over a 1D domain.

QUADRULE, a Python library which defines quadrature rules for approximating an integral over a 1D domain.

QUADRULE_FAST, a MATLAB library which rapidly defines certain quadrature rules for 1D domains.

QUALITY, a C++ library which measures the dispersion of pointsets in M dimensions;

QUALITY, a FORTRAN90 library which measures the dispersion of pointsets in M dimensions;

QUALITY, a MATLAB library which measures the dispersion of pointsets in M dimensions;

QUATERNIONS, a C library which carries out some simple arithmetic operations for quaternions.

QUATERNIONS, a C++ library which carries out some simple arithmetic operations for quaternions.

QUATERNIONS, a FORTRAN90 library which carries out some simple arithmetic operations for quaternions.

QUATERNIONS, a MATLAB library which carries out some simple arithmetic operations for quaternions.

QUATERNIONS, a Python library which carries out some simple arithmetic operations for quaternions.

QUIZ, MATLAB programs which investigate a few simple questions, as practice for beginning MATLAB programmers.

QUOTES, a FORTRAN90 program which prints a random quote from a file;

QVORONOI, a C program which computes the Voronoi diagram of a pointset in M dimensions. This is part of the qhull package;

R, examples which illustrate the use of R, which is a programming language specifically focussed on statistical computing and the analysis of multiple large datasets.

R-PARALLEL, examples which illustrate the use of R-PARALLEL, which is a set of libraries for parallel programming in R: rmpi, snow, and snowfall.

R4LIB, a C library which contains many utility routines, using single precision real (R4) arithmetic.

R4LIB, a C++ library which contains many utility routines using single precision real (R4) arithmetic.

R4LIB, a FORTRAN77 library which contains many utility routines using single precision real (R4) arithmetic.

R4LIB, a FORTRAN90 library which contains many utility routines using single precision real (R4) arithmetic.

R4LIB, a Matlab library which contains many utility routines using single precision real (R4) arithmetic.

R4LIB, a Python library which contains many utility routines using single precision real (R4) arithmetic.

R83, a C library which contains linear algebra routines for R83 matrices (real, 64 bit, tridiagonal 3xN format).

R83, a C++ library which contains linear algebra routines for R83 matrices (real, 64 bit, tridiagonal 3xN format).

R83, a FORTRAN90 library which contains linear algebra routines for R83 matrices (real, 64 bit, tridiagonal 3xN format).

R83, a MATLAB library which contains linear algebra routines for R83 matrices (real, 64 bit, tridiagonal 3xN format).

R83, a Python library which contains linear algebra routines for R83 matrices (real, 64 bit, tridiagonal 3xN format).

R83_NP, a C library which contains linear algebra routines for R83_NP matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).

R83_NP, a C++ library which contains linear algebra routines for R83_NP matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).

R83_NP, a FORTRAN90 library which contains linear algebra routines for R83_NP matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).

R83_NP, a MATLAB library which contains linear algebra routines for R83_NP matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).

R83_NP, a Python library which contains linear algebra routines for R83_NP matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).

R83P, a C library which contains linear algebra routines for R83P matrices (real, 64 bit, tridiagonal periodic format).

R83P, a C++ library which contains linear algebra routines for R83P matrices (real, 64 bit, tridiagonal periodic format).

R83P, a FORTRAN90 library which contains linear algebra routines for R83P matrices (real, 64 bit, tridiagonal periodic format).

R83P, a MATLAB library which contains linear algebra routines for R83P matrices (real, 64 bit, tridiagonal periodic format).

R83P, a Python library which contains linear algebra routines for R83P matrices (real, 64 bit, tridiagonal periodic format).

R83S, a C library which contains linear algebra routines for R83S matrices (real, 64 bit, tridiagonal scalar format).

R83S, a C++ library which contains linear algebra routines for R83S matrices (real, 64 bit, tridiagonal scalar format).

R83S, a FORTRAN90 library which contains linear algebra routines for R83S matrices (real, 64 bit, tridiagonal scalar format).

R83S, a MATLAB library which contains linear algebra routines for R83S matrices (real, 64 bit, tridiagonal scalar format).

R83S, a Python library which contains linear algebra routines for R83S matrices (real, 64 bit, tridiagonal scalar format).

R83T, a C library which contains linear algebra routines for R83T matrices (real, 64 bit, tridiagonal Mx3 format).

R83T, a C++ library which contains linear algebra routines for R83T matrices (real, 64 bit, tridiagonal Mx3 format).

R83T, a FORTRAN90 library which contains linear algebra routines for R83T matrices (real, 64 bit, tridiagonal Mx3 format).

R83T, a MATLAB library which contains linear algebra routines for R83T matrices (real, 64 bit, tridiagonal Mx3 format).

R83T, a Python library which contains linear algebra routines for R83T matrices (real, 64 bit, tridiagonal Mx3 format).

R83V, a C library which contains linear algebra routines for R83V matrices (real, 64 bit, tridiagonal three vector format).

R83V, a C++ library which contains linear algebra routines for R83V matrices (real, 64 bit, tridiagonal three vector format).

R83V, a FORTRAN90 library which contains linear algebra routines for R83V matrices (real, 64 bit, tridiagonal three vector format).

R83V, a MATLAB library which contains linear algebra routines for R83V matrices (real, 64 bit, tridiagonal three vector format).

R83V, a Python library which contains linear algebra routines for R83V matrices (real, 64 bit, tridiagonal three vector format).

R85, a C library which contains linear algebra routines for R85 matrices (real, 64 bit, pentadiagonal format).

R85, a C++ library which contains linear algebra routines for R85 matrices (real, 64 bit, pentadiagonal format).

R85, a FORTRAN90 library which contains linear algebra routines for R85 matrices (real, 64 bit, pentadiagonal format).

R85, a MATLAB library which contains linear algebra routines for R85 matrices (real, 64 bit, pentadiagonal format).

R85, a Python library which contains linear algebra routines for R85 matrices (real, 64 bit, pentadiagonal format).

R8BB, a C library which contains linear algebra routines for R8BB matrices (real, 64 bit, border banded format).

R8BB, a C++ library which contains linear algebra routines for R8BB matrices (real, 64 bit, border banded format).

R8BB, a FORTRAN90 library which contains linear algebra routines for R8BB matrices (real, 64 bit, border banded format).

R8BB, a MATLAB library which contains linear algebra routines for R8BB matrices (real, 64 bit, border banded format).

R8BB, a Python library which contains linear algebra routines for R8BB matrices (real, 64 bit, border banded format).

R8BLT, a C library which contains linear algebra routines for R8BLT matrices (real, 64 bit, band lower triangular format).

R8BLT, a C++ library which contains linear algebra routines for R8BLT matrices (real, 64 bit, band lower triangular format).

R8BLT, a FORTRAN90 library which contains linear algebra routines for R8BLT matrices (real, 64 bit, band lower triangular format).

R8BLT, a MATLAB library which contains linear algebra routines for R8BLT matrices (real, 64 bit, band lower triangular format).

R8BLT, a Python library which contains linear algebra routines for R8BLT matrices (real, 64 bit, band lower triangular format).

R8BTO, a C library which contains linear algebra routines for R8BTO matrices (real, 64 bit, block Toeplitz format).

R8BTO, a C++ library which contains linear algebra routines for R8BTO matrices (real, 64 bit, block Toeplitz format).

R8BTO, a FORTRAN90 library which contains linear algebra routines for R8BTO matrices (real, 64 bit, block Toeplitz format).

R8BTO, a MATLAB library which contains linear algebra routines for R8BTO matrices (real, 64 bit, block Toeplitz format).

R8BTO, a Python library which contains linear algebra routines for R8BTO matrices (real, 64 bit, block Toeplitz format).

R8BUT, a C library which contains linear algebra routines for R8BUT matrices (real, 64 bit, band upper triangular format).

R8BUT, a C++ library which contains linear algebra routines for R8BUT matrices (real, 64 bit, band upper triangular format).

R8BUT, a FORTRAN90 library which contains linear algebra routines for R8BUT matrices (real, 64 bit, band upper triangular format).

R8BUT, a MATLAB library which contains linear algebra routines for R8BUT matrices (real, 64 bit, band upper triangular format).

R8BUT, a Python library which contains linear algebra routines for R8BUT matrices (real, 64 bit, band upper triangular format).

R8CB, a C library which contains linear algebra routines for R8CB matrices (real, 64 bit, Compressed Band format).

R8CB, a C++ library which contains linear algebra routines for R8CB matrices (real, 64 bit, Compressed Band format).

R8CB, a FORTRAN90 library which contains linear algebra routines for R8CB matrices (real, 64 bit, Compressed Band format).

R8CB, a MATLAB library which contains linear algebra routines for R8CB matrices (real, 64 bit, Compressed Band format).

R8CB, a Python library which contains linear algebra routines for R8CB matrices (real, 64 bit, Compressed Band format).

R8CBB, a C library which contains linear algebra routines for R8CBB matrices (real, 64 bit, Compressed Border Banded format).

R8CBB, a C++ library which contains linear algebra routines for R8CBB matrices (real, 64 bit, Compressed Border Banded format).

R8CBB, a FORTRAN90 library which contains linear algebra routines for R8CBB matrices (real, 64 bit, Compressed Border Banded format).

R8CBB, a MATLAB library which contains linear algebra routines for R8CBB matrices (real, 64 bit, Compressed Border Banded format).

R8CBB, a Python library which contains linear algebra routines for R8CBB matrices (real, 64 bit, Compressed Border Banded format).

R8CC, a C library which contains linear algebra routines for R8CC matrices (real, 64 bit, Compressed Column (Colptr,Row,Value) format).

R8CC, a C++ library which contains linear algebra routines for R8CC matrices (real, 64 bit, Compressed Column (Colptr,Row,Value) format).

R8CC, a FORTRAN90 library which contains linear algebra routines for R8CC matrices (real, 64 bit, Compressed Column (Colptr,Row,Value) format).

R8CC, a MATLAB library which contains linear algebra routines for R8CC matrices (real, 64 bit, Compressed Column (Colptr,Row,Value) format).

R8CC, a Python library which contains linear algebra routines for R8CC matrices (real, 64 bit, Compressed Column (Colptr,Row,Value) format).

R8CI, a C library which contains linear algebra routines for R8CI matrices (real, 64 bit, circulant format).

R8CI, a C++ library which contains linear algebra routines for R8CI matrices (real, 64 bit, circulant format).

R8CI, a FORTRAN90 library which contains linear algebra routines for R8CI matrices (real, 64 bit, circulant format).

R8CI, a MATLAB library which contains linear algebra routines for R8CI matrices (real, 64 bit, circulant format).

R8CI, a Python library which contains linear algebra routines for R8CI matrices (real, 64 bit, circulant format).

R8COL, a C library which contains utility routines for R8COL's, that is, double precision real MxN arrays, considered as N column vectors, each of length M. The data may be thought of as a matrix of multiple columns, and many operations will be carried out columnwise.

R8COL, a C++ library which contains utility routines for R8COL's, that is, double precision real MxN arrays, considered as N column vectors, each of length M. The data may be thought of as a matrix of multiple columns, and many operations will be carried out columnwise.

R8COL, a FORTRAN90 library which contains utility routines for R8COL's, that is, double precision real MxN arrays, considered as N column vectors, each of length M. The data may be thought of as a matrix of multiple columns, and many operations will be carried out columnwise.

R8COL, a MATLAB library which contains utility routines for R8COL's, that is, double precision real MxN arrays, considered as N column vectors, each of length M. The data may be thought of as a matrix of multiple columns, and many operations will be carried out columnwise.

R8COL, a Python library which contains utility routines for R8COL's, that is, double precision real MxN arrays, considered as N column vectors, each of length M. The data may be thought of as a matrix of multiple columns, and many operations will be carried out columnwise.

R8GB, a C library which contains linear algebra routines for R8GB matrices (real, 64 bit, General Banded format).

R8GB, a C++ library which contains linear algebra routines for R8GB matrices (real, 64 bit, General Banded format).

R8GB, a FORTRAN90 library which contains linear algebra routines for R8GB matrices (real, 64 bit, General Banded format).

R8GB, a MATLAB library which contains linear algebra routines for R8GB matrices (real, 64 bit, General Banded format).

R8GB, a Python library which contains linear algebra routines for R8GB matrices (real, 64 bit, General Banded format).

R8GD, a C library which contains linear algebra routines for R8GD matrices (real, 64 bit, general diagonal format).

R8GD, a C++ library which contains linear algebra routines for R8GD matrices (real, 64 bit, general diagonal format).

R8GD, a FORTRAN90 library which contains linear algebra routines for R8GD matrices (real, 64 bit, general diagonal format).

R8GD, a MATLAB library which contains linear algebra routines for R8GD matrices (real, 64 bit, general diagonal format).

R8GD, a Python library which contains linear algebra routines for R8GD matrices (real, 64 bit, general diagonal format).

R8GE, a C library which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).

R8GE, a C++ library which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).

R8GE, a FORTRAN90 library which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).

R8GE, a MATLAB library which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).

R8GE, a Python library which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).

R8GE_NP, a C library which contains nonpivoting linear algebra routines for R8GE_NP matrices (real, 64 bit, General Nonpivoting format).

R8GE_NP, a C++ library which contains nonpivoting linear algebra routines for R8GE_NP matrices (real, 64 bit, General Nonpivoting format).

R8GE_NP, a FORTRAN90 library which contains nonpivoting linear algebra routines for R8GE_NP matrices (real, 64 bit, General Nonpivoting format).

R8GE_NP, a MATLAB library which contains nonpivoting linear algebra routines for R8GE_NP matrices (real, 64 bit, General Nonpivoting format).

R8GE_NP, a Python library which contains nonpivoting linear algebra routines for R8GE_NP matrices (real, 64 bit, General Nonpivoting format).

R8LIB, a C library which contains many utility routines using double precision real (R8) arithmetic.

R8LIB, a C++ library which contains many utility routines using double precision real (R8) arithmetic.

R8LIB, a FORTRAN77 library which contains many utility routines using double precision real (R8) arithmetic.

R8LIB, a FORTRAN90 library which contains many utility routines using double precision real (R8) arithmetic.

R8LIB, a MATLAB library which contains many utility routines using double precision real (R8) arithmetic.

R8LIB, a Python library which contains many utility routines using double precision real (R8) arithmetic.

R8LT, a C library which contains linear algebra routines for R8LT matrices (real, 64 bit, lower triangular format).

R8LT, a C++ library which contains linear algebra routines for R8LT matrices (real, 64 bit, lower triangular format).

R8LT, a FORTRAN90 library which contains linear algebra routines for R8LT matrices (real, 64 bit, lower triangular format).

R8LT, a MATLAB library which contains linear algebra routines for R8LT matrices (real, 64 bit, lower triangular format).

R8LT, a Python library which contains linear algebra routines for R8LT matrices (real, 64 bit, lower triangular format).

R8LTT, a C library which contains linear algebra routines for R8LTT matrices (real, 64 bit, lower triangular Toeplitz format).

R8LTT, a C++ library which contains linear algebra routines for R8LTT matrices (real, 64 bit, lower triangular Toeplitz format).

R8LTT, a FORTRAN90 library which contains linear algebra routines for R8LTT matrices (real, 64 bit, lower triangular Toeplitz format).

R8LTT, a MATLAB library which contains linear algebra routines for R8LTT matrices (real, 64 bit, lower triangular Toeplitz format).

R8LTT, a Python library which contains linear algebra routines for R8LTT matrices (real, 64 bit, lower triangular Toeplitz format).

R8NCF, a C library which contains linear algebra routines for R8NCF matrices (real, 64 bit, nonsymmetric coordinate format).

R8NCF, a C++ library which contains linear algebra routines for R8NCF matrices (real, 64 bit, nonsymmetric coordinate format).

R8NCF, a FORTRAN90 library which contains linear algebra routines for R8NCF matrices (real, 64 bit, nonsymmetric coordinate format).

R8NCF, a MATLAB library which contains linear algebra routines for R8NCF matrices (real, 64 bit, nonsymmetric coordinate format).

R8NCF, a Python library which contains linear algebra routines for R8NCF matrices (real, 64 bit, nonsymmetric coordinate format).

R8PBL, a C library which contains linear algebra routines for R8PBL matrices (real, 64 bit, positive definite symmetric band lower format).

R8PBL, a C++ library which contains linear algebra routines for R8PBL matrices (real, 64 bit, positive definite symmetric band lower format).

R8PBL, a FORTRAN90 library which contains linear algebra routines for R8PBL matrices (real, 64 bit, positive definite symmetric band lower format).

R8PBL, a MATLAB library which contains linear algebra routines for R8PBL matrices (real, 64 bit, positive definite symmetric band lower format).

R8PBL, a Python library which contains linear algebra routines for R8PBL matrices (real, 64 bit, positive definite symmetric band lower format).

R8PBU, a C library which contains linear algebra routines for R8PBU matrices (real, 64 bit, positive definite symmetric band upper format).

R8PBU, a C++ library which contains linear algebra routines for R8PBU matrices (real, 64 bit, positive definite symmetric band upper format).

R8PBU, a FORTRAN90 library which contains linear algebra routines for R8PBU matrices (real, 64 bit, positive definite symmetric band upper format).

R8PBU, a MATLAB library which contains linear algebra routines for R8PBU matrices (real, 64 bit, positive definite symmetric band upper format).

R8PBU, a Python library which contains linear algebra routines for R8PBU matrices (real, 64 bit, positive definite symmetric band upper format).

R8PO, a C library which contains linear algebra routines for R8PO matrices (real, 64 bit, positive definite symmetric format).

R8PO, a C++ library which contains linear algebra routines for R8PO matrices (real, 64 bit, positive definite symmetric format).

R8PO, a FORTRAN90 library which contains linear algebra routines for R8PO matrices (real, 64 bit, positive definite symmetric format).

R8PO, a MATLAB library which contains linear algebra routines for R8PO matrices (real, 64 bit, positive definite symmetric format).

R8PO, a Python library which contains linear algebra routines for R8PO matrices (real, 64 bit, positive definite symmetric format).

R8POLY, a C library which contains utilities for polynomials with R8 coefficients, that is, using double precision or 64 bit real arithmetic.

R8POLY, a C++ library which contains utilities for polynomials with R8 coefficients, that is, using double precision or 64 bit real arithmetic.

R8POLY, a FORTRAN90 library which contains utilities for polynomials with R8 coefficients, that is, using double precision or 64 bit real arithmetic.

R8POLY, a MATLAB library which contains utilities for polynomials with R8 coefficients, that is, using double precision or 64 bit real arithmetic.

R8POLY, a Python library which contains utilities for polynomials with R8 coefficients, that is, using double precision or 64 bit real arithmetic.

R8PP, a C library which contains linear algebra routines for R8PP matrices (real, 64 bit, positive definite symmetric packed format).

R8PP, a C++ library which contains linear algebra routines for R8PP matrices (real, 64 bit, positive definite symmetric packed format).

R8PP, a FORTRAN90 library which contains linear algebra routines for R8PP matrices (real, 64 bit, positive definite symmetric packed format).

R8PP, a MATLAB library which contains linear algebra routines for R8PP matrices (real, 64 bit, positive definite symmetric packed format).

R8PP, a Python library which contains linear algebra routines for R8PP matrices (real, 64 bit, positive definite symmetric packed format).

R8RI, a C library which contains linear algebra routines for R8RI matrices (real, 64 bit, row indexed format).

R8RI, a C++ library which contains linear algebra routines for R8RI matrices (real, 64 bit, row indexed format).

R8RI, a FORTRAN90 library which contains linear algebra routines for R8RI matrices (real, 64 bit, row indexed format).

R8RI, a MATLAB library which contains linear algebra routines for R8RI matrices (real, 64 bit, row indexed format).

R8RI, a Python library which contains linear algebra routines for R8RI matrices (real, 64 bit, row indexed format).

R8ROW, a C library which contains utility routines for R8ROW's, that is, double precision real MxN arrays, considered as M row vectors, each of length N. The data may be thought of as a matrix of multiple rows, and many operations will be carried out rowwise.

R8ROW, a C++ library which contains utility routines for R8ROW's, that is, double precision real MxN arrays, considered as M row vectors, each of length N. The data may be thought of as a matrix of multiple rows, and many operations will be carried out rowwise.

R8ROW, a FORTRAN90 library which contains utility routines for R8ROW's, that is, double precision real MxN arrays, considered as M row vectors, each of length N. The data may be thought of as a matrix of multiple rows, and many operations will be carried out rowwise.

R8ROW, a MATLAB library which contains utility routines for R8ROW's, that is, double precision real MxN arrays, considered as M row vectors, each of length N. The data may be thought of as a matrix of multiple rows, and many operations will be carried out rowwise.

R8ROW, a Python library which contains utility routines for R8ROW's, that is, double precision real MxN arrays, considered as M row vectors, each of length N. The data may be thought of as a matrix of multiple rows, and many operations will be carried out rowwise.

R8S3, a C library which contains linear algebra routines for R8S3 matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8S3, a C++ library which contains linear algebra routines for R8S3 matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8S3, a FORTRAN90 library which contains linear algebra routines for R8S3 matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8S3, a MATLAB library which contains linear algebra routines for R8S3 matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8S3, a Python library which contains linear algebra routines for R8S3 matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8SD, a C library which contains linear algebra routines for R8SD matrices (real, 64 bit, symmetric diagonal format).

R8SD, a C++ library which contains linear algebra routines for R8SD matrices (real, 64 bit, symmetric diagonal format).

R8SD, a FORTRAN90 library which contains linear algebra routines for R8SD matrices (real, 64 bit, symmetric diagonal format).

R8SD, a MATLAB library which contains linear algebra routines for R8SD matrices (real, 64 bit, symmetric diagonal format).

R8SD, a Python library which contains linear algebra routines for R8SD matrices (real, 64 bit, symmetric diagonal format).

R8SM, a C library which contains linear algebra routines for R8SM matrices (real, 64 bit, Sherman-Morrison A-u*v' format).

R8SM, a C++ library which contains linear algebra routines for R8SM matrices (real, 64 bit, Sherman-Morrison A-u*v' format).

R8SM, a FORTRAN90 library which contains linear algebra routines for R8SM matrices (real, 64 bit, Sherman-Morrison A-u*v' format).

R8SM, a MATLAB library which contains linear algebra routines for R8SM matrices (real, 64 bit, Sherman-Morrison A-u*v' format).

R8SM, a Python library which contains linear algebra routines for R8SM matrices (real, 64 bit, Sherman-Morrison A-u*v' format).

R8SP, a C library which contains linear algebra routines for R8SP matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8SP, a C++ library which contains linear algebra routines for R8SP matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8SP, a FORTRAN90 library which contains linear algebra routines for R8SP matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8SP, a MATLAB library which contains linear algebra routines for R8SP matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8SP, a Python library which contains linear algebra routines for R8SP matrices (real, 64 bit, SLAP Triad (I,J,AIJ) format).

R8SR, a C library which carries out linear algebra operations for R8SR matrices (real, 64 bit, diagonal + compressed row offdiagonal format).

R8SR, a C++ library which carries out linear algebra operations for R8SR matrices (real, 64 bit, diagonal + compressed row offdiagonal format).

R8SR, a FORTRAN90 library which carries out linear algebra operations for R8SR matrices (real, 64 bit, diagonal + compressed row offdiagonal format).

R8SR, a MATLAB library which carries out linear algebra operations for R8SR matrices (real, 64 bit, diagonal + compressed row offdiagonal format).

R8SR, a Python library which carries out linear algebra operations for R8SR matrices (real, 64 bit, diagonal + compressed row offdiagonal format).

R8SS, a C library which carries out linear algebra operations for R8SS matrices (real, 64 bit, symmetric skyline format).

R8SS, a C++ library which carries out linear algebra operations for R8SS matrices (real, 64 bit, symmetric skyline format).

R8SS, a FORTRAN90 library which carries out linear algebra operations for R8SS matrices (real, 64 bit, symmetric skyline format).

R8SS, a MATLAB library which carries out linear algebra operations for R8SS matrices (real, 64 bit, symmetric skyline format).

R8SS, a Python library which carries out linear algebra operations for R8SS matrices (real, 64 bit, symmetric skyline format).

R8STO, a C library which contains linear algebra routines for R8STO matrices (real, 64 bit, symmetric Toeplitz N format).

R8STO, a C++ library which contains linear algebra routines for R8STO matrices (real, 64 bit, symmetric Toeplitz N format).

R8STO, a FORTRAN90 library which contains linear algebra routines for R8STO matrices (real, 64 bit, symmetric Toeplitz N format).

R8STO, a MATLAB library which contains linear algebra routines for R8STO matrices (real, 64 bit, symmetric Toeplitz N format).

R8STO, a Python library which contains linear algebra routines for R8STO matrices (real, 64 bit, symmetric Toeplitz N format).

R8TO, a C library which contains linear algebra routines for R8TO matrices (real, 64 bit, Toeplitz 2*N-1 format).

R8TO, a C++ library which contains linear algebra routines for R8TO matrices (real, 64 bit, Toeplitz 2*N-1 format).

R8TO, a FORTRAN90 library which contains linear algebra routines for R8TO matrices (real, 64 bit, Toeplitz 2*N-1 format).

R8TO, a MATLAB library which contains linear algebra routines for R8TO matrices (real, 64 bit, Toeplitz 2*N-1 format).

R8TO, a Python library which contains linear algebra routines for R8TO matrices (real, 64 bit, Toeplitz 2*N-1 format).

R8UT, a C library which contains linear algebra routines for R8UT matrices (real, 64 bit, upper triangular format).

R8UT, a C++ library which contains linear algebra routines for R8UT matrices (real, 64 bit, upper triangular format).

R8UT, a FORTRAN90 library which contains linear algebra routines for R8UT matrices (real, 64 bit, upper triangular format).

R8UT, a MATLAB library which contains linear algebra routines for R8UT matrices (real, 64 bit, upper triangular format).

R8UT, a Python library which contains linear algebra routines for R8UT matrices (real, 64 bit, upper triangular format).

R8UTT, a C library which contains linear algebra routines for R8UTT matrices (real, 64 bit, upper triangular Toeplitz format).

R8UTT, a C++ library which contains linear algebra routines for R8UTT matrices (real, 64 bit, upper triangular Toeplitz format).

R8UTT, a FORTRAN90 library which contains linear algebra routines for R8UTT matrices (real, 64 bit, upper triangular Toeplitz format).

R8UTT, a MATLAB library which contains linear algebra routines for R8UTT matrices (real, 64 bit, upper triangular Toeplitz format).

R8UTT, a Python library which contains linear algebra routines for R8UTT matrices (real, 64 bit, upper triangular Toeplitz format).

R8VM, a C library which contains linear algebra routines for R8VM matrices (real, 64 bit, Vandermonde format).

R8VM, a C++ library which contains linear algebra routines for R8VM matrices (real, 64 bit, Vandermonde format).

R8VM, a FORTRAN90 library which contains linear algebra routines for R8VM matrices (real, 64 bit, Vandermonde format).

R8VM, a MATLAB library which contains linear algebra routines for R8VM matrices (real, 64 bit, Vandermonde format).

R8VM, a Python library which contains linear algebra routines for R8VM matrices (real, 64 bit, Vandermonde format).

RAND48, a C program which demonstrates the rand48 family of random number generators (RNG's) available in the C/C++ standard library.

RAND48, a C++ program which demonstrates the rand48 family of random number generators (RNG's) available in the C/C++ standard library.

RANDLC, a C library which implements a random number generator (RNG) used by the NAS Benchmark programs.

RANDLC, a C++ library which implements a random number generator (RNG) used by the NAS Benchmark programs.

RANDLC, a FORTRAN77 library which implements a random number generator (RNG) used by the NAS Benchmark programs.

RANDLC, a FORTRAN90 library which implements a random number generator (RNG) used by the NAS Benchmark programs.

RANDLC, a MATLAB library which implements a random number generator (RNG) used by the NAS Benchmark programs.

RANDLC, a Python library which implements a random number generator (RNG) used by the NAS Benchmark programs.

RANDOM_DATA, a C library which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF's), spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.

RANDOM_DATA, a C++ library which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF's), spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.

RANDOM_DATA, a FORTRAN77 library which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF's), spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.

RANDOM_DATA, a FORTRAN90 library which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF's), spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.

RANDOM_DATA, a MATLAB library which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF's), spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.

RANDOM_DATA, a Python library which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF's), spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.

RANDOM_MATRIX_EIGENVALUES, a Python library which demonstrates how, for certain probability density functions (PDF's), a symmetric matrix with entries sampled from that PDF will have eigenvalues distributed according to Wigner's semicircle distribution.

RANDOM_MPI, a C program which demonstrates one way to generate the same sequence of random numbers for both sequential execution and parallel execution under MPI.

RANDOM_MPI, a C++ program which demonstrates one way to generate the same sequence of random numbers for both sequential execution and parallel execution under MPI.

RANDOM_MPI, a FORTRAN77 program which demonstrates one way to generate the same sequence of random numbers for both sequential execution and parallel execution under MPI.

RANDOM_MPI, a FORTRAN90 program which demonstrates one way to generate the same sequence of random numbers for both sequential execution and parallel execution under MPI.

RANDOM_OPENMP, a C program which illustrates how a parallel program using OpenMP can generate multiple distinct streams of random numbers.

RANDOM_OPENMP, a C++ program which illustrates how a parallel program using OpenMP can generate multiple distinct streams of random numbers.

RANDOM_OPENMP, a FORTRAN77 program which illustrates how a parallel program using OpenMP can generate multiple distinct streams of random numbers.

RANDOM_OPENMP, a FORTRAN90 program which illustrates how a parallel program using OpenMP can generate multiple distinct streams of random numbers.

RANDOM_SORTED, a C library which generates vectors of random values which are already sorted.

RANDOM_SORTED, a C++ library which generates vectors of random values which are already sorted.

RANDOM_SORTED, a FORTRAN90 library which generates vectors of random values which are already sorted.

RANDOM_SORTED, a MATLAB library which generates vectors of random values which are already sorted.

RANDOM_SORTED, a Python library which generates vectors of random values which are already sorted.

RANDOM_WALK_1D_SIMULATION, a MATLAB program which simulates a random walk in a 1-dimensional region.

RANDOM_WALK_2D_AVOID_SIMULATION, a MATLAB program which simulates a self-avoiding random walk in a 2-dimensional region.

RANDOM_WALK_2D_AVOID_TASKS, a MATLAB program which computes many self avoiding random walks in a 2-dimensional region by creating a job which defines each walk as a task, and then computes these independently using MATLAB's Parallel Computing Toolbox task computing capability.

RANDOM_WALK_2D_SIMULATION, a MATLAB program which simulates a random walk in a 2-dimensional region.

RANDOM_WALK_3D_SIMULATION, a MATLAB program which simulates a random walk in a 3-dimensional region.

RANDOM_WRITE, a FORTRAN90 program which creates a very large file of 32 bit integers, for input to the DIEHARD program, which can apply statistical tests for randomness.

RANLIB, a C library which produces random samples from Probability Density Functions (PDF's), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.

RANLIB, a C++ library which produces random samples from Probability Density Functions (PDF's), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.

RANLIB, a FORTRAN77 library which produces random samples from Probability Density Functions (PDF's), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.

RANLIB, a FORTRAN90 library which produces random samples from Probability Density Functions (PDF's), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.

RANLIB, a MATLAB library which produces random samples from Probability Density Functions (PDF's), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.

RANLIB, a Python library which produces random samples from Probability Density Functions (PDF's), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.

RANMAP, a FORTRAN90 program which creates PostScript (PS) images of iterated affine mappings, including the Barnsley fractal fern and the Levy dragon.

RBF_INTERP_1D, a C library which defines and evaluates radial basis function (RBF) interpolants to 1D data.

RBF_INTERP_1D, a C++ library which defines and evaluates radial basis function (RBF) interpolants to 1D data.

RBF_INTERP_1D, a FORTRAN77 library which defines and evaluates radial basis function (RBF) interpolants to 1D data.

RBF_INTERP_1D, a FORTRAN90 library which defines and evaluates radial basis function (RBF) interpolants to 1D data.

RBF_INTERP_1D, a MATLAB library which defines and evaluates radial basis function (RBF) interpolants to 1D data.

RBF_INTERP_1D, a Python library which defines and evaluates radial basis function (RBF) interpolants to 1D data.

RBF_INTERP_2D, a C library which defines and evaluates radial basis function (RBF) interpolants to 2D data.

RBF_INTERP_2D, a C++ library which defines and evaluates radial basis function (RBF) interpolants to 2D data.

RBF_INTERP_2D, a FORTRAN77 library which defines and evaluates radial basis function (RBF) interpolants to 2D data.

RBF_INTERP_2D, a FORTRAN90 library which defines and evaluates radial basis function (RBF) interpolants to 2D data.

RBF_INTERP_2D, a MATLAB library which defines and evaluates radial basis function (RBF) interpolants to 2D data.

RBF_INTERP_2D, a Python library which defines and evaluates radial basis function (RBF) interpolants to 2D data.

RBF_INTERP_ND, a C library which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.

RBF_INTERP_ND, a C++ library which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.

RBF_INTERP_ND, a FORTRAN77 library which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.

RBF_INTERP_ND, a FORTRAN90 library which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.

RBF_INTERP_ND, a MATLAB library which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.

RBOX, a C program which generates a set of points in a region, selected at random according to a given distribution.

RCM, a C++ library which applies the Reverse Cuthill McKee (RCM) algorithm for reordering the nodes of a graph, and reducing the bandwidth of a corresponding sparse matrix;

RCM, a FORTRAN90 library which applies the Reverse Cuthill McKee (RCM) algorithm for reordering the nodes of a graph, and reducing the bandwidth of a corresponding sparse matrix;

RCM, a MATLAB library which applies the Reverse Cuthill McKee (RCM) algorithm for reordering the nodes of a graph, and reducing the bandwidth of a corresponding sparse matrix;

REACTOR_SIMULATION, a C program which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."

REACTOR_SIMULATION, a C++ program which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."

REACTOR_SIMULATION, a FORTRAN77 program which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."

REACTOR_SIMULATION, a FORTRAN90 program which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."

REACTOR_SIMULATION, a MATLAB program which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."

readtable_test, MATLAB functions which use readtable() to read a data file containing data in columns, with some data being numeric and some text.

REAL_PRECISION, FORTRAN90 programs which investigate the somewhat awkward methods for requesting a real data type with given precision. This is the preferred method for requesting double or quadruple precision arithmetic;

RECOMMENT, a C++ program which converts C style comments to C++ style.

REFORMAT, a FORTRAN90 program which makes a copy of a file with a given number of words per line.

REGION, a FORTRAN90 library which reads 3D magnetic resonance imaging (MRI) voxel data, and groups the voxels into connected regions, called components or segments;

REGRESSION, a dataset directory which contains datasets for testing linear regression;

REGRESSION, a FORTRAN90 library which handles problems in linear regression.

REJECTION_SAMPLE, a MATLAB library which demonstrates acceptance/rejection sampling.

REJOIN, a FORTRAN90 library which demonstrates a way to split or merge data files for parallel computations.

REWORD, a C++ program which reads a text file and writes a copy which has a fixed number of words per line.

RING_DATA , a MATLAB library which can create, plot, or save data generated by sampling a number of concentric, possibly overlapping rings.

RING_MPI, a C program 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, a C++ program 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, a FORTRAN77 program 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, a FORTRAN90 program which uses the MPI parallel programming environment, and measures the time necessary to copy a set of data around a ring of processes.

RK4, a C library which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.

RK4, a C++ library which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.

RK4, a FORTRAN77 library which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.

RK4, a FORTRAN90 library which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.

RK4, a MATLAB library which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.

RK4, a Python library which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.

RKF45, a C library which implements the Runge-Kutta-Fehlberg (RKF) solver for the approximate solution of a system of ordinary differential equations (ODE's).

RKF45, a C++ library which implements the Runge-Kutta-Fehlberg (RKF) solver for the solution of an ordinary differential equation (ODE) system.

RKF45, a FORTRAN77 library which implements the Runge-Kutta-Fehlberg (RKF) solver for the solution of an ordinary differential equation (ODE) system.

RKF45, a FORTRAN90 library which implements the Runge-Kutta-Fehlberg (RKF) solver for the solution of an ordinary differential equation (ODE) system.

RKF45, a MATLAB library which implements the Runge-Kutta-Fehlberg (RKF) solver for the solution of an ordinary differential equation (ODE) system.

RKF45, a Python library which implements the Runge-Kutta-Fehlberg (RKF) solver for the solution of an ordinary differential equation (ODE) system.

RNGLIB, a C library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.

RNGLIB, a C++ library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.

RNGLIB, a FORTRAN77 library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.

RNGLIB, a FORTRAN90 library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.

RNGLIB, a MATLAB library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.

RNGLIB, a Python library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.

ROC, a FORTRAN90 program which computes the receiver operator characteristic (ROC);

ROMBERG, a FORTRAN90 library which approximates the integral of a function using the trapezoid rule, the composite trapezoid rule, a sequence of composite trapezoid rules with error estimation, or a sequence of composite trapezoid rules with error estimation and Romberg extrapolation.

ROMERO, a dataset directory which contains datasets of Latin Square points used as starting points for Centroidal Voronoi Tessellation (CVT) calculations;

ROOT_RC, a C library which seeks a solution of a scalar nonlinear equation f(x) = 0, or a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.

ROOT_RC, a C++ library which seeks a solution of a scalar nonlinear equation f(x) = 0, or a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.

ROOT_RC, a FORTRAN90 library which seeks a solution of a scalar nonlinear equation f(x) = 0, or a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.

ROOT_RC, a MATLAB library which seeks a solution of a scalar nonlinear equation f(x) = 0, or a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.

ROOT_RC, a Python library which seeks a solution of a scalar nonlinear equation f(x) = 0, or a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.

ROOTS_RC, a C library which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.

ROOTS_RC, a C++ library which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.

ROOTS_RC, a FORTRAN90 library which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.

ROOTS_RC, a MATLAB library which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.

ROOTS_RC, a Python library which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.

ROT13, a C program which makes a copy of a file which has been encoded using the ROT13 coding, and a ROT5 coding for digits.

ROT13, a C++ program which makes a copy of a file which has been encoded using the ROT13 coding, and a ROT5 coding for digits.

ROT13, a FORTRAN90 library which can encipher a string using the ROT13 cipher for letters, and the ROT5 cipher for digits.

ROT13, a MATLAB library which can encipher a string using the ROT13 cipher for letters, and the ROT5 cipher for digits.

ROT13, a Python library which can encipher a string using the ROT13 cipher for letters, and the ROT5 cipher for digits.

ROTATING_CUBE_DISPLAY_OPENGL, a C++ program which displays a rotating color cube in 3D, using OpenGL;

ROULETTE_SIMULATION, a MATLAB library which simulates the spinning of a roulette wheel and the evaluation of certain common roulette bets.

ROW_ECHELON_INTEGER, a C library which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.

ROW_ECHELON_INTEGER, a C++ library which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.

ROW_ECHELON_INTEGER, a FORTRAN90 library which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.

ROW_ECHELON_INTEGER, a MATLAB library which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.

ROW_ECHELON_INTEGER, a Python library which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.

RREF, a MATLAB library which demonstrates some uses of the reduced row echelon form (RREF) of a matrix, which can be singular or rectangular.

RSITES, a C++ program which generates random pointsets with integer coordinates for testing computational geometry algorithms, by Ken Clarkson.

S2DE_FREEFEM++, examples which illustrate the use of FREEFEM++ for the solution of steady-state incompressible Stokes flow problems.

SAC, examples which illustrate the use of SAC, which is a seismic analysis code.

SAMMON, a dataset directory which contains six sets of M-dimensional data for cluster analysis.

SAMMON_DATA, a MATLAB program which generates six sets of M-dimensional data for cluster analysis.

SAMMON_DATA, a Python program which generates six sets of M-dimensional data for cluster analysis.

SAMPLE_2D, a dataset directory which contains datasets of points that sample the unit square;

SAMTOOLS, examples which illustrate the use of SAMTOOLS, which is a set of tools for high throughput sequencing data.

SANDIA_CUBATURE, a C++ library which computes M-dimensional quadrature rules for certain regions and weight functions.

SANDIA_CUBATURE, a FORTRAN90 library which computes M-dimensional quadrature rules for certain regions and weight functions.

SANDIA_CUBATURE, a MATLAB library which computes M-dimensional quadrature rules for certain regions and weight functions.

SANDIA_CVT, a FORTRAN77 program which positions a given number of points in an arbitrary region, using probabilistic centroidal Voronoi tessellation techniques to achieve good coverage and separation; developed for Sandia National Laboratories;

SANDIA_CVT, a FORTRAN90 program which positions a given number of points in an arbitrary region, using probabilistic centroidal Voronoi tessellation techniques to achieve good coverage and separation; developed for Sandia National Laboratories;

SANDIA_RULES, a C library which produces 1D quadrature rules of Chebyshev, Clenshaw Curtis, Fejer 2, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, Legendre and Patterson types.

SANDIA_RULES, a C++ library which produces 1D quadrature rules of Chebyshev, Clenshaw Curtis, Fejer 2, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, Legendre and Patterson types.

SANDIA_RULES, a FORTRAN90 library which produces 1D quadrature rules of Chebyshev, Clenshaw Curtis, Fejer 2, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, Legendre and Patterson types.

SANDIA_RULES, a MATLAB library which produces 1D quadrature rules of Chebyshev, Clenshaw Curtis, Fejer 2, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, Legendre and Patterson types.

SANDIA_RULES2, a C++ library which contains a very small selection of functions which serve as an interface between SANDIA_SGMG or SANDIA_SGMGA and SANDIA_RULES.

SANDIA_SGMG, a C++ library which creates a sparse grid dataset based on a mixed set of 1D factor rules, and experiments with the use of a linear growth rate for the quadrature rules. This is a version of SGMG that uses a different procedure for supplying the parameters needed to evaluate certain quadrature rules.

SANDIA_SGMGA, a C++ library which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension. This is a version of SGMGA that uses a different procedure for supplying the parameters needed to evaluate certain quadrature rules.

SANDIA_SGMGG, a C++ library which explores a generalized construction method for sparse grids.

SANDIA_SGMGG, a FORTRAN90 library which explores a generalized construction method for sparse grids.

SANDIA_SGMGG, a MATLAB library which explores a generalized construction method for sparse grids.

SANDIA_SPARSE, a C++ library which can produce a M-dimensional sparse grid, based on a variety of 1D quadrature rules; only isotropic grids are generated, that is, the same rule is used in each dimension, and the same maximum order is used in each dimension.

SANDIA_SPARSE, a FORTRAN90 library which can produce a M-dimensional sparse grid, based on a variety of 1D quadrature rules; only isotropic grids are generated, that is, the same rule is used in each dimension, and the same maximum order is used in each dimension.

SANDIA_SPARSE, a MATLAB library which can produce a M-dimensional sparse grid, based on a variety of 1D quadrature rules; only isotropic grids are generated, that is, the same rule is used in each dimension, and the same maximum order is used in each dimension.

SATISFY, a C program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.

SATISFY, a C++ program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.

SATISFY, a FORTRAN77 program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.

SATISFY, a FORTRAN90 program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.

SATISFY, a MATLAB program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.

SATISFY, a Python program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.

SATISFY_MPI, a C program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using MPI to carry out the calculation in parallel.

SATISFY_MPI, a C++ program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using MPI to carry out the calculation in parallel.

SATISFY_MPI, a FORTRAN77 program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using MPI to carry out the calculation in parallel.

SATISFY_MPI, a FORTRAN90 program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using MPI to carry out the calculation in parallel.

SATISFY_OPENMP, a C program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using OpenMP for parallel execution.

SATISFY_OPENMP, a C++ program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using OpenMP for parallel execution.

SATISFY_OPENMP, a FORTRAN77 program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using OpenMP for parallel execution.

SATISFY_OPENMP, a FORTRAN90 program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using OpenMP for parallel execution.

SATISFY_PARFOR, a MATLAB program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, running in parallel using MATLAB's parfor feature.

SCALAPACK, examples which illustrate the use of SCALAPACK, which is a library for the configuration, distribution, and solution of linear algebra problems using distributed memory and parallel processing.

scalapack_test, FORTRAN90 programs which demonstrate scalapack, a linear algebra library for parallel computing.

SCHEDULE_OPENMP, a C program which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.

SCHEDULE_OPENMP, a C++ program which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.

SCHEDULE_OPENMP, a FORTRAN77 program which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.

SCHEDULE_OPENMP, a FORTRAN90 program which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.

SCHWARZ_MPI, a FreeFem++ script which demonstrates how the Schwarz method can be implemented with MPI. For this demonstration, only 2 MPI processes are involved.

SCHWARZ_OVERLAP, a FreeFem++ script which demonstrates how the Schwarz method can be implemented. This example replaces the original domain by two overlapping subdomains.

SCIP_SOLUTION_READ, a MATLAB program which reads a file created by the integer programming package SCIP, representing the solution of a polyomino tiling problem, and writes out a simple ASCII file that can be read by load().

SCIPY, examples which illustrate the use of SCIPY, which is a Python library of algorithms addressing common problems in scientific computing.

SCONS, examples which illustrate the use of SCONS, which is a tool for building software, and is intended as a powerful and flexible substitute for the standard Make facility.

scotch_test, a FORTRAN77 program which tests the scotch sparse matrix package.

SCPACK, a FORTRAN77 library which performs the numerical computation of Schwarz-Christoffel conformal mappings, by Nick Trefethen.

SCREENSHOT_OPENGL, a C program which shows how a program using the OpenGL graphics library can save a screenshot of the graphics being displayed.

SCREENSHOT_OPENGL, a C++ program which shows how a program using the OpenGL graphics library can save a screenshot of the graphics being displayed.

SCVT_MPI, a C++ program which determines a Centroidal Voronoi Tessellation (CVT) on a spherical surface, using triangle() for triangulation, and the boost mpi and serialization libraries, by Doug Jacobsen;

SDE, a C library which illustrates properties of stochastic ordinary differential equations (SODE's), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, making graphics files for processing and display by gnuplot, by Desmond Higham;

SDE, a C++ library which illustrates properties of stochastic ordinary differential equations (SODE's), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;

SDE, a FORTRAN77 library which illustrates properties of stochastic ordinary differential equations (SODE's), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;

SDE, a FORTRAN90 library which illustrates properties of stochastic ordinary differential equations (SODE's), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;

SDE, a MATLAB library which illustrates properties of stochastic ordinary differential equations (SODE's), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;

SEARCH_MPI, a C program which searches integers between A and B for a value J such that F(J) = C, using MPI for parallel execution.

SEARCH_MPI, a C++ program which searches integers between A and B for a value J such that F(J) = C, using MPI for parallel execution.

SEARCH_MPI, a FORTRAN77 program which searches integers between A and B for a value J such that F(J) = C, using MPI for parallel execution.

SEARCH_MPI, a FORTRAN90 program which searches integers between A and B for a value J such that F(J) = C, using MPI for parallel execution.

SEARCH_MPI, a Python program which searches integers between A and B for a value J such that F(J) = C, using MPI and MPI4PY for parallel execution.

SEARCH_SERIAL, a C program which searches integers between A and B for a value J such that F(J) = C, intended as a starting point for the creation of a parallel version.

SEARCH_SERIAL, a C++ program which searches integers between A and B for a value J such that F(J) = C, intended as a starting point for the creation of a parallel version.

SEARCH_SERIAL, a FORTRAN77 program which searches integers between A and B for a value J such that F(J) = C, intended as a starting point for the creation of a parallel version.

SEARCH_SERIAL, a FORTRAN90 program which searches integers between A and B for a value J such that F(J) = C, intended as a starting point for the creation of a parallel version.

SEARCH_SERIAL, a MATLAB program which searches integers between A and B for a value J such that F(J) = C, intended as a starting point for the creation of a parallel version.

SEARCH_SERIAL, a Python program which searches integers between A and B for a value J such that F(J) = C, intended as a starting point for the creation of a parallel version.

SELECT, a FORTRAN77 library which generates various combinatorial objects.

SELECT, a FORTRAN90 library which generates various combinatorial objects.

SEMICIRCLE_INTEGRALS, a MATHEMATICA program which evaluates the integral of a function f(x,y) over the unit semicircle -1 <= x <= +1, 0 <= y <= sqrt (1-x^2).

SEQTK, examples which illustrate the use of SEQTK, which is a toolkit of programs for working with sequence data in FASTA or FASTQ format.

SEQUENCE, a FORTRAN90 program which reads a numeric sequence with missing values, and fills in the missing values.

SEQUENCE_STREAK_DISPLAY, a MATLAB program which displays a streak plot of a numeric sequence;

SERBA, a FORTRAN77 program which applies the boundary element method (BEM) to solve the elasticity equation in a 2D region, by Federico Paris and Jose Canas.

SET_THEORY, a C library which demonstrates various set theoretic operations using several models of a set.

SET_THEORY, a C++ library which demonstrates various set theoretic operations using several models of a set.

SET_THEORY, a FORTRAN77 library which demonstrates various set theoretic operations using several models of a set.

SET_THEORY, a FORTRAN90 library which demonstrates various set theoretic operations using several models of a set.

SET_THEORY, a MATLAB library which demonstrates MATLAB commands that implement various set theoretic operations.

SFTPACK, a C library which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).

SFTPACK, a C++ library which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).

SFTPACK, a FORTRAN77 library which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).

SFTPACK, a FORTRAN90 library which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).

SFTPACK, a MATLAB library which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).

SFTPACK, a Python library which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).

SGB, a dataset directory which contains files used as input data for demonstrations and tests of Donald Knuth's Stanford Graph Base (SGB).

SGE, examples which illustrate the use of the Sun Grid Engine (SGE), a job queueing system whose input is a modified form of shell scripts in the BASH shell, C shell, and so on.

SGEFA_OPENMP, a C program which reimplements the sgefa/sgesl linear algebra routines from LINPACK for use with OpenMP.

SGEFA_OPENMP, a C++ program which reimplements the sgefa/sgesl linear algebra routines from LINPACK for use with OpenMP.

SGEFA_OPENMP, a FORTRAN77 program which reimplements the sgefa/sgesl linear algebra routines from LINPACK for use with OpenMP.

SGEFA_OPENMP, a FORTRAN90 program which reimplements the sgefa/sgesl linear algebra routines from LINPACK for use with OpenMP.

SGMG, a C++ library which creates a sparse grid dataset based on a mixed set of 1D factor rules, and experiments with the use of a linear growth rate for the quadrature rules.

SGMG, a dataset directory which contains M-dimensional Smolyak sparse grids based on a mixed set of 1D factor rules and a choice of exponential or linear growth rates.

SGMGA, a C library which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.

SGMGA, a C++ library which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.

SGMGA, a FORTRAN90 library which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.

SGMGA, a MATLAB library which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.

SGMGA, a dataset directory which contains Sparse Grid Mixed Growth Anisotropic (SGMGA) files, that is, M-dimensional Smolyak sparse grids based on a mixture of 1D rules, and with a choice of exponential and linear growth rates for the 1D rules and anisotropic weights for the dimensions.

SHALLOW_WATER_1D, a C program which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.

SHALLOW_WATER_1D, a C++ program which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.

SHALLOW_WATER_1D, a FORTRAN90 program which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.

SHALLOW_WATER_1D, a MATLAB program which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.

SHALLOW_WATER_1D_DISPLAY, a MATLAB program which can display a solution of the shallow water equations in 1D, generally as computed by the program shallow_water_1d.

SHALLOW_WATER_2D, a MATLAB program which simulates the evolution of a 2D fluid governed by the time-dependent shallow water equations, by Cleve Moler.

SHALLOW_WATER_2D, a Python program which simulates the evolution of a 2D fluid governed by the time-dependent shallow water equations, by Cleve Moler.

SHEPARD_INTERP_1D, a C library which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.

SHEPARD_INTERP_1D, a C++ library which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.

SHEPARD_INTERP_1D, a FORTRAN77 library which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.

SHEPARD_INTERP_1D, a FORTRAN90 library which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.

SHEPARD_INTERP_1D, a MATLAB library which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.

SHEPARD_INTERP_1D, a Python library which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.

SHEPARD_INTERP_2D, a C library which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.

SHEPARD_INTERP_2D, a C++ library which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.

SHEPARD_INTERP_2D, a FORTRAN77 library which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.

SHEPARD_INTERP_2D, a FORTRAN90 library which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.

SHEPARD_INTERP_2D, a MATLAB library which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.

SHEPARD_INTERP_ND, a C library which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.

SHEPARD_INTERP_ND, a C++ library which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.

SHEPARD_INTERP_ND, a FORTRAN77 library which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.

SHEPARD_INTERP_ND, a FORTRAN90 library which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.

SHEPARD_INTERP_ND, a MATLAB library which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.

SHORELINE, a MATLAB program which tries to identify and triangulate the 2D domain over which some function f(x,y) is nonnegative.

SHORELINE2, a MATLAB program which tries to identify and triangulate the 2D domain over which some function f(x,y) is approximately zero.

SHOWME, a C program which uses the X Window library to display triangulatons, by Jonathan Shewchuk.

SIDE_BY_SIDE_DISPLAY, a MATLAB program which demonstrates how to display curves side by side in a 3D plot; the curves might be yearly snowfall data over consecutive years, for instance.

SIMPACK, a FORTRAN77 library which approximates the integral of a function over an M-dimensional simplex, by Alan Genz.

SIMPLE_GA, a C++ program which a simple example of a genetic algorithm, by Dennis Cormier and Sita Raghavan.

SIMPLEX_COORDINATES, a C library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.

SIMPLEX_COORDINATES, a C++ library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.

SIMPLEX_COORDINATES, a FORTRAN77 library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.

SIMPLEX_COORDINATES, a FORTRAN90 library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.

SIMPLEX_COORDINATES, a MATLAB library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.

SIMPLEX_COORDINATES, a Python library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.

SIMPLEX_GM_RULE, a C library which defines Grundmann-Moeller quadrature rules over the interior of a simplex in M dimensions.

SIMPLEX_GM_RULE, a C++ library which defines Grundmann-Moeller quadrature rules over the interior of a simplex in M dimensions.

SIMPLEX_GM_RULE, a FORTRAN77 library which defines Grundmann-Moeller quadrature rules over the interior of a simplex in M dimensions.

SIMPLEX_GM_RULE, a FORTRAN90 library which defines Grundmann-Moeller quadrature rules over the interior of a simplex in M dimensions.

SIMPLEX_GM_RULE, a MATLAB library which defines Grundmann-Moeller quadrature rules over the interior of a simplex in M dimensions.

SIMPLEX_GM_RULE, a Python library which defines Grundmann-Moeller quadrature rules over the interior of a simplex in M dimensions.

SIMPLEX_GRID, a C library which generates a grid of points over the interior of a simplex in M dimensions.

SIMPLEX_GRID, a C++ library which generates a grid of points over the interior of a simplex in M dimensions.

SIMPLEX_GRID, a FORTRAN77 library which generates a grid of points over the interior of a simplex in M dimensions.

SIMPLEX_GRID, a FORTRAN90 library which generates a grid of points over the interior of a simplex in M dimensions.

SIMPLEX_GRID, a MATLAB library which generates a grid of points over the interior of a simplex in M dimensions.

SIMPLEX_GRID, a Python library which generates a grid of points over the interior of a simplex in M dimensions.

SIMPLEX_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.

SIMPLEX_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.

SIMPLEX_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.

SIMPLEX_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.

SIMPLEX_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.

SIMPLEX_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.

SIMPLEX_MONTE_CARLO, a C library which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.

SIMPLEX_MONTE_CARLO, a C++ library which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.

SIMPLEX_MONTE_CARLO, a FORTRAN77 library which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.

SIMPLEX_MONTE_CARLO, a FORTRAN90 library which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.

SIMPLEX_MONTE_CARLO, a MATLAB library which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.

SIMPLEX_MONTE_CARLO, a Python library which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.

SINE_TRANSFORM, a C library which demonstrates some simple properties of the discrete sine transform.

SINE_TRANSFORM, a C++ library which demonstrates some simple properties of the discrete sine transform.

SINE_TRANSFORM, a FORTRAN77 library which demonstrates some simple properties of the discrete sine transform.

SINE_TRANSFORM, a FORTRAN90 library which demonstrates some simple properties of the discrete sine transform.

SINE_TRANSFORM, a MATLAB library which demonstrates some simple properties of the discrete sine transform.

SINE_TRANSFORM, a Python library which demonstrates some simple properties of the discrete sine transform.

SINGLE_LINKAGE, a MATLAB library which demonstrates the use of MATLAB's single linkage clustering functions.

SINGULAR examples which illustrate the use of SINGULAR, which is a computer algebra system for polynomial computations, with special emphasis on commutative and non-commutative algebra, algebraic geometry, and singularity theory.

SIR, a MATLAB program which simulates the spread of a disease using the Susceptible/Infected/Recovered (SIR) model.

SIR_SIMULATION, a MATLAB program which simulates the spread of a disease through a hospital room of M by N beds, using the Susceptible/Infected/Recovered (SIR) model.

SLATEC, a FORTRAN90 library which collects together a number of standard numerical libraries, including BLAS, DASSL, DEPAC, EISPACK, FFTPACK, FISHPACK, FNLIB, LINPACK, PCHIP, QUADPACK, SDRIV, SLAP, XERROR.

SLURM, examples which illustrate the use of the SLURM job scheduler for batch execution of jobs on a computer cluster.

SMDLIB_FONTS, a FORTRAN77 program which reads ASCII files defining fonts, and creates a single direct access binary font file for use by the smdlib graphics library.

SMDLIB_FONTS, a FORTRAN90 program which reads ASCII files defining fonts, and creates a single direct access binary font file for use by the smdlib graphics library.

SMF, a data directory which contains examples of SMF files. The SMF format was used by Michael Garland as an input and output format for his surface simplifying program QSLIM.

SMOLPACK, a C library which estimates the integral of a function over a M-dimensional hypercube using a sparse grid, by Knut Petras;

SMOLYAK_DISPLAY, a MATLAB program which displays the exactness diagram for a 2D Smolyak sparse grid, by displaying and summing the exactness diagrams for the component product rules.

SNAKES_AND_LADDERS, C programs which simulate the game of Snakes and Ladders.

SNAKES_AND_LADDERS, C++ programs which simulate the game of Snakes and Ladders.

SNAKES_AND_LADDERS, FORTRAN77 programs which simulate the game of Snakes and Ladders.

SNAKES_AND_LADDERS, FORTRAN90 programs which simulate the game of Snakes and Ladders.

SNAKES_AND_LADDERS, a MATLAB program which simulates the game of Snakes and Ladders.

SNAKES_AND_LADDERS, a Python library which simulates the game of Snakes and Ladders.

SNAKES_BAR, a MATLAB library which produces bar charts of the count, PDF and CDF estimates for the length of a one-player game of Snakes and Ladders, produced by simulating N games.

SNAKES_HISTOGRAM, a MATLAB library which produces histograms of the count, PDF and CDF estimates for the length of a one-player game of Snakes and Ladders, produced by simulating N games.

SNAKES_MATRIX, a MATLAB program which computes the transition matrix for Snakes and Ladders

SNAKES_PROBABILITY, a MATLAB program which computes the game length probabilities for Snakes and Ladders, by Desmond Higham and Nicholas Higham.

SOBOL, a dataset directory which contains samples of the Sobol Quasi Monte Carlo (QMC) sequence;

SOBOL, a C++ library which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence, by Bennett Fox.

SOBOL, a FORTRAN90 library which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence, by Bennett Fox.

SOBOL, a MATLAB library which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence, by Bennett Fox.

SOBOL, a Python library which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence.

SOBOL_DATASET, a C++ program which computes a Sobol Quasi Monte Carlo (QMC) sequence and writes it to a file.

SOBOL_DATASET, a FORTRAN90 program which computes a Sobol Quasi Monte Carlo (QMC) sequence and writes it to a file.

SOBOL_DATASET, a MATLAB program which computes a Sobol Quasi Monte Carlo (QMC) sequence and writes it to a file.

SOKAL_ROHLF, a dataset directory which contains biological datasets considered by Sokal and Rohlf.

SOLVE, a C library which implements a linear solver which makes it easy to create doubly-dimensioned arrays and solve associated linear systems.

SOLVE, a C++ library which implements a linear solver which makes it easy to create doubly-dimensioned arrays and solve associated linear systems.

SOLVE, a FORTRAN77 library which demonstrates how Gauss elimination can be used to solve a simple system of linear equations A*x=b.

SOLVE, a FORTRAN90 library which demonstrates how Gauss elimination can be used to solve a simple system of linear equations A*x=b.

SOLVE, a MATLAB library which demonstrates how Gauss elimination can be used to solve a simple system of linear equations A*x=b.

SOLVE, a Python library which demonstrates how Gauss elimination can be used to solve a simple system of linear equations A*x=b.

SOR, a C++ library which implements a simple version of the successive over-relaxation (SOR) method for the iteration solution of a linear system of equations.

SOR, a MATLAB library which implements a simple version of the successive over-relaxation (SOR) method for the iteration solution of a linear system of equations.

SORT, examples which illustrate the use of the unix SORT command.

SORT_RC, a C library which can sort a list of any kind of objects, using reverse communication (RC).

SORT_RC, a C++ library which can sort a list of any kind of objects, using reverse communication (RC).

SORT_RC, a FORTRAN77library which can sort a list of any kind of objects, using reverse communication (RC).

SORT_RC, a FORTRAN90 library which can sort a list of any kind of objects, using reverse communication (RC).

SORT_RC, a MATLAB library which can sort a list of any kind of objects, using reverse communication (RC).

SORT_RC, a Python library which can sort a list of any kind of objects, using reverse communication (RC).

SOX, examples which illustrate the use of SOX, which is a program for the manipulation of sound data.

SPADES, examples which illustrate the use of SPADES, which is an assembly toolkit containing various assembly pipelines.

SPAETH, a dataset directory which contains datasets for cluster analysis;

SPAETH, a FORTRAN90 library which can cluster data according to various principles, by Helmut Spaeth.

SPAETH2, a dataset directory which contains datasets for cluster analysis;

SPAETH2, a FORTRAN77 library which can cluster data according to various principles, by Helmut Spaeth.

SPAETH2, a FORTRAN90 library which can cluster data according to various principles, by Helmut Spaeth.

SPARSE, MATLAB programs which illustrate the use of MATLAB's sparse matrix utilities;

SPARSE_COUNT, a C++ library which for the analysis and creation of sparse grids in which a single family of 1D quadrature rules is used for all spatial dimensions, and various growth rules are considered.

SPARSE_COUNT, a FORTRAN90 library which for the analysis and creation of sparse grids in which a single family of 1D quadrature rules is used for all spatial dimensions, and various growth rules are considered.

SPARSE_COUNT, a MATLAB library which for the analysis and creation of sparse grids in which a single family of 1D quadrature rules is used for all spatial dimensions, and various growth rules are considered.

SPARSE_DISPLAY, a C library which can read information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot. This operation is already available in the built-in MATLAB "spy" command.

SPARSE_DISPLAY, a C++ library which can read information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot. This operation is already available in the built-in MATLAB "spy" command.

SPARSE_DISPLAY, a FORTRAN77 library which can read information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot. This operation is already available in the built-in MATLAB "spy" command.

SPARSE_DISPLAY, a FORTRAN90 library which can read information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot. This operation is already available in the built-in MATLAB "spy" command.

SPARSE_DISPLAY, a MATLAB library which can read information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot. This operation is already available in the built-in MATLAB "spy" command.

SPARSE_GRID, a Python library which contains classes and functions defining sparse grids, by Jochen Garcke.

SPARSE_GRID_CC, a C library which creates sparse grids based on Clenshaw-Curtis rules.

SPARSE_GRID_CC, a C++ library which creates sparse grids based on Clenshaw-Curtis rules.

SPARSE_GRID_CC, a FORTRAN77 library which creates sparse grids based on Clenshaw-Curtis rules.

SPARSE_GRID_CC, a FORTRAN90 library which creates sparse grids based on Clenshaw-Curtis rules.

SPARSE_GRID_CC, a MATLAB library which creates sparse grids based on Clenshaw-Curtis rules.

SPARSE_GRID_CC_DATASET, a C program which creates a sparse grid dataset based on Clenshaw-Curtis rules.

SPARSE_GRID_CC_DATASET, a C++ program which creates a sparse grid dataset based on Clenshaw-Curtis rules.

SPARSE_GRID_CC_DATASET, a FORTRAN77 program which creates a sparse grid dataset based on Clenshaw-Curtis rules.

SPARSE_GRID_CC_DATASET, a FORTRAN90 program which creates a sparse grid dataset based on Clenshaw-Curtis rules.

SPARSE_GRID_CC_DATASET, a MATLAB program which creates a sparse grid dataset based on Clenshaw-Curtis rules.

SPARSE_GRID_CCE, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Clenshaw Curtis Exponential growth rule;

SPARSE_GRID_CCL, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Clenshaw Curtis Linear growth rule;

SPARSE_GRID_CCS, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Clenshaw Curtis Slow growth rule;

SPARSE_GRID_COMPOSITE, a MATLAB library which creates sparse grids based on 1D composite rules (currently only of order 1).

SPARSE_GRID_COMPOSITE, a dataset directory which contains examples of sparse grids based on 1D composite rules (currently only of order 1).

SPARSE_GRID_F2, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Fejer-2 rule;

SPARSE_GRID_F2S, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Fejer-2 Slow growth rule;

SPARSE_GRID_GL, a C++ library which creates sparse grids based on Gauss-Legendre rules.

SPARSE_GRID_GL, a FORTRAN90 library which creates sparse grids based on Gauss-Legendre rules.

SPARSE_GRID_GL, a MATLAB library which creates sparse grids based on Gauss-Legendre rules.

SPARSE_GRID_GL_DATASET, a C++ program which creates a sparse grid dataset based on Gauss-Legendre rules.

SPARSE_GRID_GL_DATASET, a FORTRAN90 program which creates a sparse grid dataset based on Gauss-Legendre rules.

SPARSE_GRID_GL_DATASET, a MATLAB program which creates a sparse grid dataset based on Gauss-Legendre rules.

SPARSE_GRID_GLE, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Legendre Exponential growth rule.

SPARSE_GRID_GLL, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Legendre Linear growth rule.

SPARSE_GRID_GLO, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Legendre Linear (Odd) growth rule.

SPARSE_GRID_GPE, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Patterson Exponential growth rule;

SPARSE_GRID_GPS, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Patterson Slow growth rule;

SPARSE_GRID_HERMITE, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Gauss-Hermite rule;

SPARSE_GRID_HERMITE, a C++ library which creates sparse grids based on Gauss-Hermite rules.

SPARSE_GRID_HERMITE, a FORTRAN90 library which creates sparse grids based on Gauss-Hermite rules.

SPARSE_GRID_HERMITE, a MATLAB library which creates sparse grids based on Gauss-Hermite rules.

SPARSE_GRID_HERMITE_DATASET, a C++ program which creates a sparse grid dataset based on Gauss-Hermite rules.

SPARSE_GRID_HERMITE_DATASET, a FORTRAN90 program which creates a sparse grid dataset based on Gauss-Hermite rules.

SPARSE_GRID_HERMITE_DATASET, a MATLAB program which creates a sparse grid dataset based on Gauss-Hermite rules.

SPARSE_GRID_HW, a C library which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.

SPARSE_GRID_HW, a C++ library which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.

SPARSE_GRID_HW, a FORTRAN77 library which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.

SPARSE_GRID_HW, a FORTRAN90 library which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.

SPARSE_GRID_HW, a MATLAB library which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.

SPARSE_GRID_LAGUERRE, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Gauss-Laguerre rule;

SPARSE_GRID_LAGUERRE, a C++ library which creates sparse grids based on Gauss-Laguerre rules.

SPARSE_GRID_LAGUERRE, a FORTRAN90 library which creates sparse grids based on Gauss-Laguerre rules.

SPARSE_GRID_LAGUERRE, a MATLAB library which creates sparse grids based on Gauss-Laguerre rules.

SPARSE_GRID_LAGUERRE_DATASET, a C++ program which creates a sparse grid dataset based on Gauss-Laguerrre rules.

SPARSE_GRID_LAGUERRE_DATASET, a FORTRAN90 program which creates a sparse grid dataset based on Gauss-Laguerrre rules.

SPARSE_GRID_LAGUERRE_DATASET, a MATLAB program which creates a sparse grid dataset based on Gauss-Laguerrre rules.

SPARSE_GRID_MIXED, a C++ library which creates a sparse grid dataset based on a mixed set of 1D factor rules.

SPARSE_GRID_MIXED, a dataset directory which contains M-dimensional Smolyak sparse grids based on a mixed set of 1D factor rules.

SPARSE_GRID_MIXED, a FORTRAN90 library which creates a sparse grid dataset based on a mixed set of 1D factor rules.

SPARSE_GRID_MIXED, a MATLAB library which creates a sparse grid dataset based on a mixed set of 1D factor rules.

SPARSE_GRID_MIXED_DATASET, a C++ program which creates a sparse grid dataset based on a mixture of 1D rules.

SPARSE_GRID_MIXED_DATASET, a FORTRAN90 program which creates a sparse grid dataset based on a mixture of 1D rules.

SPARSE_GRID_MIXED_DATASET, a MATLAB program which creates a sparse grid dataset based on a mixture of 1D rules.

SPARSE_GRID_NCC, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Newton Cotes Closed rule;

SPARSE_GRID_NCO, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Newton Cotes Open rule;

SPARSE_GRID_OPEN, a C++ library which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).

SPARSE_GRID_OPEN, a FORTRAN90 library which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).

SPARSE_GRID_OPEN, a MATLAB library which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).

SPARSE_GRID_OPEN_DATASET, a C++ program which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).

SPARSE_GRID_OPEN_DATASET, a FORTRAN90 program which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).

SPARSE_GRID_OPEN_DATASET, a MATLAB program which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).

SPARSE_GRID_TOTAL_POLY, a MATLAB library which investigates the efficient approximation of all polynomials up to a given total degree using sparse grids.

SPARSE_INTERP_ND a C library which can be used to define a sparse interpolant to a function f(x) of a M-dimensional argument.

SPARSE_INTERP_ND a C++ library which can be used to define a sparse interpolant to a function f(x) of a M-dimensional argument.

SPARSE_INTERP_ND a FORTRAN77 library which can be used to define a sparse interpolant to a function f(x) of a M-dimensional argument.

SPARSE_INTERP_ND a FORTRAN90 library which can be used to define a sparse interpolant to a function f(x) of a M-dimensional argument.

SPARSE_INTERP_ND a MATLAB library which can be used to define a sparse interpolant to a function f(x) of a M-dimensional argument.

SPARSE_PARFOR a MATLAB library which demonstrates how a sparse matrix can be constructed by evaluating individual blocks in parallel with the parfor command, and then assembled on a single processor using the sparse() command, by Gene Cliff.

SPARSEHASH, examples which illustrate the use of SPARSEHASH, which is one of the most space efficient hash tables available, requiring only two bits of overhead per entry. SPARSEHASH is only two to three times slower than most other C++ hash table libraries, which are far more expensive in space.

SPARSEKIT, a FORTRAN77 library which implements operations on sparse matrices, including conversion between various formats, by Yousef Saad.

SPARSEKIT, a FORTRAN90 library which implements operations on sparse matrices, including conversion between various formats, by Yousef Saad.

SPARSEKIT2, a FORTRAN77 library which implements operations on sparse matrices, including conversion between various formats; this is version 2 of the library, by Yousef Saad.

SPARSEPAK, a FORTRAN77 library which forms an obsolete version of the Waterloo Sparse Matrix Package.

SPARSEPAK, a FORTRAN90 library which forms an obsolete version of the Waterloo Sparse Matrix Package.

SPECFUN, a FORTRAN77 library which evaluates 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, a FORTRAN90 library which computes special functions, including Bessel I, J, K and Y functions, and the Dawson, E1, EI, Erf, Gamma, log Gamma, Psi/Digamma functions, by William Cody and Laura Stoltz;

SPECIAL_FUNCTIONS, a FORTRAN77 library which evaluates special functions, including Airy, Associated Legendre Bessel, Beta, Complete Elliptic Integral, Confluent Hypergeometric, Cosine Integral, Elliptic Integral, Error, Exponential Integral, Fresnel Integral, Gamma, Hankel, Hypergeometric, Incomplete Beta, Incomplete Gamma, Jacobian Elliptic, Kelvin, Lambda, Legendre, Mathieu, Modified Spherical Bessel, Parabolic Cylinder, Psi, Riccati-Bessel, Sine Integral, Spheroidal Wave, Struve, Whittaker, as well as Bernoulli Numbers, Euler Numbers, Hermite Polynomials, Laguerre Polynomials, Legendre Polynomials, by Shanjie Zhang, Jianming Jin;

SPECIAL_FUNCTIONS, a FORTRAN90 library which evaluates special functions, including Airy, Associated Legendre Bessel, Beta, Complete Elliptic Integral, Confluent Hypergeometric, Cosine Integral, Elliptic Integral, Error, Exponential Integral, Fresnel Integral, Gamma, Hankel, Hypergeometric, Incomplete Beta, Incomplete Gamma, Jacobian Elliptic, Kelvin, Lambda, Legendre, Mathieu, Modified Spherical Bessel, Parabolic Cylinder, Psi, Riccati-Bessel, Sine Integral, Spheroidal Wave, Struve, Whittaker, as well as Bernoulli Numbers, Euler Numbers, Hermite Polynomials, Laguerre Polynomials, Legendre Polynomials, by Shanjie Zhang, Jianming Jin;

SPHERE_CUBED_GRID, a FORTRAN90 library which uses the projection of a cube to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_CUBED_GRID, a MATLAB library which uses the projection of a cube to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_CVT, a FORTRAN90 library which uses a Centroidal Voronoi Tessellation to create a mesh of well-separated points on the surface of the unit sphere in 3D.

SPHERE_CVT, a MATLAB library which uses a Centroidal Voronoi Tessellation to create a mesh of well-separated points on the surface of the unit sphere in 3D.

SPHERE_DELAUNAY, a FORTRAN90 program which computes and plots the Delaunay triangulation of points on the surface of the unit sphere in 3D.

SPHERE_DELAUNAY, a MATLAB program which computes the Delaunay triangulation of points on the surface of the unit sphere in 3D.

SPHERE_DESIGN_RULE, a dataset directory which contains files defining point sets on the surface of the unit sphere in 3D, known as designs, which can be useful for estimating integrals on the surface, among other uses.

SPHERE_DESIGN_RULE, a FORTRAN90 library which returns point sets on the surface of the unit sphere in 3D, known as designs, which can be useful for estimating integrals on the surface.

SPHERE_DISTANCE, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected on the unit sphere.

SPHERE_EXACTNESS, a C program which tests the monomial exactness of a quadrature rule over the surface of the unit sphere in 3D.

SPHERE_EXACTNESS, a C++ program which tests the monomial exactness of a quadrature rule over the surface of the unit sphere in 3D.

SPHERE_EXACTNESS, a FORTRAN77 program which tests the monomial exactness of a quadrature rule over the surface of the unit sphere in 3D.

SPHERE_EXACTNESS, a FORTRAN90 program which tests the monomial exactness of a quadrature rule over the surface of the unit sphere in 3D.

SPHERE_EXACTNESS, a MATLAB program which tests the monomial exactness of a quadrature rule over the surface of the unit sphere in 3D.

SPHERE_FIBONACCI_GRID, a C library which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.

SPHERE_FIBONACCI_GRID, a C++ library which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.

SPHERE_FIBONACCI_GRID, a FORTRAN77 library which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.

SPHERE_FIBONACCI_GRID, a FORTRAN90 library which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.

SPHERE_FIBONACCI_GRID, a MATLAB library which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.

SPHERE_FIBONACCI_GRID, a Python library which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.

SPHERE_GRID, a dataset directory which contains grids of points, lines, triangles or quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_GRID, a C library which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.

SPHERE_GRID, a C++ library which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.

SPHERE_GRID, a FORTRAN77 library which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.

SPHERE_GRID, a FORTRAN90 library which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.

SPHERE_GRID, a MATLAB library which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.

SPHERE_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.

SPHERE_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.

SPHERE_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.

SPHERE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.

SPHERE_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.

SPHERE_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.

SPHERE_LEBEDEV_RULE, a dataset directory which contains files defining Lebedev rules of points on the surface of the unit sphere in 3D, which can be used for quadrature rules of a known precision;

SPHERE_LEBEDEV_RULE, a C library which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.

SPHERE_LEBEDEV_RULE, a C++ library which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.

SPHERE_LEBEDEV_RULE, a FORTRAN77 library which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.

SPHERE_LEBEDEV_RULE, a FORTRAN90 library which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.

SPHERE_LEBEDEV_RULE, a MATLAB library which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.

SPHERE_LEBEDEV_RULE_DISPLAY, a MATLAB program which reads a file defining a Lebedev quadrature rule on the surface of the unit sphere in 3D and displays the point locations.

SPHERE_LLQ_GRID, a C library which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_LLQ_GRID, a C++ library which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_LLQ_GRID, a FORTRAN90 library which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_LLQ_GRID, a MATLAB library which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_LLQ_GRID, a Python library which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.

SPHERE_LLT_GRID, a C library which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.

SPHERE_LLT_GRID, a C++ library which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.

SPHERE_LLT_GRID, a FORTRAN90 library which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.

SPHERE_LLT_GRID, a MATLAB library which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.

SPHERE_LLT_GRID, a Python library which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.

SPHERE_MAXIMUM_DETERMINANT, a dataset directory which contains files defining maximum determinant rules on the surface of the unit sphere in 3D, which can be used for interpolation and quadrature;

SPHERE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.

SPHERE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.

SPHERE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;

SPHERE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;

SPHERE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;

SPHERE_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;

SPHERE_QUAD, a C library which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.

SPHERE_QUAD, a C++ library which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.

SPHERE_QUAD, a FORTRAN77 library which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.

SPHERE_QUAD, a FORTRAN90 library which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.

SPHERE_QUAD, a MATLAB library which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.

SPHERE_STEREOGRAPH, a C library which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.

SPHERE_STEREOGRAPH, a C++ library which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.

SPHERE_STEREOGRAPH, a FORTRAN77 library which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.

SPHERE_STEREOGRAPH, a FORTRAN90 library which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.

SPHERE_STEREOGRAPH, a MATLAB library which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available

SPHERE_STEREOGRAPH_DISPLAY, a MATLAB library which computes and displays the results of several stereographic projections between points on the surface of the unit sphere in 3D and a plane.

SPHERE_TRIANGLE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;

SPHERE_TRIANGLE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;

SPHERE_TRIANGLE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;

SPHERE_TRIANGLE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;

SPHERE_TRIANGLE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;

SPHERE_TRIANGLE_QUAD, a C library which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.

SPHERE_TRIANGLE_QUAD, a C++ library which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.

SPHERE_TRIANGLE_QUAD, a FORTRAN77 library which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.

SPHERE_TRIANGLE_QUAD, a FORTRAN90 library which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.

SPHERE_TRIANGLE_QUAD, a MATLAB library which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.

SPHERE_VORONOI, a FORTRAN90 program which computes and plots the Voronoi diagram of points on the surface of the unit sphere in 3D.

SPHERE_VORONOI, a MATLAB program which computes the Voronoi diagram of points on the surface of the unit sphere in 3D.

SPHERE_VORONOI_DISPLAY_OPENGL, a C++ program which displays randomly selected generator points and colors in points on the sphere that are closest to each generator, on the surface of the unit sphere in 3D.

SPHERE_XYZ_DISPLAY, a MATLAB program which reads XYZ information defining points and displays a unit sphere and the points in the MATLAB graphics window, on the surface of the unit sphere in 3D.

SPHERE_XYZ_DISPLAY_OPENGL, a C++ program which reads XYZ information defining points and displays a unit sphere and the points, using OpenGL, on the surface of the unit sphere in 3D.

SPHERE_XYZF_DISPLAY, a MATLAB program which reads XYZF information defining points and faces on the surface of the unit sphere in 3D, and displays a unit sphere, the points, and the faces, in the MATLAB 3D graphics window. This can be used, for instance, to display Voronoi diagrams or Delaunay triangulations on the unit sphere.

SPHERICAL_HARMONIC, a MATLAB library which evaluates spherical harmonic functions.

SPINTERP, a MATLAB library which carries out piecewise multilinear hierarchical sparse grid interpolation, quadrature and optimization, by Andreas Klimke; an earlier version of this software is ACM TOMS Algorithm 847.

SPINTERP_test, MATLAB programs which demonstrate some simple uses of the spinterp program, which uses sparse grids for interpolation, optimization, and quadrature in higher dimensions.

SPIRAL_DATA, a C library which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.

SPIRAL_DATA, a C++ library which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.

SPIRAL_DATA, a FORTRAN77 library which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.

SPIRAL_DATA, a FORTRAN90 library which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.

SPIRAL_DATA, a MATLAB library which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.

SPIRAL_DATA, a Python library which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.

SPLINE, a C library which constructs and evaluates spline interpolants and approximants.

SPLINE, a C++ library which constructs and evaluates spline interpolants and approximants.

SPLINE, a FORTRAN77 library which constructs and evaluates spline interpolants and approximants.

SPLINE, a FORTRAN90 library which constructs and evaluates spline interpolants and approximants.

SPLINE, a MATLAB library which constructs and evaluates spline interpolants and approximants.

SPQUAD, a MATLAB library which computes the points and weights of a sparse grid quadrature rule for an M-dimensional integral, based on the Clenshaw-Curtis quadrature rule, by Greg von Winckel.

SPRAI, examples which illustrate the use of SPRAI, which is a tool to correct sequencing errors in single-pass reads for de novo assembly.

SPREAD, a FORTRAN77 program which reads a SWISS-PROT file and locates tyrosine residues.

SPRING_ODE, a C program which shows how line printer graphics can be used to make a crude illustration of a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE, a C++ program which shows how line printer graphics can be used to make a crude illustration of a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE, a FORTRAN77 program which shows how line printer graphics can be used to make a crude illustration of a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE, a FORTRAN90 program which shows how line printer graphics can be used to make a crude illustration of a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE, a MATLAB program which shows how line printer graphics can be used to make a crude illustration of a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE2, a C program which shows how gnuplot graphics can be used to illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE2, a C++ program which shows how gnuplot graphics can be used to illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE2, a FORTRAN77 program which shows how gnuplot graphics can be used to illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE2, a FORTRAN90 program which shows how gnuplot graphics can be used to illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SPRING_ODE2, a MATLAB program which shows how gnuplot graphics can be used to illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.

SQUARE_ARBQ_RULE, a C library which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_ARBQ_RULE, a C++ library which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_ARBQ_RULE, a FORTRAN77 library which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_ARBQ_RULE, a FORTRAN90 library which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_ARBQ_RULE, a MATLAB library which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

square_distance, a MATLAB library which considers the problem of describing the typical value of the distance between a pair of points randomly selected in the unit square.

SQUARE_EXACTNESS, a C library which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a square (rectangle/quadrilateral) in 2D.

SQUARE_EXACTNESS, a C++ library which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a square (rectangle/quadrilateral) in 2D.

SQUARE_EXACTNESS, a FORTRAN77 library which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a square (rectangle/quadrilateral) in 2D.

SQUARE_EXACTNESS, a FORTRAN90 library which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a square (rectangle/quadrilateral) in 2D.

SQUARE_EXACTNESS, a MATLAB library which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a square (rectangle/quadrilateral) in 2D.

SQUARE_FELIPPA_RULE, a C library which returns the points and weights of a Felippa quadrature rule over the interior of a square in 2D.

SQUARE_FELIPPA_RULE, a C++ library which returns the points and weights of a Felippa quadrature rule over the interior of a square in 2D.

SQUARE_FELIPPA_RULE, a FORTRAN77 library which returns the points and weights of a Felippa quadrature rule over the interior of a square in 2D.

SQUARE_FELIPPA_RULE, a FORTRAN90 library which returns the points and weights of a Felippa quadrature rule over the interior of a square in 2D.

SQUARE_FELIPPA_RULE, a MATLAB library which returns the points and weights of a Felippa quadrature rule over the interior of a square in 2D.

SQUARE_GRID, a C library which computes a grid of points over the interior of a square in 2D.

SQUARE_GRID, a C++ library which computes a grid of points over the interior of a square in 2D.

SQUARE_GRID, a FORTRAN77 library which computes a grid of points over the interior of a square in 2D.

SQUARE_GRID, a FORTRAN90 library which computes a grid of points over the interior of a square in 2D.

SQUARE_GRID, a MATLAB library which computes a grid of points over the interior of a square in 2D.

SQUARE_GRID, a Python library which computes a grid of points over the interior of a square in 2D.

SQUARE_HEX_GRID, a dataset directory which contains datasets of hexagaonal grid of points over the interior of a square in 2D.

SQUARE_HEX_GRID, a C++ library which computes a hexagonal grid of points over the interior of a square in 2D.

SQUARE_HEX_GRID, a FORTRAN90 library which computes a hexagonal grid of points over the interior of a square in 2D.

SQUARE_HEX_GRID, a MATLAB library which computes a hexagonal grid of points over the interior of a square in 2D.

SQUARE_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.

SQUARE_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.

SQUARE_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit square in 2D.

SQUARE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.

SQUARE_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.

SQUARE_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.

SQUARE_MINIMAL_RULE, a C library which returns "almost minimal" quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.

SQUARE_MINIMAL_RULE, a C++ library which returns "almost minimal" quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.

SQUARE_MINIMAL_RULE, a FORTRAN90 library which returns "almost minimal" quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.

SQUARE_MINIMAL_RULE, a MATLAB library which returns "almost minimal" quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.

SQUARE_MINIMAL_RULE, a Python library which returns "almost minimal" quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.

SQUARE_MONTE_CARLO, a C library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.

SQUARE_MONTE_CARLO, a C++ library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.

SQUARE_MONTE_CARLO, a FORTRAN77 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;

SQUARE_MONTE_CARLO, a FORTRAN90 library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;

SQUARE_MONTE_CARLO, a MATLAB library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;

SQUARE_MONTE_CARLO, a Python library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;

SQUARE_SYMQ_RULE, a C library which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_SYMQ_RULE, a C++ library which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_SYMQ_RULE, a FORTRAN77 library which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_SYMQ_RULE, a FORTRAN90 library which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

SQUARE_SYMQ_RULE, a MATLAB library which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.

ST, a data directory which contains examples of the Sparse Triplet (ST) format, a sparse matrix file format, storing just (I,J,A(I,J)), and using zero-based indexing.

ST_IO, a C library which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.

ST_IO, a C++ library which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.

ST_IO, a FORTRAN77 library which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.

ST_IO, a FORTRAN90 library which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.

ST_IO, a MATLAB library which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.

ST_IO, a Python library which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.

ST_TO_CC, a C library which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column (CC) format.

ST_TO_CC, a C++ library which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column (CC) format.

ST_TO_CC, a FORTRAN77 library which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column (CC) format.

ST_TO_CC, a FORTRAN90 library which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column (CC) format.

ST_TO_CC, a MATLAB library which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column (CC) format.

ST_TO_HB, a FORTRAN90 program which converts a sparse matrix file from Sparse Triplet (ST) format to Harwell Boeing (HB) format;

ST_TO_HB, a MATLAB program which converts a sparse matrix file from Sparse Triplet (ST) format to Harwell Boeing (HB) format;

ST_TO_MM, a MATLAB program which converts a sparse matrix file from Sparse Triplet (ST) format to Matrix Market (MM) format;

ST_TO_MSM, a MATLAB program which reads a Sparse Triplet (ST) file and creates a corresponding MATLAB Sparse Matrix.

STAR_DISCREPANCY, a C program which reads a file of N points in M dimensions, (presumed to lie in the unit hypercube) and computes bounds on the star discrepancy, a measure of dispersion, by Eric Thiemard.

STAR_DISCREPANCY, a C++ program which reads a table file of N points in M dimensions (presumed to lie in the unit hypercube) and computes bounds on the star discrepancy, a measure of dispersion, by Eric Thiemard.

STATA, examples which illustrate the use of STATA, which is an interactive statistical package that enables a user to read in datasets, apply a variety of built-in statistical analysis tools, or user-written algorithms, and to create tables and graphs of publication quality.

STATES, a dataset directory which contains some information about the individual American states.

STATS, a dataset directory which contains datasets for computational statistics, including biometric measurements, movie attendance and sales, taxicab fares and distances;

STEAM, a FORTRAN90 library which is based on the National Bureau of Standards (NBS) steam table package;

STEAM_INTERACT, a FORTRAN90 program which queries the National Bureau of Standards (NBS) steam table package;

STEAM_NBS, a FORTRAN77 library which is based on the National Bureau of Standards (NBS) steam table package;

STEAM_NBS_INTERACT, a FORTRAN77 program which queries the National Bureau of Standards (NBS) steam table package;

step1, a FENICS script which solves a Poisson equation with constant diffusivity kappa(x,y).

step2, a FENICS script which solves a Poisson equation with piecewise constant diffusivity kappa(x,y).

step3, a FENICS script which solves a Poisson equation with piecewise constant diffusivity kappa(x,y), and computes and plots |grad(u)|.

step4, a FENICS script which shows how to generate the right hand side of a Poisson problem, using the symbolic mathematics package and an exact solution formula.

step5, a FENICS script which solves a Poisson equation whose diffusivity kappa(x,y) is defined as |grad(w)| for a given scalar field w(x,y).

step6, a FENICS script which solves the nonlinear p-Laplacian problem directly.

step7, a FENICS script which compares error norm and DPG error indicators for a Poisson problem.

step8, a FENICS script which uses DPG error indicators for adaptive mesh refinement.

step9, a FENICS script which uses the Discontinuous Petrov Galerkin (DPG) method to solve a Poisson problem, and repeatedly refines the mesh, guided by DPG error indicators. On each refinement step, the top fifty percent of the cells are refined, as ordered by size of local error estimates. It then plots the decay of the estimated error as a function of the number of mesh elements.

step10, a FENICS script which uses the Discontinuous Petrov Galerkin (DPG) method to solve a Poisson problem, and repeatedly refines the mesh, guided by DPG error indicators. On each refinement step, cells are ordered by size of the local error estimates, and then enough "top" cells are refined to represent the proportion THETA of the total error estimate. It then plots the decay of the estimated error as a function of the number of mesh elements.

step11, a FENICS script which uses the Discontinuous Petrov Galerkin (DPG) method to solve a Poisson problem, and repeatedly refines the mesh, guided by DPG error indicators. Two methods of adaptive refinement are compared, one of which refines cells which represent a fixed percentage of the error (case 0), and one of which refines a fixed percentage of the cells (case1). The problem uses a discontinuous diffusivity function kappa(x,y).

stla, a data directory which contains examples of ASCII stereolithography (STL) files for 3D graphics;

STLA_DISPLAY, a MATLAB program which reads an ASCII stereolithography (STL) file and displays it on the screen.

STLA_IO, a C++ library which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;

STLA_IO, a FORTRAN90 library which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;

STLA_IO, a MATLAB library which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;

STLA_TO_TRI_SURFACE, a MATLAB program which reads an ASCII stereolithography (STL) file and extracts the surface mesh data as a tri_surface dataset.

STLA_TO_TRI_SURFACE_FAST, a MATLAB program which a faster version of stla_to_tri_surface.

STLB, a data directory which contains examples of binary stereolithography (STL) files, 3D graphics;

STOCHASTIC_DIFFUSION, a C library which implements several versions of a stochastic diffusivity coefficient, and displays sample results using gnuplot.

STOCHASTIC_DIFFUSION, a C++ library which implements several versions of a stochastic diffusivity coefficient, and displays sample results using gnuplot.

STOCHASTIC_DIFFUSION, a FORTRAN77 library which implements several versions of a stochastic diffusivity coefficient, and displays sample results using gnuplot.

STOCHASTIC_DIFFUSION, a FORTRAN90 library which implements several versions of a stochastic diffusivity coefficient, and displays sample results using gnuplot.

STOCHASTIC_DIFFUSION, MATLAB functions which implement several versions of a stochastic diffusivity coefficient.

STOCHASTIC_GRADIENT_ND_NOISE, a MATLAB program which solves an optimal control problem involving a functional over a system with stochastic noise, by Jeff Borggaard, Catalin Trenchea, Clayton Webster.

STOCHASTIC_HEAT2D, a C program which implements a finite difference method (FDM) for the steady 2D heat equation with a stochastic heat diffusivity coefficient, using gnuplot to illustrate the results.

STOCHASTIC_HEAT2D, a C++ program which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient, using gnuplot to illustrate the results.

STOCHASTIC_HEAT2D, a FORTRAN77 program which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient, using gnuplot to illustrate the results.

STOCHASTIC_HEAT2D, a FORTRAN90 program which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient, using gnuplot to illustrate the results.

STOCHASTIC_HEAT2D, a MATLAB program which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.

STOCHASTIC_RK, a C library which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SODE).

STOCHASTIC_RK, a C++ library which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SODE).

STOCHASTIC_RK, a FORTRAN77 library which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SODE).

STOCHASTIC_RK, a FORTRAN90 library which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SODE).

STOCHASTIC_RK, a MATLAB library which applies a Runge Kutta (RK) scheme to a stochastic ordinary differential equation (SODE).

STOKES_2D_EXACT, a C library which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.

STOKES_2D_EXACT, a C++ library which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.

STOKES_2D_EXACT, a FORTRAN77 library which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.

STOKES_2D_EXACT, a FORTRAN90 library which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.

STOKES_2D_EXACT, a MATLAB library which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.

STOKES_2D_EXACT, a Python library which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.

STRING_SIMULATION, a C program which simulates the behavior of a vibrating string by solving the corresponding initial boundary value problem (IBVP), creating files that can be displayed by gnuplot.

STRING_SIMULATION, a C++ program which simulates the behavior of a vibrating string by solving the corresponding initial boundary value problem (IBVP), creating files that can be displayed by gnuplot.

STRING_SIMULATION, a FORTRAN77 program which simulates the behavior of a vibrating string, creating files that can be displayed by gnuplot.

STRING_SIMULATION, a FORTRAN90 program which simulates the behavior of a vibrating string by solving the corresponding initial boundary value problem (IBVP), creating files that can be displayed by gnuplot.

STRING_SIMULATION, a MATLAB program which simulates the behavior of a vibrating string by solving the corresponding initial boundary value problem (IBVP), creating files that can be displayed by gnuplot.

STRIPACK, a FORTRAN90 library which computes the Delaunay triangulation or Voronoi diagram of points on a unit sphere, by Robert Renka.

STRIPACK_BENCH, a FORTRAN90 program which benchmarks the Delaunay triangulation calculation of STRIPACK by timing computations involving random sets of nodes of increasing size.

STRIPACK_DELAUNAY, a FORTRAN90 program which reads a set of points on the unit sphere, calls stripack() to compute the Delaunay triangulation, and writes it to a file.

STRIPACK_VORONOI, a FORTRAN90 program which reads a set of points on the unit sphere, computes the Voronoi diagram, and writes it to a file.

STRIPPER, a FORTRAN90 program which performs a variety of file modifications (capitalization, remove control characters, and so on);

STROUD, a C library which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.

STROUD, a C++ library which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.

STROUD, a FORTRAN77 library which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.

STROUD, a FORTRAN90 library which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.

STROUD, a MATLAB library which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.

STRUVEH, a MATHEMATICA library which evaluates the Struve H function.

SUBANAGRAM, a FORTRAN90 program which finds words which are anagrams formed from some of the letters of a given master word.

SUBPAK, a C library which contains many utility routines;

SUBPAK, a C++ library which contains many utility routines;

SUBPAK, a FORTRAN77 library which contains many utility routines;

SUBPAK, a FORTRAN90 library which contains many utility routines;

SUBPAK, a MATLAB library which contains many utility routines;

SUBSET, a C library which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Some routines for continued fractions are included.

SUBSET, a C++ library which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Some routines for continued fractions are included.

SUBSET, a FORTRAN77 library which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Some routines for continued fractions are included.

SUBSET, a FORTRAN90 library which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Some routines for continued fractions are included.

SUBSET, a MATLAB library which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Some routines for continued fractions are included.

SUBSET, a Python library which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Some routines for continued fractions are included.

SUBSET_SUM, a C library which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum.

SUBSET_SUM, a C++ library which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum.

SUBSET_SUM, a FORTRAN77 library which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum.

SUBSET_SUM, a FORTRAN90 library which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum.

SUBSET_SUM, a MATLAB library which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum.

SUBSET_SUM, a Python library which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum.

SUBSET_SUM, a dataset directory which contains examples of the subset sum problem, in which a set of numbers is given, and it is desired to find at least one subset that sums to a given target value.

SUBSET_SUM_SERIAL, a C program which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum; this version of the program is intended as a starting point for a parallel approach.

SUBSET_SUM_SERIAL, a C++ program which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum; this version of the program is intended as a starting point for a parallel approach.

SUBSET_SUM_SERIAL, a FORTRAN77 program which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum; this version of the program is intended as a starting point for a parallel approach.

SUBSET_SUM_SERIAL, a FORTRAN90 program which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum; this version of the program is intended as a starting point for a parallel approach.

SUBSET_SUM_SERIAL, a MATLAB program which seeks solutions of the subset sum problem, in which it is desired to find a subset of a set of integers which has a given sum; this version of the program is intended as a starting point for a parallel approach.

SUBSET_SUM_TASKS, a MATLAB program which solves a subset sum problem by exhaustive search, using parallel programming to subdividing the search range among separate tasks.

SUDOKU, a MATLAB library which handles Sudoku puzzles;

SUPER_BLAS, a C library which implements some of the Basic Linear Algebra Subprograms (BLAS) for fast execution.

superlu_test, C programs which illustrate how to use the SUPERLU library, which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

superlu_test, C++ programs which illustrate how a C++ program can call the SUPERLU library, which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

SUPERLU, FORTRAN77 programs which illustrate how a FORTRAN77 program can call the SUPERLU library, (which is written in C), which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

superlu_test, FORTRAN90 programs which illustrate how a FORTRAN90 program can call the SUPERLU library, (which is written in C), which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

superlu_test, MATLAB programs which illustrate how to use the SUPERLU library, which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

SUPERLU_OPENMP, C programs which illustrate how to use the SUPERLU library with the OpenMP parallel programming interface, which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

SUPERLU_OPENMP, C++ programs which illustrate how to use the SUPERLU library with the OpenMP parallel programming interface, which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

SUPERLU_OPENMP, FORTRAN77 programs which illustrate how to use the SUPERLU library with the OpenMP parallel programming interface, which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

SUPERLU_OPENMP, FORTRAN90 programs which illustrate how to use the SUPERLU library with the OpenMP parallel programming interface, which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.

SVD_BASIS, a C++ program which applies the Singular Value Decomposition (SVD) to a set of vectors, extracting dominant modes;

SVD_BASIS, a FORTRAN90 program which applies the Singular Value Decomposition (SVD) to a collection of data vectors, extracting dominant modes;

SVD_BASIS, a MATLAB program which applies the Singular Value Decomposition (SVD) to a collection of data vectors, extracting dominant modes;

SVD_BASIS_WEIGHT, a FORTRAN90 program which is similar to SVD_BASIS, but which allows the user to assign weights to each data vector.

SVD_DEMO, a C program which demonstrates the Singular Value Decomposition (SVD) for a simple example.

SVD_DEMO, a C++ program which demonstrates the Singular Value Decomposition (SVD) for a simple example.

SVD_DEMO, a FORTRAN77 program which demonstrates the Singular Value Decomposition (SVD) for a simple example.

SVD_DEMO, a FORTRAN90 program which demonstrates the Singular Value Decomposition (SVD) for a simple example.

SVD_DEMO, a MATLAB program which demonstrates the Singular Value Decomposition (SVD) for a simple example.

SVD_FINGERPRINT, a MATLAB program which reads a file containing a fingerprint image and uses the Singular Value Decomposition (SVD) to compute and display a series of low rank approximations to the image.

SVD_GRAY, a MATLAB program which reads a gray scale image, computes the Singular Value Decomposition (SVD), and constructs a series of low rank approximations to the image.

SVD_SNOWFALL, a C library which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD), and plots created by gnuplot.

SVD_SNOWFALL, a C++ library which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD), and plots created by gnuplot.

SVD_SNOWFALL, a FORTRAN77 library which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD), and plots created by gnuplot.

SVD_SNOWFALL, a FORTRAN90 library which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD), and plots created by gnuplot.

SVD_SNOWFALL, a MATLAB library which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).

SVD_SNOWFALL, a Python library which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).

SVD_TRUNCATED, a C program which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.

SVD_TRUNCATED, a C++ program which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.

SVD_TRUNCATED, a FORTRAN77 program which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.

SVD_TRUNCATED, a FORTRAN90 program which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.

SVD_TRUNCATED, a MATLAB program which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.

SVDPACK, a dataset directory which contains matrices in Harwell-Boeing format, used for testing the singular value decomposition library svdpack();

SVG, a data directory which contains examples of Scalable Vector Graphics (SVG) files, 2D graphics, that can be included in an HTML file;

SWEEP2, a C program which computes Voronoi Diagrams or Delaunay triangulations, by Steve Fortune;

SWEEP2_DELAUNAY_EPS, a FORTRAN90 program which makes an Encapsulated PostScript (EPS) plot from the Delaunay triangulation information that is output by sweep2;

SWEEP2_VORONOI_EPS, a FORTRAN90 program which makes an Encapsulated PostScript (EPS) plot of the Voronoi diagram information that is output by sweep2;

SWIG, examples which illustrate the use of SWIG, which is a tool that enables C and C++ functions to be called from other languages.

SYMBOLS, a dataset directory which contains large images of numbers and symbols.

SZIP, examples which illustrate the use of SZIP, which is an implementation of the extended-Rice lossless compression algorithm, which has been integrated into the HDF4 and HDF5 hierarchical data file standard.

TABLE_COLUMNS, a FORTRAN90 program which reads a table file of N points in M dimensions and creates a new file by copying various columns, with repetition and shuffling;

TABLE_COLUMNS_PERMUTE, a FORTRAN90 program which reads a table file where each line has the same number of values, and permutes the columns according to the user's prescription;

TABLE_DELAUNAY, a C++ program which reads a file of point coordinates in the table format and writes out the Delaunay triangulation.

TABLE_DELAUNAY, a FORTRAN90 program which reads a file of point coordinates in the table format and writes out the Delaunay triangulation.

TABLE_DELAUNAY, a MATLAB program which reads a file of point coordinates in the table format and writes out the Delaunay triangulation.

TABLE_GRAPH_CODE, a FORTRAN90 program which reads a table file representing the adjacency matrix of a graph, and computes the graph code.

TABLE_HISTOGRAM, a FORTRAN90 program which reads a table file and histograms each column.

TABLE_IO, a C library which reads and writes table files.

TABLE_IO, a C++ library which reads and writes table files.

TABLE_IO, a FORTRAN77 library which reads and writes table files.

TABLE_IO, a FORTRAN90 library which reads and writes table files.

TABLE_IO, a MATLAB library which reads and writes table files.

TABLE_LATINIZE, a C++ program which reads a table file of N points in M dimensions, adjusts to form a Latin hypercube;

TABLE_LATINIZE, a FORTRAN90 program which reads a table file of N points in M dimensions, adjusts to form a Latin hypercube;

TABLE_LATINIZE, a MATLAB program which reads a table file of N points in M dimensions, adjusts to form a Latin hypercube;

TABLE_QUALITY, a C++ program which measures the dispersion quality of points in a dataset read from a file.

TABLE_QUALITY, a FORTRAN90 program which measures the dispersion quality of points in a dataset read from a file.

TABLE_QUALITY, a MATLAB program which measures the dispersion quality of points in a dataset read from a file.

TABLE_READ, a MATLAB program which reads a table file containing comment lines beginning with a hash mark, and a matrix of data, one row per line;

TABLE_TET_MESH, a FORTRAN90 program which reads a table file of N points in 3 dimensions and produces a tet mesh;

TABLE_TOP, a FORTRAN90 program which is given a table file of M-dimensional points, makes plots of all coordinate pairs;

TABLE_VORONOI, a C++ program which reads a set of 2D points from a table file and prints information about the Voronoi diagram;

TABLE_VORONOI, a FORTRAN90 program which reads a table file of N points in 2 dimensions, calls geompack to get Delaunay triangulation information, and then determines and prints the Voronoi diagram information;

TASK_DIVISION, a C library which implements a simple procedure for smoothly dividing T tasks among P processors; such a method can be useful in MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors can be indexed starting from 0 or from 1.

TASK_DIVISION, a C++ library which implements a simple procedure for smoothly dividing T tasks among P processors; such a method can be useful in MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors can be indexed starting from 0 or from 1.

TASK_DIVISION, a FORTRAN77 library which implements a simple procedure for smoothly dividing T tasks among P processors; such a method can be useful in MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors can be indexed starting from 0 or from 1.

TASK_DIVISION, a FORTRAN90 library which implements a simple procedure for smoothly dividing T tasks among P processors; such a method can be useful in MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors can be indexed starting from 0 or from 1.

TASK_DIVISION, a MATLAB library which implements a simple procedure for smoothly dividing T tasks among P processors; such a method can be useful in MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors can be indexed starting from 0 or from 1.

TBB, examples which illustrate the use of TBB, which is the Intel Threading Building Blocks library for C++.

TCELL, a FORTRAN77 program which solves the time-dependent Navier Stokes equations (NSE) for fluid flow in a 2D T-shaped region.

TCELL, a MATLAB program which solves the time-dependent Navier Stokes equations (NSE) for fluid flow in a 2D T-shaped region.

TCELL_FLOW, a dataset directory which contains 500 time steps of flow governed by the Navier-Stokes Equations (NSE) in a 2D T-shaped region.

TCELL_FLOW_DISPLAY, a MATLAB library which displays a single velocity field solution for the T cell;

TCELL_FLOW_MOVIE, a MATLAB library which creates an animation of the velocity solutions for the T cell;

TCELL_FLOW_MOVIE, an MP4 animation which displays the time evolution of the T-Cell flow.

TCELL_MASS, a FORTRAN77 program which computes the mass matrix for the T-Cell problem, which is needed in order to for TCELL_ROM to run the reduced order model (ROM) of the problem.

TCELL_ROM, a MATLAB program which solves a reduced order model (ROM) of a finite element method (FEM) solution of the Navier Stokes equations (NSE) in a T Cell flow region;

TEC, a data directory which contains examples of tecplot ASCII files, used for storing 2D or 3D graphics with attributes;

TEC_IO, a FORTRAN90 library which reads or writes a tecplot ASCII file containing a model associated with the finite element method (FEM).

TEC_IO, a MATLAB library which reads or writes a tecplot ASCII file containing a model associated with the finite element method (FEM).

TEC_TO_FEM, a FORTRAN90 program which converts a tecplot ASCII file into an FEM model.

TEC_TO_FEM, a MATLAB program which converts a tecplot ASCII file into an FEM model.

TEC_TO_OBJ, a FORTRAN90 program which reads a tecplot ASCII file of finite element information and writes an equivalent Alias OBJ file;

TEC_TO_OBJ2, a FORTRAN90 program which reads a tecplot ASCII file of information associated with a model for the finite element method (FEM), and writes an equivalent Alias OBJ file; This is a minor revision of tec_to_obj, which tries to handle multiple zones.

TEC_TO_VTK, a MATLAB program which reads a particular tecplot ASCII file containing 80 frames of the movement of a red blood cell, and creates 80 separate VTK unstructured grid files, which can then be read by the paraview interactive visualization program and animated.

TECPLOT, examples which illustrate the use of TECPLOT, which is an interactive program for scientific illustration, animation and visualization.

TEMPLATED, a FORTRAN77 library which carries out simple versions of various iterative solvers. This is the double precision version.

TEMPLATES, a FORTRAN77 library which carries out simple versions of various iterative solvers. This is the single precision version.

TEMPLATES, a FORTRAN90 library which carries out simple versions of various iterative solvers.

TEMPLATES, a MATLAB library which carries out simple versions of various iterative solvers.

TENSOR_GRID_DISPLAY, a MATLAB program which can display the grid points of a tensor product rule used for interpolation or quadrature, in 1D, 2D or 3D.

TEST_APPROX, a C library which defines test problems for approximation, provided as a set of (x,y) data.

TEST_APPROX, a C++ library which defines test problems for approximation, provided as a set of (x,y) data.

TEST_APPROX, a FORTRAN77 library which defines test problems for approximation, provided as a set of (x,y) data.

TEST_APPROX, a FORTRAN90 library which defines test problems for approximation, provided as a set of (x,y) data.

TEST_APPROX, a MATLAB library which defines test problems for approximation, provided as a set of (x,y) data.

TEST_APPROX, a dataset directory which contains sets of data (x,y) for which an approximating formula is desired.

TEST_CON, a dataset directory which contains sequences of points that lie on M-dimensional curves defined by sets of nonlinear equations;

TEST_CON, a FORTRAN77 library which implements test problems for numerical continuation.

TEST_CON, a FORTRAN90 library which implements test problems for numerical continuation.

TEST_CON, a MATLAB library which implements test problems for numerical continuation.

TEST_EIGEN, a C library which implements test matrices for eigenvalue analysis.

TEST_EIGEN, a C++ library which implements test matrices for eigenvalue analysis.

TEST_EIGEN, a FORTRAN77 library which implements test matrices for eigenvalue analysis.

TEST_EIGEN, a FORTRAN90 library which implements test matrices for eigenvalue analysis.

TEST_EIGEN, a MATLAB library which implements test matrices for eigenvalue analysis.

TEST_EIGEN, a Python library which implements test matrices for eigenvalue analysis.

TEST_INT, a C library which defines test integrands for 1D quadrature rules.

TEST_INT, a C++ library which defines test integrands for 1D quadrature rules.

TEST_INT, a FORTRAN77 library which defines test integrands for 1D quadrature rules.

TEST_INT, a FORTRAN90 library which defines test integrands for 1D quadrature rules.

TEST_INT, a MATLAB library which defines test integrands for 1D quadrature rules.

TEST_INT_2D, a C library which defines test integrands f(x,y) for 2D quadrature rules.

TEST_INT_2D, a C++ library which defines test integrands f(x,y) for 2D quadrature rules.

TEST_INT_2D, a FORTRAN77 library which defines test integrands f(x,y) for 2D quadrature rules.

TEST_INT_2D, a FORTRAN90 library which defines test integrands f(x,y) for 2D quadrature rules.

TEST_INT_2D, a MATLAB library which defines test integrands f(x,y) for 2D quadrature rules.

TEST_INT_MARGIN, a MATLAB library which implements test functions for the task of locating the region for which margin <= f(x), and estimating an integral over that region.

TEST_INTERP, a C library which defines a number of test problems for interpolation, provided as a set of (x,y) data.

TEST_INTERP, a C++ library which defines a number of test problems for interpolation, provided as a set of (x,y) data.

TEST_INTERP, a FORTRAN77 library which defines a number of test problems for interpolation, provided as a set of (x,y) data.

TEST_INTERP, a FORTRAN90 library which defines a number of test problems for interpolation, provided as a set of (x,y) data.

TEST_INTERP, a MATLAB library which defines a number of test problems for interpolation, provided as a set of (x,y) data.

TEST_INTERP, a Python library which defines a number of test problems for interpolation, provided as a set of (x,y) data.

TEST_INTERP_1D, a C library which defines test problems for interpolation of data y(x), depending on a 1D argument.

TEST_INTERP_1D, a C++ library which defines test problems for interpolation of data y(x), depending on a 1D argument.

TEST_INTERP_1D, a FORTRAN77 library which defines test problems for interpolation of data y(x), depending on a 1D argument.

TEST_INTERP_1D, a FORTRAN90 library which defines test problems for interpolation of data y(x), depending on a 1D argument.

TEST_INTERP_1D, a MATLAB library which defines test problems for interpolation of data y(x), depending on a 1D argument.

TEST_INTERP_1D, a Python library which defines test problems for interpolation of data y(x), depending on a 1D argument.

TEST_INTERP_2D, a C library which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.

TEST_INTERP_2D, a C++ library which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.

TEST_INTERP_2D, a FORTRAN77 library which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.

TEST_INTERP_2D, a FORTRAN90 library which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.

TEST_INTERP_2D, a MATLAB library which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.

TEST_INTERP_2D, a Python library which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.

TEST_INTERP_4D, a FORTRAN90 library which defines test problems for interpolation of data u(w,x,y,z), depending on a 4D argument.

TEST_INTERP_ND, a C library which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.

TEST_INTERP_ND, a C++ library which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.

TEST_INTERP_ND, a FORTRAN77 library which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.

TEST_INTERP_ND, a FORTRAN90 library which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.

TEST_INTERP_ND, a MATLAB library which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.

TEST_LLS, a C library which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the rectangular linear system A*x=b.

TEST_LLS, a C++ library which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the rectangular linear system A*x=b.

TEST_LLS, a FORTRAN77 library which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the rectangular linear system A*x=b.

TEST_LLS, a FORTRAN90 library which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the rectangular linear system A*x=b.

TEST_LLS, a MATLAB library which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the rectangular linear system A*x=b.

TEST_LLS, a Python library which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the rectangular linear system A*x=b.

TEST_MAT, a C library which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde and Wathen matrix.

TEST_MAT, a C++ library which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde and Wathen matrix.

TEST_MAT, a FORTRAN77 library which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde and Wathen matrix.

TEST_MAT, a FORTRAN90 library which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde and Wathen matrix.

TEST_MAT, a MATLAB library which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde and Wathen matrix.

TEST_MAT, a Python library which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde and Wathen matrix.

TEST_MATRIX, a MATLAB library which contains a collection of test matrices by Nick Higham.

TEST_MATRIX_EXPONENTIAL, a C library which defines a set of test cases for computing the matrix exponential.

TEST_MATRIX_EXPONENTIAL, a C++ library which defines a set of test cases for computing the matrix exponential.

TEST_MATRIX_EXPONENTIAL, a FORTRAN77 library which defines a set of test cases for computing the matrix exponential.

TEST_MATRIX_EXPONENTIAL, a FORTRAN90 library which defines a set of test cases for computing the matrix exponential.

TEST_MATRIX_EXPONENTIAL, a MATLAB library which defines a set of test cases for computing the matrix exponential.

TEST_MATRIX_EXPONENTIAL, a Python library which defines a set of test cases for computing the matrix exponential.

TEST_MESH, a FORTRAN90 library which defines a few test meshes.

TEST_MIN, a C library which implements test problems for minimization of a scalar function of a scalar variable.

TEST_MIN, a C++ library which implements test problems for minimization of a scalar function of a scalar variable.

TEST_MIN, a FORTRAN77 library which implements test problems for minimization of a scalar function of a scalar variable.

TEST_MIN, a FORTRAN90 library which implements test problems for minimization of a scalar function of a scalar variable.

TEST_MIN, a MATLAB library which implements test problems for minimization of a scalar function of a scalar variable.

TEST_MIN, a Python library which implements test problems for minimization of a scalar function of a scalar variable.

TEST_NEAREST, a C program which tests the time complexity of various procedures for solving the nearest neighbor problem.

TEST_NEAREST, a C++ program which tests the time complexity of various procedures for solving the nearest neighbor problem.

TEST_NEAREST, a FORTRAN77 program which tests the time complexity of various procedures for solving the nearest neighbor problem.

TEST_NEAREST, a FORTRAN90 program which tests the time complexity of various procedures for solving the nearest neighbor problem.

TEST_NEAREST, a MATLAB program which tests the time complexity of various procedures for solving the nearest neighbor problem.

TEST_NINT, a C++ library which defines test functions for M-dimensional quadrature routines.

TEST_NINT, a FORTRAN90 library which defines test functions for M-dimensional quadrature routines.

TEST_NINT, a MATLAB library which defines test functions for M-dimensional quadrature routines.

TEST_NLS, a FORTRAN90 library which implements nonlinear least squares (NLS) test problems.

TEST_NONLIN, a FORTRAN77 library which implements test problems for the solution of systems of nonlinear equations.

TEST_NONLIN, a FORTRAN90 library which implements test problems for the solution of systems of nonlinear equations.

TEST_ODE, a FORTRAN90 library which defines ordinary differential equations (ODE) test problems.

TEST_ODE, a MATLAB library which defines ordinary differential equations (ODE) test problems.

TEST_OPT, a FORTRAN90 library which defines test problems for the minimization of a scalar function of several variables.

TEST_OPT, a MATLAB library which defines test problems for the minimization of a scalar function of several variables.

TEST_OPT_CON, a C library which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.

TEST_OPT_CON, a C++ library which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.

TEST_OPT_CON, a FORTRAN77 library which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.

TEST_OPT_CON, a FORTRAN90 library which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.

TEST_OPT_CON, a MATLAB library which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.

TEST_OPTIMIZATION, a C++ library which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.

TEST_OPTIMIZATION, a FORTRAN77 library which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.

TEST_OPTIMIZATION, a FORTRAN90 library which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.

TEST_OPTIMIZATION, a MATLAB library which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.

TEST_OPTIMIZATION, a Python library which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.

TEST_PARTIAL_DIGEST, a C library which can generate example cases of the partial digest problem.

TEST_PARTIAL_DIGEST, a C++ library which can generate example cases of the partial digest problem.

TEST_PARTIAL_DIGEST, a FORTRAN90 library which can generate example cases of the partial digest problem.

TEST_PARTIAL_DIGEST, a MATLAB library which can generate example cases of the partial digest problem.

TEST_PARTIAL_DIGEST, a Python library which can generate example cases of the partial digest problem.

TEST_TET_MESH, a FORTRAN90 library which implements test problems for tetrahedralization or meshing of arbitrary regions in 3 dimensions.

TEST_TRIANGLE_INTEGRALS, a MATLAB library which defines tests involving the integration of an integrand function over some specific triangle, not necessarily the unit triangle.

TEST_TRIANGULATION, a FORTRAN90 library which defines a number of test regions to be triangulated.

TEST_TRIANGULATION, a MATLAB library which defines a number of test regions to be triangulated.

TEST_VALUES, a C library which supplies test values of various mathematical functions.

TEST_VALUES, a C++ library which supplies test values of various mathematical functions.

TEST_VALUES, a FORTRAN77 library which supplies test values of various mathematical functions.

TEST_VALUES, a FORTRAN90 library which supplies test values of various mathematical functions.

TEST_VALUES, a MATHEMATICA library which computes a few selected values of various mathematical functions.

TEST_VALUES, a MATLAB library which supplies test values of various mathematical functions.

TEST_VALUES, a Python library which supplies test values of various mathematical functions.

TEST_ZERO, a C library which implements test problems for the solution of a single nonlinear equation in one variable.

TEST_ZERO, a C++ library which implements test problems for the solution of a single nonlinear equation in one variable.

TEST_ZERO, a FORTRAN77 library which implements test problems for the solution of a single nonlinear equation in one variable.

TEST_ZERO, a FORTRAN90 library which implements test problems for the solution of a single nonlinear equation in one variable.

TEST_ZERO, a MATLAB library which implements test problems for the solution of a single nonlinear equation in one variable.

TEST_ZERO, a Python library which implements test problems for the solution of a single nonlinear equation in one variable.

TESTPACK, a C library which defines a set of integrands used to test M-dimensional quadrature.

TESTPACK, a C++ library which defines a set of integrands used to test M-dimensional quadrature.

TESTPACK, a FORTRAN77 library which defines a set of integrands used to test M-dimensional quadrature.

TESTPACK, a FORTRAN90 library which defines a set of integrands used to test M-dimensional quadrature.

TESTPACK, a MATLAB library which defines a set of integrands used to test M-dimensional quadrature.

TET_MESH, a C library which carries out various operations on tetrahedral meshes.

TET_MESH, a C++ library which carries out various operations on tetrahedral meshes.

TET_MESH, a FORTRAN77 library which carries out various operations on tetrahedral meshes.

TET_MESH, a FORTRAN90 library which carries out various operations on tetrahedral meshes.

TET_MESH, a MATLAB library which carries out various operations on tetrahedral meshes.

TET_MESH_BOUNDARY, a FORTRAN90 program which returns the nodes and faces of the boundary of a tetrahedral mesh, which themselves form a 3D triangular mesh or TRI_SURFACE.

TET_MESH_BOUNDARY, a C++ program which returns the nodes and faces of the boundary of a tetrahedral mesh, which themselves form a 3D triangular mesh or TRI_SURFACE.

TET_MESH_BOUNDARY, a MATLAB program which returns the nodes and faces of the boundary of a tetrahedral mesh, which themselves form a 3D triangular mesh or TRI_SURFACE.

TET_MESH_DISPLAY, a MATLAB program which reads in the node and element files defining a tet mesh and displays a wireframe image.

TET_MESH_DISPLAY_OPENGL, a C++ program which reads a 3D tet mesh and displays the nodes and edges using OpenGL.

TET_MESH_L2Q, a C++ program which reads information about a 4-node (linear) tet mesh and creates data defining a corresponding 10-node (quadratic) tet mesh;

TET_MESH_L2Q, a FORTRAN90 program which reads information about a 4-node (linear) tet mesh and creates data defining a corresponding 10-node (quadratic) tet mesh;

TET_MESH_L2Q, a MATLAB program which reads information about a 4-node (linear) tet mesh and creates data defining a corresponding 10-node (quadratic) tet mesh;

TET_MESH_ORDER4, a dataset directory which contains examples of order 4 (linear) tetrahedral meshes, using a pair of files to list the node coordinates and the 4 nodes that make up each tetrahedron;

TET_MESH_ORDER10, a dataset directory which contains examples of order 10 (quadratic) tetrahedral meshes, using a pair of files to list the node coordinates and the 10 nodes that make up each tetrahedron;

TET_MESH_ORDER20, a dataset directory which contains examples of order 20 (cubic) tetrahedral meshes, using a pair of files to list the node coordinates and the 20 nodes that make up each tetrahedron;

TET_MESH_Q2L, a C++ program which reads information about a 10-node (quadratic) tet mesh and creates data defining a corresponding 4-node (linear) tet mesh;

TET_MESH_Q2L, a FORTRAN90 program which reads information about a 10-node (quadratic) tet mesh and creates data defining a corresponding 4-node (linear) tet mesh;

TET_MESH_Q2L, a MATLAB program which reads information about a 10-node (quadratic) tet mesh and creates data defining a corresponding 4-node (linear) tet mesh;

TET_MESH_QUAD, a C++ program which estimates the integral of a function over a region defined by a tetrahedral mesh.

TET_MESH_QUAD, a FORTRAN90 program which estimates the integral of a function over a region defined by a tetrahedral mesh.

TET_MESH_QUAD, a MATLAB program which estimates the integral of a function over a region defined by a tetrahedral mesh.

TET_MESH_QUALITY, a C++ program which computes quality measures of a tetrahedral mesh.

TET_MESH_QUALITY, a FORTRAN90 program which computes quality measures of a tetrahedral mesh.

TET_MESH_QUALITY, a MATLAB program which computes quality measures of a tetrahedral mesh.

TET_MESH_RCM, a C++ program which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a tet mesh that uses 4-node or 10-node tetrahedrons;

TET_MESH_RCM, a FORTRAN90 program which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a tet mesh that uses 4-node or 10-node tetrahedrons;

TET_MESH_RCM, a MATLAB program which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a tet mesh that uses 4-node or 10-node tetrahedrons;

TET_MESH_REFINE, a C++ program which refines a tet mesh;

TET_MESH_REFINE, a FORTRAN90 program which refines a tet mesh;

TET_MESH_REFINE, a MATLAB program which refines a tet mesh;

TET_MESH_TET_NEIGHBORS, a C++ program which reads information about a tet mesh and writes out a list of the tetrahedrons that are adjacent to a given tetrahedron;

TET_MESH_TET_NEIGHBORS, a data directory which contains examples of TET_MESH_TET_NEIGHBOR files, description of a format for tetrahedron adjacency information in a tetrahedral mesh of 3D points;

TET_MESH_TET_NEIGHBORS, a FORTRAN90 program which reads information about a tet mesh and writes out a list of the tetrahedrons that are adjacent to a given tetrahedron;

TET_MESH_TET_NEIGHBORS, a MATLAB program which reads information about a tet mesh and writes out a list of the tetrahedrons that are adjacent to a given tetrahedron;

TET_MESH_VOLUMES, a C++ program which computes the volume of each tetrahedron in a tet mesh;

TET_MESH_VOLUMES, a FORTRAN90 program which computes the volume of each tetrahedron in a tet mesh;

TET_MESH_VOLUMES, a MATLAB program which computes the volume of each tetrahedron in a tet mesh;

TETGEN, examples which illustrate the use of TETGEN, a program which can compute the convex hull and Delaunay tetrahedralization of a set of 3D points, or can start with a 3D region defined by its boundaries, and construct a boundary-constrained conforming quality Delaunay mesh, by Hang Si.

TETHEX, examples which illustrate the use of TETHEX, a C++ program which can read a Gmsh file defining a mesh of triangles or tetrahedrons, and subdivide the mesh into quadrilaterals or hexahedrons, which are suitable for use by the DEALII finite element program, by Mikhail Artemiev.

TETRAHEDRON_ARBQ_RULE, a C library which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.

TETRAHEDRON_ARBQ_RULE, a C++ library which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.

TETRAHEDRON_ARBQ_RULE, a FORTRAN77 library which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.

TETRAHEDRON_ARBQ_RULE, a FORTRAN90 library which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.

TETRAHEDRON_ARBQ_RULE, a MATLAB library which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.

TETRAHEDRON_EXACTNESS, a C program which investigates the monomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.

TETRAHEDRON_EXACTNESS, a C++ program which investigates the monomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.

TETRAHEDRON_EXACTNESS, a FORTRAN77 program which investigates the monomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.

TETRAHEDRON_EXACTNESS, a FORTRAN90 program which investigates the monomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.

TETRAHEDRON_EXACTNESS, a MATLAB program which investigates the monomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.

TETRAHEDRON_FELIPPA_RULE, a C library which returns Felippa's quadratures rules for approximating integrals over the interior of a tetrahedron in 3D.

TETRAHEDRON_FELIPPA_RULE, a C++ library which returns Felippa's quadratures rules for approximating integrals over the interior of a tetrahedron in 3D.

TETRAHEDRON_FELIPPA_RULE, a FORTRAN77 library which returns Felippa's quadratures rules for approximating integrals over the interior of a tetrahedron in 3D.

TETRAHEDRON_FELIPPA_RULE, a FORTRAN90 library which returns Felippa's quadratures rules for approximating integrals over the interior of a tetrahedron in 3D.

TETRAHEDRON_FELIPPA_RULE, a MATLAB library which returns Felippa's quadratures rules for approximating integrals over the interior of a tetrahedron in 3D.

TETRAHEDRON_GRID, a C library which computes a grid of points over the interior of a tetrahedron in 3D.

TETRAHEDRON_GRID, a C++ library which computes a grid of points over the interior of a tetrahedron in 3D.

TETRAHEDRON_GRID, a FORTRAN77 library which computes a grid of points over the interior of a tetrahedron in 3D.

TETRAHEDRON_GRID, a FORTRAN90 library which computes a grid of points over the interior of a tetrahedron in 3D.

TETRAHEDRON_GRID, a MATLAB library which computes a grid of points over the interior of a tetrahedron in 3D.

TETRAHEDRON_GRID, a Python library which computes a grid of points over the interior of a tetrahedron in 3D.

TETRAHEDRON_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.

TETRAHEDRON_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.

TETRAHEDRON_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.

TETRAHEDRON_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.

TETRAHEDRON_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.

TETRAHEDRON_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.

TETRAHEDRON_KEAST_RULE, a C library which defines ten quadrature rules, with exactness degrees 0 through 8, over the interior of a tetrahedron in 3D.

TETRAHEDRON_KEAST_RULE, a C++ library which defines ten quadrature rules, with exactness degrees 0 through 8, over the interior of a tetrahedron in 3D.

TETRAHEDRON_KEAST_RULE, a FORTRAN90 library which defines ten quadrature rules, with exactness degrees 0 through 8, over the interior of a tetrahedron in 3D.

TETRAHEDRON_KEAST_RULE, a MATLAB library which defines ten quadrature rules, with exactness degrees 0 through 8, over the interior of a tetrahedron in 3D.

TETRAHEDRON_MONTE_CARLO, a C library which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.

TETRAHEDRON_MONTE_CARLO, a C++ library which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.

TETRAHEDRON_MONTE_CARLO, a FORTRAN77 library which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.

TETRAHEDRON_MONTE_CARLO, a FORTRAN90 library which uses the Monte Carlo method to estimate integrals over the interior of a generalt tetrahedron in 3D.

TETRAHEDRON_MONTE_CARLO, a MATLAB library which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.

TETRAHEDRON_NCC_RULE, a C library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_NCC_RULE, a C++ library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_NCC_RULE, a FORTRAN90 library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_NCC_RULE, a MATLAB library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_NCO_RULE, a C library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_NCO_RULE, a C++ library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_NCO_RULE, a FORTRAN90 library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_NCO_RULE, a MATLAB library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.

TETRAHEDRON_PROPERTIES, a C program which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.

TETRAHEDRON_PROPERTIES, a C++ program which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.

TETRAHEDRON_PROPERTIES, a FORTRAN77 program which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.

TETRAHEDRON_PROPERTIES, a FORTRAN90 program which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.

TETRAHEDRON_PROPERTIES, a MATLAB program which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.

TETRAHEDRON_SAMPLES, a dataset directory which contains examples of sets of sample points from the interior of a tetrahedron in 3D.

TETRAHEDRON_SLICE_ANIMATE, a MATLAB program which is given a tetrahedron and a vector, and displays an evenly spaced sequence of planes that intersect the tetrahedron and are normal to the vector.

TETRAHEDRON_SLICE_DISPLAY, a MATLAB program which determines the intersection between a tetrahedron and a plane and displays the result.

TETRAHEDRON01_MONTE_CARLO, a C library which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.

TETRAHEDRON01_MONTE_CARLO, a C++ library which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.

TETRAHEDRON01_MONTE_CARLO, a FORTRAN77 library which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.

TETRAHEDRON01_MONTE_CARLO, a FORTRAN90 library which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.

TETRAHEDRON01_MONTE_CARLO, a MATLAB library which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.

TETRAHEDRON01_MONTE_CARLO, a Python library which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.

TETRAHEDRONS, a dataset directory which contains examples of tetrahedrons;

TETVIEW, examples which illustrate the use of the tetview graphics program, which can display 3D POLY files, by Hang Si.

TEXT, a dataset directory which contains some short English texts, such as the Gettysburg Address;

TGA, a data directory which contains TGA or TARGA graphics file;

TGA_IO, a C++ library which reads a TGA or TARGA graphics file;

THEANO, examples which illustrate the use of THEANO, which is a deep learning package written in Python.

THEODOLITE, a MATLAB library which presents the problem of estimating the location of an event which occurs in the sky, atmosphere, or the heavens, using nothing but the reported angle of observation from several stations; this is an example in which a nonlinear least squares (NLS) solver is needed.

THREE_BODY_SIMULATION, a C program which simulates the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.

THREE_BODY_SIMULATION, a C++ program which simulates the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.

THREE_BODY_SIMULATION, a FORTRAN77 program which simulates the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.

THREE_BODY_SIMULATION, a FORTRAN90 program which simulates the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.

THREE_BODY_SIMULATION, a MATLAB program which simulates the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.

THREED, a MATLAB library which contains functions useful for finite element method (FEM) calculations applied within a 3D geometry, by Jeff Borggaard.

THREED_TO_TECPLOT, a MATLAB program which accepts finite element method (FEM) data computed for a 3D fluid governed by the Navier Stokes equations (NSE) and writes it to a PLT file for postprocessing by tecplot.

THREED_TO_VTK, a MATLAB program which accepts finite element method (FEM) data computed for a 3D fluid governed by the Navier Stokes equations (NSE) and writes it to a VTK legacy file for postprocessing by the paraview interactive visualization program.

THREED_TO_VTU, (archived) a MATLAB program which accepts finite element method (FEM) data computed for a 3D fluid governed by the Navier Stokes equations (NSE) and writes it to a VTK unstructured grid file for postprocessing by the paraview interactive visualization program.

THREED_TO_VU, a MATLAB program which accepts finite element method (FEM) data computed for a 3D fluid governed by the Navier Stokes equations (NSE) and writes it to a file for postprocessing by the graphics program VU.

TIC_TOC, MATLAB programs which demonstrate some features of MATLAB's tic() and toc() functions for wallclock timing.

TIKZ, examples which illustrate the use of TIKZ, a drawing package for use in TEX and LATEX documents;

TILER_2D, a FORTRAN90 program which demonstrates a 2D example of transfinite interpolation.

TILER_3D, a C++ program which demonstrates a 3D example of transfinite interpolation.

TILER_3D, a FORTRAN90 program which demonstrates a 3D example of transfinite interpolation.

TIME_SERIES, a dataset directory which contains examples of time series, which are simply records of the values of some quantity at a sequence of times.

TIMER, C programs which demonstrate how to compute CPU time or elapsed time.

TIMER, C++ programs which demonstrate how to compute CPU time or elapsed time.

TIMER, FORTRAN77 programs which demonstrate how to compute CPU time or elapsed time.

TIMER, FORTRAN90 programs which demonstrate how to compute CPU time or elapsed time.

TIMER, MATLAB programs which demonstrate how to compute CPU time or elapsed time.

TIMER, Python programs which demonstrate how to compute CPU time or elapsed time.

TIMESTAMP, a C library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a C++ library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a FORTRAN77 library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a FORTRAN90 library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a Julia library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a MATHEMATICA library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a MATLAB library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a Perl library which returns the YMDHMS date as a timestamp.

TIMESTAMP, a Python function which returns the YMDHMS date as a timestamp.

TOEPLITZ, a FORTRAN77 library solves a variety of Toeplitz and circulant linear systems.

TOEPLITZ, a FORTRAN90 library solves a variety of Toeplitz and circulant linear systems.

TOEPLITZ_CHOLESKY, a C library which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.

TOEPLITZ_CHOLESKY, a C++ library which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.

TOEPLITZ_CHOLESKY, a FORTRAN77 library which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.

TOEPLITZ_CHOLESKY, a FORTRAN90 library which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.

TOEPLITZ_CHOLESKY, a MATLAB library which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.

TOEPLITZ_CHOLESKY, a Python library which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.

TOMS097, a C library which computes the distance between all pairs of nodes in a directed graph with weighted edges, using Floyd's algorithm.

TOMS097, a C++ library which computes the distance between all pairs of nodes in a directed graph with weighted edges, using Floyd's algorithm.

TOMS097, a FORTRAN77 library which computes the distance between all pairs of nodes in a directed graph with weighted edges, using Floyd's algorithm.

TOMS097, a FORTRAN90 library which computes the distance between all pairs of nodes in a directed graph with weighted edges, using Floyd's algorithm.

TOMS097, a MATLAB library which computes the distance between all pairs of nodes in a directed graph with weighted edges, using Floyd's algorithm.

TOMS097, a Python library which computes the distance between all pairs of nodes in a directed graph with weighted edges, using Floyd's algorithm.

TOMS112, a C library which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.

TOMS112, a C++ library which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.

TOMS112, a FORTRAN90 library which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.

TOMS112, a MATLAB library which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.

TOMS112, a Python library which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.

TOMS178, a C library which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.

TOMS178, a C++ library which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.

TOMS178, a FORTRAN77 library which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.

TOMS178, a FORTRAN90 library which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.

TOMS178, a MATLAB library which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.

TOMS178, a Python library which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.

TOMS179, a C library which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.

TOMS179, a C++ library which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.

TOMS179, a FORTRAN77 library which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.

TOMS179, a FORTRAN90 library which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.

TOMS179, a MATLAB library which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.

TOMS179, a Python library which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.

TOMS291, a C library which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.

TOMS291, a C++ library which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.

TOMS291, a FORTRAN77 library which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.

TOMS291, a FORTRAN90 library which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.

TOMS291, a MATLAB library which evaluates the logarithm of the Gamma function. This is a version of ACM TOMS algorithm 291.

TOMS322, a C library which evaluates the F and Student's T Cumulative Density Functions (CDF); This is a version of ACM TOMS algorithm 291.

TOMS322, a FORTRAN77 library which evaluates the F and Student's T Cumulative Density Functions (CDF). This is a version of ACM TOMS algorithm 322.

TOMS332, a FORTRAN77 library which evaluates Jacobi polynomials; this is a version of ACM TOMS algorithm 332.

TOMS343, a FORTRAN77 library which computes the eigenvalues and eigenvectors of a general real matrix; this is a version of ACM TOMS algorithm 343.

TOMS344, a FORTRAN77 library which calculates the Student T distribution; this is a version of ACM TOMS algorithm 344.

TOMS347, a FORTRAN77 library which sorts an integer vector; this is a version of ACM TOMS algorithm 347.

TOMS351, a FORTRAN77 library which estimates an integral using Romberg integration. This is a version of ACM TOMS algorithm 351.

TOMS352, a FORTRAN77 library which computes the characteristic values and associated solutions of Mattieu's ordinary differential equation (ODE); this is a version of ACM TOMS algorithm 352.

TOMS353, a FORTRAN77 library which estimates an integral of the form integral ( a <= x <= b ) f(x) cos(w*x) dx or integral ( a <= x <= b ) f(x) sin(w*x) dx using Filon quadrature, by Chase and Fosdick. This is a version of ACM TOMS algorithm 353.

TOMS358, a FORTRAN77 library which computes the singular value decomposition (SVD) of a complex matrix; this is a version of ACM TOMS algorithm 358.

TOMS358, a FORTRAN library which computes the singular value decomposition (SVD) of a complex matrix; this is a version of ACM TOMS algorithm 358. This is a translation created by Alexsander Schwarzenberg-Czerny.

TOMS359, a FORTRAN77 library which computes the factorial analysis of variance; this is a version of ACM TOMS algorithm 359.

TOMS365, a FORTRAN77 library which finds a root of an analytic complex function by the downhill method; this is a version of ACM TOMS algorithm 365.

TOMS370, a FORTRAN77 library which produces random numbers sampled from an arbitrary Probability Density Function (PDF); this is a version of ACM TOMS algorithm 370.

TOMS379, a FORTRAN77 library which estimates an integral. This is a version of ACM TOMS algorithm 379.

TOMS384, a FORTRAN77 library which computes the eigenvalues and eigenvectors of a symmetric matrix; this is a version of ACM TOMS algorithm 384.

TOMS385, a FORTRAN77 library which evaluates the exponential integral function; this is a version of ACM TOMS algorithm 385.

TOMS392, a FORTRAN77 library which approximates the time evolution of a hyperbolic PDE; this is a version of ACM TOMS algorithm 392.

TOMS418, a FORTRAN77 library 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.

TOMS419, a FORTRAN77 library which seeks the roots of a polynomial with complex coefficients; this library is commonly called CPOLY; this is a version of ACM TOMS algorithm 419.

TOMS423, a FORTRAN77 library which implements Gaussian elimination, revised versions of DECOMP and SOLVE; this is a version of ACM TOMS algorithm 423.

TOMS424, a FORTRAN77 library which implements Clenshaw-Curtis integration; this is a version of ACM TOMS algorithm 424.

TOMS425, a FORTRAN77 library which generates a sequence of vectors from a multivariate normal distribution with given covariance; this is a version of ACM TOMS algorithm 425.

TOMS427, a FORTRAN77 library 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.

TOMS429, a FORTRAN77 library which reports information about the estimated location of roots of a polynomial; this is a version of ACM TOMS algorithm 429.

TOMS431, a FORTRAN77 library which solves quadratic and linear programming problems; this is a version of ACM TOMS algorithm 431.

TOMS434, a FORTRAN77 library which computes the probability of a given RxC contingency table; this is a version of ACM TOMS algorithm 434.

TOMS435, a FORTRAN77 library which evaluates the modified incomplete Gamma function. This is a version of ACM TOMS algorithm 435.

TOMS436, a FORTRAN77 library which carries out product-type trapezoidal integration; this is a version of ACM TOMS algorithm 436.

TOMS437, a FORTRAN77 library which carries out product-type Simpson's integration; this is a version of ACM TOMS algorithm 437.

TOMS438, a FORTRAN77 library which carries out product-type two point Gauss-Legendre-Simpson integration; this is a version of ACM TOMS algorithm 438.

TOMS439, a FORTRAN77 library which carries out product-type three point Gauss-Legendre-Simpson integration; this is a version of ACM TOMS algorithm 439.

TOMS441, a FORTRAN77 library which samples the dipole Probability Density Function (PDF); this is a version of ACM TOMS algorithm 441.

TOMS443, a C library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 443.

TOMS443, a C++ library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 443.

TOMS443, a FORTRAN77 library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 443.

TOMS443, a FORTRAN90 library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 443.

TOMS443, a MATLAB library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 443.

TOMS446, a C library which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.

TOMS446, a C++ library which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.

TOMS446, a FORTRAN77 library which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.

TOMS446, a FORTRAN90 library which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.

TOMS446, a MATLAB library which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.

TOMS448, a FORTRAN77 library which counts the number of partitions of an integer into a given set of integers; this is a version of ACM TOMS algorithm 448.

TOMS449, a FORTRAN77 library which implements ACM TOMS algorithm 449, which solves linear programming problems in which the variables are resricted to the values 0 and 1.

TOMS450, a FORTRAN77 library which minimizes a scalar function of N variables using the method of Rosenbrock; this is a version of ACM TOMS algorithm 450.

TOMS451, a FORTRAN77 library which determines quantiles of the Chi-Square Probability Density Function (PDF); this is a version of ACM TOMS algorithm 451.

TOMS452, a FORTRAN77 library which generates a sequence of combinations of M things out of N; this is a version of ACM TOMS algorithm 452.

TOMS453, a FORTRAN77 library 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, a FORTRAN90 library which determines the abscissas and weights for a Gaussian quadrature formula for Bromwich's integral; this is a version of ACM TOMS algorithm 453.

TOMS454, a FORTRAN77 library which implements the complex method of constrained optimization; this is a version of ACM TOMS algorithm 454.

TOMS456, a FORTRAN77 library which implements the routing algorithm; this is a version of ACM TOMS algorithm 456.

TOMS460, a FORTRAN77 library which determines the optimal parameters for an alternating direction implicit iteration; this is a version of ACM TOMS algorithm 460.

TOMS461, a FORTRAN77 library which applies cubic spline solutions to a class of functional differential equations; this is a version of ACM TOMS algorithm 461.

TOMS462, a C library which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.

TOMS462, a C++ library which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.

TOMS462, a FORTRAN77 library which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.

TOMS462, a FORTRAN90 library which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.

TOMS462, a MATLAB library which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.

TOMS463, a FORTRAN77 library which chooses nice ranges for a graph of computer-generated data; this is a version of ACM TOMS algorithm 463.

TOMS467, a FORTRAN77 library which transposes a matrix in place; this is a version of ACM TOMS algorithm 467.

TOMS468, a FORTRAN77 library which applies automatic integration to a function using the Gauss-Patterson family of quadrature rules. This is a version of ACM TOMS algorithm 468.

TOMS470, a FORTRAN77 library which solves an almost tridiagonal system of linear equations; this is a version of ACM TOMS algorithm 470.

TOMS493, a FORTRAN77 library which seeks the roots of a real polynomial; this library is commonly called RPOLY; this is a version of ACM TOMS algorithm 493.

TOMS494, a FORTRAN77 library which approximates a 1D partial differential equation (PDE) as a system of ordinary differential equations (ODE's); this library is commonly called PDEONE; this is a version of ACM TOMS algorithm 494.

TOMS502, a FORTRAN77 library which computes a sequence of solutions of a parameterized system of nonlinear equations; this is a version of ACM TOMS algorithm 502.

TOMS511, a FORTRAN77 library which can evaluate Bessel I or J functions of real (non integer) order, This is a version of ACM TOMS Algorithm 515;

TOMS515, a C library which can select subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.

TOMS515, a C++ library which can select subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.

TOMS515, a FORTRAN77 library which can select subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.

TOMS515, a FORTRAN90 library which can select subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.

TOMS515, a MATLAB library which can select subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.

TOMS515, a Python library which can select subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.

TOMS526, a FORTRAN77 library which interpolates scattered bivariate data. This is a version of ACM TOMS algorithm 526, by Hiroshi Akima;

TOMS526, a FORTRAN90 library which interpolates scattered bivariate data. This is a version of ACM TOMS algorithm 526, by Hiroshi Akima;

TOMS550, a FORTRAN77 library 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.

TOMS552, a FORTRAN77 library which solves an overdetermined constrained linear system this is a version of ACM TOMS algorithm 552.

TOMS552, a FORTRAN90 library which computes a solution of a constrained linear system. of a scalar function, this is a version of ACM TOMS algorithm 552;

TOMS563, a FORTRAN77 library which solves a linearly constrained L1 minimization problem, by Richard Bartels, Andrew Conn. This is a version of ACM TOMS algorithm 563.

TOMS565, a FORTRAN77 library which approximates the solution of a system of time-dependent partial differential equations (PDE's) over a 2D domain; this library is commonly called PDETWO; this is a version of ACM TOMS algorithm 565;

TOMS571, a FORTRAN77 library which evaluates or inverts the von Mises and Fisher Probability Density Functions (PDF's) of directions on a circle or sphere; this is a version of ACM TOMS algorithm 571.

TOMS577, a C library which evaluates Carlson's elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;

TOMS577, a C++ library which evaluates Carlson's elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;

TOMS577, a FORTRAN77 library which evaluates Carlson's elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;

TOMS577, a FORTRAN90 library which evaluates Carlson's elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;

TOMS577, a MATLAB library which evaluates Carlson's elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;

TOMS577, a Python library which evaluates Carlson's elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;

TOMS581, a FORTRAN77 library which implements an improved algorithm for computing the singular value decomposition (SVD) of a rectangular matrix; this is a version of ACM TOMS algorithm 571, by Tony Chan.

TOMS596, a FORTRAN77 library 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.

TOMS597, a FORTRAN77 library which can evaluate Bessel I functions of real (non integer) order, This is a version of ACM TOMS Algorithm 597;

TOMS599, a library 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.

TOMS611, a FORTRAN77 library which seeks the minimizer of a scalar functional of multiple variables. This is a version of ACM TOMS algorithm 611, by David Gay.

TOMS611, a FORTRAN90 library which seeks the minimizer of a scalar functional of multiple variables. This is a version of ACM TOMS algorithm 611, by David Gay.

TOMS612, a FORTRAN77 library which estimates the integral of a function over a triangle. This is a version of ACM TOMS algorithm 612.

TOMS626, a FORTRAN77 library which creates a contour plot of data associated with a triangulated set of points. This is a version of ACM TOMS algorithm 626.

TOMS632, a FORTRAN77 library which solves the multiple knapsack problem, by Silvano Martello and Paolo Toth. This is a version of ACM TOMS algorithm 632.

TOMS644, a FORTRAN77 library 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.

TOMS647, a FORTRAN77 library which evaluates Faure, Halton and Sobol Quasi Monte Carlo (QMC) sequences. This is a version of ACM TOMS algorithm 647,

TOMS647, a FORTRAN90 library which evaluates Faure, Halton and Sobol Quasi Monte Carlo (QMC) sequences. This is a version of ACM TOMS algorithm 647.

TOMS648_NSD, a FORTRAN77 library which defines non-stiff systems of ordinary differential equations (ODE's) to be used as test problems; this is part of ACM TOMS algorithm 648.

TOMS655, a C library which computes the weights for interpolatory quadrature rules; this library is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.

TOMS655, a C++ library which computes the weights for interpolatory quadrature rules; this library is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.

TOMS655, a FORTRAN77 library which computes the weights for interpolatory quadrature rules; this library is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.

TOMS655, a FORTRAN90 library which computes the weights for interpolatory quadrature rules; this library is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.

TOMS655, a MATLAB library which computes the weights for interpolatory quadrature rules; this library is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.

TOMS655_ORIGINAL, a FORTRAN77 library which computes the weights for interpolatory quadrature rules; this library is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.

TOMS659, a FORTRAN77 library which computes elements of the Sobol Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 659.

TOMS659, a FORTRAN90 library which computes elements of the Sobol Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 659.

TOMS660, a FORTRAN77 library which takes scattered 2D data and produces an interpolating function F(X,Y). This is a version of ACM TOMS algorithm 660, called qshep2d, by Robert Renka.

TOMS660, a FORTRAN90 library which takes scattered 2D data and produces an interpolating function F(X,Y). This is a version of ACM TOMS algorithm 660, called qshep2d, by Robert Renka.

TOMS661, a FORTRAN77 library which takes scattered 3D data and produces an interpolating function F(X,Y,Z). This is a version of ACM TOMS algorithm 661, called qshep3d, by Robert Renka.

TOMS661, a FORTRAN90 library which takes scattered 3D data and produces an interpolating function F(X,Y,Z). This is a version of ACM TOMS algorithm 661, called qshep3d, by Robert Renka.

TOMS664, a FORTRAN77 library 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 is a version of ACM TOMS algorithm 664.

TOMS672, a FORTRAN77 library which generates an interpolatory quadrature rule of highest possible order, given a set of preassigned abscissas. This library can be used to generate Gauss-Kronrod and Gauss-Patterson quadrature rules. This library is commonly called EXTEND; This is a version of ACM TOMS algorithm 672.

TOMS672, a FORTRAN90 library which generates an interpolatory quadrature rule of highest possible order, given a set of preassigned abscissas. This library can be used to generate Gauss-Kronrod and Gauss-Patterson quadrature rules. This library is commonly called EXTEND. This is a version of ACM TOMS algorithm 672.

TOMS699, a FORTRAN77 library which implements a new representation of Patterson's quadrature formula; this is a version of ACM TOMS algorithm 699.

TOMS706, a FORTRAN77 library which estimates the integral of a function over a triangulated region; this is a version of ACM TOMS algorithm 706.

TOMS708, a FORTRAN77 library which includes routines to evaluate the incomplete Gamma function, by Armido Didonato, Alfred Morris; this is a version of ACM TOMS algorithm 708.

TOMS708, a FORTRAN90 library which includes routines to evaluate the incomplete Gamma function, by Armido Didonato, Alfred Morris; this is a version of ACM TOMS algorithm 708.

TOMS715, a FORTRAN77 library 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, a FORTRAN90 library 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.

TOMS722, a C library which supports IEEE arithmetic; this is a version of ACM TOMS algorithm 722.

TOMS723, a FORTRAN77 library which computes the Fresnel sine and cosine integrals, by W van Snyder. This is a version of ACM TOMS algorithm 723.

TOMS724, a FORTRAN77 library 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.

TOMS725, a FORTRAN77 library which evaluates multivariate normal integrals associated with the computation of cumulative probabilities 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.

TOMS726, a FORTRAN77 library which computes recursion coefficients for orthogonal polynomials, and the abscissa and weights for related quadrature rules, by Walter Gautschi. This library is commonly called ORTHPOL. This is a version of ACM TOMS algorithm 726.

TOMS726, a FORTRAN90 library which computes recursion coefficients for orthogonal polynomials, and the abscissa and weights for related quadrature rules. by Walter Gautschi. This library is commonly called ORTHPOL. This is a version of ACM TOMS algorithm 726.

TOMS738, a FORTRAN77 library which evaluates Niederreiter's Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 738;

TOMS738, a FORTRAN90 library which evaluates Niederreiter's Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 738;

TOMS743, a C library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.

TOMS743, a C++ library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.

TOMS743, a FORTRAN77 library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.

TOMS743, a FORTRAN90 library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.

TOMS743, a MATLAB library which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.

TOMS757, a FORTRAN77 library which evaluates uncommon special functions, by Allan Mcleod; this is a version of ACM TOMS algorithm 757;

TOMS757, a FORTRAN90 library which evaluates uncommon special functions, by Allan Mcleod; this is a version of ACM TOMS algorithm 757;

TOMS772, a FORTRAN77 library which carries out computational geometry on the unit sphere, by Robert Renka. this library is commonly called stripack; this is a version of ACM TOMS algorithm 772.

TOMS790, a FORTRAN77 library which computes an interpolating function to a set of scattered data in the plane, by Robert Renka; This library is commonly called cshep2d; this is a version of ACM TOMS algorithm 790.

TOMS790, a FORTRAN90 library which computes an interpolating function to scattered data in the plane, by Robert Renka; this library is commonly called cshep2d; this is a version of ACM TOMS algorithm 790.

TOMS792, a FORTRAN77 library which tests functions that interpolate scattered data in the plane; by Robert Renka; this is a version of ACM TOMS algorithm 792.

TOMS792, a FORTRAN90 library which tests functions that interpolate scattered data in the plane; by Robert Renka; this is a version of ACM TOMS algorithm 792.

TOMS793, a FORTRAN77 library 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.

TOMS847, a MATLAB library which carries out piecewise multilinear hierarchical sparse grid interpolation; this library is commonly called SPINTERP (version 2.1); this is a version of ACM TOMS Algorithm 847, by Andreas Klimke;

TOMS866, a MATLAB library which is version 2.2 of the Incompressible Flow Iterative Solution Software (IFISS), for fluid flow governed by the Navier Stokes equations (NSE), by Howard Elman, Alison Ramage, David Silvester; this is a version of ACM TOMS algorithm 866.

TOMS886, a C library which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.

TOMS886, a C++ library which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.

TOMS886, a FORTRAN77 library which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.

TOMS886, a FORTRAN90 library which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.

TOMS886, a MATLAB library which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.

TOMS917, a C library which evaluates the Wright Omega function, by Piers Lawrence, Robert Corless, David Jeffrey. This is a version of ACM TOMS algorithm 917.

TOMS917, a C++ library which evaluates the Wright Omega function, by Piers Lawrence, Robert Corless, David Jeffrey. This is a version of ACM TOMS algorithm 917.

TOPHAT, examples which illustrate the use of TOPHAT, which is a program that aligns RNA-Seq reads to a genome in order to identify exon-exon splice junctions.

TORCH, examples which illustrate the use of TORCH, which is a scientific computing framework for LUAJIT, most commonly used for machine learning applications.

TRAFFIC_SIMULATION, a MATLAB program which simulates the cars waiting to get through a traffic light.

TRAPZ_PARFOR, a MATLAB library which shows how a parfor loop can be used to call the trapz() function, to compute several integral approximations in parallel.

TREEPACK, a C library which carries out computations on trees, a simple kind of graph that is minimally connected.

TREEPACK, a C++ library which carries out computations on trees, a simple kind of graph that is minimally connected.

TREEPACK, a FORTRAN77 library which carries out computations on trees, a simple kind of graph that is minimally connected.

TREEPACK, a FORTRAN90 library which carries out computations on trees, a simple kind of graph that is minimally connected.

TREEPACK, a MATLAB library which carries out computations on trees, a simple kind of graph that is minimally connected.

TRI_SURFACE, a data directory which contains examples of TRI_SURFACE files, a 3D surface described by a collection of triangles.

TRI_SURFACE_DISPLAY, a MATLAB program which displays the 3D graphics information in a TRI_SURFACE file;

TRI_SURFACE_DISPLAY_OPENGL, a C++ program which displays the 3D graphics information in a TRI_SURFACE file using OpenGL.

TRI_SURFACE_IO, a C++ library which reads and writes the 3D graphics information in a TRI_SURFACE file;

TRI_SURFACE_IO, a FORTRAN90 library which reads and writes the 3D graphics information in a TRI_SURFACE file;

TRI_SURFACE_IO, a MATLAB library which reads and writes the 3D graphics information in a TRI_SURFACE file;

TRI_SURFACE_TO_OBJ, a MATLAB program which reads a TRI_SURFACE dataset and extracts the surface mesh data as an OBJ file.

TRI_SURFACE_TO_PLY, a MATLAB program which converts a TRI_SURFACE dataset to a dataset suitable for storage as a PLY file.

TRI_SURFACE_TO_STLA, a MATLAB program which reads a TRI_SURFACE dataset and extracts the surface mesh data as an ASCII stereolithography (STL) file.

TRIANGLE, a C program which computes a triangulation of a geometric region, by Jonathan Shewchuk.

TRIANGLE_ANALYZE, a C program which reads a triangle defined in a file, and uses the triangle_properties() library to compute angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.

TRIANGLE_ANALYZE, a C++ program which reads a triangle defined in a file, and uses the triangle_properties() library to compute angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.

TRIANGLE_ANALYZE, a FORTRAN90 program which reads a triangle defined in a file, and uses the triangle_properties() library to compute angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.

TRIANGLE_ANALYZE, a MATLAB program which reads a triangle defined in a file, and uses the triangle_properties() library to compute angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.

TRIANGLE_BENCH, a script which times the execution of the triangle() program on a sequence of sets of randomly generated nodes in the unit square.

TRIANGLE_DISPLAY, a MATLAB program which displays the nodes and elements of a triangulation on the MATLAB graphics screen, assuming the data has been stored in NODE and ELE files by Jonathan Shewchuck's triangle() program.

TRIANGLE_DUNAVANT_RULE, a C++ library which defines Dunavant rules for quadrature over the interior of a triangle in 2D.

TRIANGLE_DUNAVANT_RULE, a FORTRAN90 library which defines Dunavant rules for quadrature over the interior of a triangle in 2D.

TRIANGLE_DUNAVANT_RULE, a MATLAB library which defines Dunavant rules for quadrature over the interior of a triangle in 2D.

TRIANGLE_EXACTNESS, a C program which investigates the monomial exactness quadrature rule over the interior of a triangle in 2D.

TRIANGLE_EXACTNESS, a C++ program which investigates the monomial exactness quadrature rule over the interior of a triangle in 2D.

TRIANGLE_EXACTNESS, a FORTRAN77 program which investigates the monomial exactness quadrature rule over the interior of a triangle in 2D.

TRIANGLE_EXACTNESS, a FORTRAN90 program which investigates the monomial exactness quadrature rule over the interior of a triangle in 2D.

TRIANGLE_EXACTNESS, a MATLAB program which investigates the monomial exactness quadrature rule over the interior of a triangle in 2D.

TRIANGLE_FEKETE_RULE, a C library which defines Fekete rules for interpolation or quadrature over the interior of a triangle in 2D.

TRIANGLE_FEKETE_RULE, a C++ library which defines Fekete rules for interpolation or quadrature over the interior of a triangle in 2D.

TRIANGLE_FEKETE_RULE, a FORTRAN90 library which defines Fekete rules for interpolation or quadrature over the interior of a triangle in 2D.

TRIANGLE_FEKETE_RULE, a MATLAB library which defines Fekete rules for quadrature or interpolation over the interior of a triangle in 2D.

TRIANGLE_FELIPPA_RULE, a C library which returns Felippa's quadratures rules for approximating integrals over the interior of a triangle in 2D.

TRIANGLE_FELIPPA_RULE, a C++ library which returns Felippa's quadratures rules for approximating integrals over the interior of a triangle in 2D.

TRIANGLE_FELIPPA_RULE, a FORTRAN77 library which returns Felippa's quadratures rules for approximating integrals over the interior of a triangle in 2D.

TRIANGLE_FELIPPA_RULE, a FORTRAN90 library which returns Felippa's quadratures rules for approximating integrals over the interior of a triangle in 2D.

TRIANGLE_FELIPPA_RULE, a MATLAB library which returns Felippa's quadratures rules for approximating integrals over the interior of a triangle in 2D.

TRIANGLE_FILES, a data directory which contains examples of files used by the triangle() and showme() programs.

TRIANGLE_GRID, a C library which computes a grid of points over the interior of a triangle in 2D.

TRIANGLE_GRID, a C++ library which computes a grid of points over the interior of a triangle in 2D.

TRIANGLE_GRID, a FORTRAN77 library which computes a grid of points over the interior of a triangle in 2D.

TRIANGLE_GRID, a FORTRAN90 library which computes a grid of points over the interior of a triangle in 2D.

TRIANGLE_GRID, a MATLAB library which computes a grid of points over the interior of a triangle in 2D.

TRIANGLE_GRID, a Python library which computes a grid of points over the interior of a triangle in 2D.

TRIANGLE_HISTOGRAM, a C++ program which computes histograms of data on the unit triangle in 2D.

TRIANGLE_HISTOGRAM, a FORTRAN90 program which computes histograms of data on the unit triangle in 2D.

TRIANGLE_HISTOGRAM, a MATLAB program which computes histograms of data on the unit triangle in 2D.

TRIANGLE_INTEGRALS, a C library which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.

TRIANGLE_INTEGRALS, a C++ library which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.

TRIANGLE_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.

TRIANGLE_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.

TRIANGLE_INTEGRALS, a MATLAB library which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.

TRIANGLE_INTEGRALS, a Python library which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.

TRIANGLE_INTERPOLATE, a C library which shows how vertex data can be interpolated at any point in the interior of a triangle.

TRIANGLE_INTERPOLATE, a C++ library which shows how vertex data can be interpolated at any point in the interior of a triangle.

TRIANGLE_INTERPOLATE, a FORTRAN90 library which shows how vertex data can be interpolated at any point in the interior of a triangle.

TRIANGLE_INTERPOLATE, a MATLAB library which shows how vertex data can be interpolated at any point in the interior of a triangle.

TRIANGLE_INTERPOLATE, a Python library which shows how vertex data can be interpolated at any point in the interior of a triangle.

TRIANGLE_IO, a C library which can read or write some of the files created by Jonathan Shewchuk's triangle() program.

TRIANGLE_IO, a C++ library which can read or write some of the files created by Jonathan Shewchuk's triangle() program.

TRIANGLE_IO, a FORTRAN77 library which can read or write some of the files created by Jonathan Shewchuk's triangle() program.

TRIANGLE_IO, a FORTRAN90 library which can read or write some of the files created by Jonathan Shewchuk's triangle() program.

TRIANGLE_IO, a MATLAB library which can read or write some of the files created by Jonathan Shewchuk's triangle() program.

TRIANGLE_LYNESS_RULE, a C++ library which returns Lyness-Jespersen quadrature rules over the interior of a triangle in 2D.

TRIANGLE_LYNESS_RULE, a FORTRAN90 library which returns Lyness-Jespersen quadrature rules over the interior of a triangle in 2D.

TRIANGLE_LYNESS_RULE, a MATLAB library which returns Lyness-Jespersen quadrature rules over the interior of a triangle in 2D.

TRIANGLE_MONTE_CARLO, a C library which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.

TRIANGLE_MONTE_CARLO, a C++ library which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.

TRIANGLE_MONTE_CARLO, a FORTRAN90 library which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.

TRIANGLE_MONTE_CARLO, a MATLAB library which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.

TRIANGLE_MONTE_CARLO, a Python library which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.

TRIANGLE_NCC_RULE, a C library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_NCC_RULE, a C++ library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_NCC_RULE, a FORTRAN90 library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_NCC_RULE, a MATLAB library which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_NCO_RULE, a C library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_NCO_RULE, a C++ library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_NCO_RULE, a FORTRAN90 library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_NCO_RULE, a MATLAB library which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.

TRIANGLE_PROPERTIES, a C program which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.

TRIANGLE_PROPERTIES, a C++ program which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.

TRIANGLE_PROPERTIES, a FORTRAN77 program which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.

TRIANGLE_PROPERTIES, a FORTRAN90 library which can compute properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.

TRIANGLE_PROPERTIES, a MATLAB library which can compute properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.

TRIANGLE_PROPERTIES, a Python library which can compute properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.

TRIANGLE_SAMPLES, a dataset directory which contains examples of sets of sample points from the unit triangle.

TRIANGLE_SVG, a C library which uses Scalable Vector Graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.

TRIANGLE_SVG, a C++ library which uses Scalable Vector Graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.

TRIANGLE_SVG, a FORTRAN77 library which uses Scalable Vector Graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.

TRIANGLE_SVG, a FORTRAN90 library which uses Scalable Vector Graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.

TRIANGLE_SVG, a MATLAB library which uses Scalable Vector Graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.

TRIANGLE_SYMQ_RULE, a C library which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of an arbitrary triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.

TRIANGLE_SYMQ_RULE, a C++ library which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of an arbitrary triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.

TRIANGLE_SYMQ_RULE, a FORTRAN77 library which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of an arbitrary triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.

TRIANGLE_SYMQ_RULE, a FORTRAN90 library which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of an arbitrary triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.

TRIANGLE_SYMQ_RULE, a MATLAB library which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of an arbitrary triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.

TRIANGLE_TO_FEM, a C program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes two simple "mesh" format files, listing node coordinates and element connectivity.

TRIANGLE_TO_FEM, a C++ program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.

TRIANGLE_TO_FEM, a FORTRAN77 program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.

TRIANGLE_TO_FEM, a FORTRAN90 program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.

TRIANGLE_TO_FEM, a MATLAB program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes two simple "mesh" format files, listing node coordinates and element connectivity.

TRIANGLE_TO_MEDIT, a C program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding MESH file for input to medit().

TRIANGLE_TO_MEDIT, a C++ program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding MESH file for input to medit().

TRIANGLE_TO_MEDIT, a FORTRAN77 program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding MESH file for input to medit().

TRIANGLE_TO_MEDIT, a FORTRAN90 program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding MESH file for input to medit().

TRIANGLE_TO_MEDIT, a MATLAB program which reads the NODE and ELE files created by triangle() to describe a triangular mesh, and writes a corresponding MESH file for input to medit().

TRIANGLE_TO_XML, a C program which reads the NODE and ELE files created by triangle() to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by DOLFIN or FENICS.

TRIANGLE_TO_XML, a C++ program which reads the NODE and ELE files created by triangle() to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by DOLFIN or FENICS.

TRIANGLE_TO_XML, a FORTRAN77 program which reads the NODE and ELE files created by triangle() to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by DOLFIN or FENICS.

TRIANGLE_TO_XML, a FORTRAN90 program which reads the NODE and ELE files created by triangle() to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by DOLFIN or FENICS.

TRIANGLE_TO_XML, a MATLAB program which reads the NODE and ELE files created by triangle() to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by DOLFIN or FENICS.

TRIANGLE_WANDZURA_RULE, a C++ library which returns quadrature rules of exactness 5, 10, 15, 20, 25 and 30 over the interior of the triangle in 2D.

TRIANGLE_WANDZURA_RULE, a FORTRAN90 library which returns quadrature rules of exactness 5, 10, 15, 20, 25 and 30 over the interior of the triangle in 2D.

TRIANGLE_WANDZURA_RULE, a MATLAB library which returns quadrature rules of exactness 5, 10, 15, 20, 25 and 30 over the interior of the triangle in 2D.

TRIANGLE01_INTEGRALS, a C library which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.

TRIANGLE01_INTEGRALS, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.

TRIANGLE01_INTEGRALS, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.

TRIANGLE01_INTEGRALS, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.

TRIANGLE01_INTEGRALS, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.

TRIANGLE01_INTEGRALS, a Python library which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.

TRIANGLE01_MONTE_CARLO, a C library which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.

TRIANGLE01_MONTE_CARLO, a C++ library which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.

TRIANGLE01_MONTE_CARLO, a FORTRAN77 library which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.

TRIANGLE01_MONTE_CARLO, a FORTRAN90 library which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.

TRIANGLE01_MONTE_CARLO, a MATLAB library which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.

TRIANGLE01_MONTE_CARLO, a Python library which uses the Monte Carlo method to estimates the integral of a function over the interior of the unit triangle in 2D.

TRIANGLES, a dataset directory which contains examples of triangles;

TRIANGULATE, a C program which triangulates a (possibly nonconvex) polygon, by Joseph ORourke.

TRIANGULATE, a MATLAB program which triangulates a (possibly nonconvex) polygon, based on a C program by Joseph ORourke.

TRIANGULATE_RECTANGLE, a MATLAB program which sets up a grid of triangles in a rectangular region.

TRIANGULATION, a C library which performs various operations on order 3 (linear) or order 6 (quadratic) triangulations, including searching a Delaunay triangulation to find which triangle contains a given point.

TRIANGULATION, a C++ library which performs various operations on order 3 (linear) or order 6 (quadratic) triangulations, including searching a Delaunay triangulation to find which triangle contains a given point.

TRIANGULATION, a FORTRAN77 library which performs various operations on order 3 (linear) or order 6 (quadratic) triangulations, including searching a Delaunay triangulation to find which triangle contains a given point.

TRIANGULATION, a FORTRAN90 library which performs various operations on order 3 (linear) or order 6 (quadratic) triangulations, including searching a Delaunay triangulation to find which triangle contains a given point.

TRIANGULATION, a MATLAB library which performs various operations on order 3 (linear) or order 6 (quadratic) triangulations, including searching a Delaunay triangulation to find which triangle contains a given point.

TRIANGULATION_BOUNDARY_EDGES, a MATLAB program which reads data defining a triangulation, determines which edges lie on the boundary, organizes them into connected components, and writes this information to a file.

TRIANGULATION_BOUNDARY_NODES, a C++ program which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file.

TRIANGULATION_BOUNDARY_NODES, a FORTRAN90 program which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file.

TRIANGULATION_BOUNDARY_NODES, a MATLAB program which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file.

TRIANGULATION_CORNER, a C++ program which patches triangulations so that no triangle has two sides on the boundary.

TRIANGULATION_CORNER, a FORTRAN90 program which patches triangulations so that no triangle has two sides on the boundary.

TRIANGULATION_CORNER, a MATLAB program which patches triangulations so that no triangle has two sides on the boundary.

TRIANGULATION_DELAUNAY_DISCREPANCY, a C++ program which measures the amount by which a triangulation fails the local Delaunay test;

TRIANGULATION_DELAUNAY_DISCREPANCY, a FORTRAN90 program which measures the amount by which a triangulation fails the local Delaunay test;

TRIANGULATION_DELAUNAY_DISCREPANCY, a MATLAB program which measures the amount by which a triangulation fails the local Delaunay test;

TRIANGULATION_DISPLAY, a MATLAB program which displays the nodes and elements of a triangulation on the MATLAB graphics screen;

TRIANGULATION_DISPLAY_OPENGL, a C++ program which reads files defining a 2D triangulation and displays an image using OpenGL.

TRIANGULATION_HISTOGRAM, a C++ program which computes histograms of data over a triangulation.

TRIANGULATION_HISTOGRAM, a FORTRAN90 program which computes histograms of data over a triangulation.

TRIANGULATION_HISTOGRAM, a MATLAB program which computes histograms of data over a triangulation.

TRIANGULATION_L2Q, a C++ program which reads information about a 3-node (linear) triangulation and creates data defining a corresponding 6-node (quadratic) triangulation;

TRIANGULATION_L2Q, a FORTRAN90 program which reads information about a 3-node (linear) triangulation and creates data defining a corresponding 6-node (quadratic) triangulation;

TRIANGULATION_L2Q, a MATLAB program which reads information about a 3-node (linear) triangulation and creates data defining a corresponding 6-node (quadratic) triangulation;

TRIANGULATION_MASK, a C++ program which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;

TRIANGULATION_MASK, a FORTRAN90 program which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;

TRIANGULATION_MASK, a MATLAB program which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;

TRIANGULATION_NODE_TO_ELEMENT, a C program which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an "order1" finite element model of the data.

TRIANGULATION_NODE_TO_ELEMENT, a C++ program which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an "order1" finite element model of the data.

TRIANGULATION_NODE_TO_ELEMENT, a FORTRAN77 program which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an "order1" finite element model of the data.

TRIANGULATION_NODE_TO_ELEMENT, a FORTRAN90 program which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an "order1" finite element model of the data.

TRIANGULATION_NODE_TO_ELEMENT, a MATLAB program which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an "order1" finite element model of the data.

TRIANGULATION_ORDER1_DISPLAY, a MATLAB program which plots piecewise constant data associated with a triangulation;

TRIANGULATION_ORDER3, a data directory which defines TRIANGULATION_ORDER3 files, a description of a linear triangulation of a set of 2D points, using a pair of files to list the node coordinates and the 3 nodes that make up each triangle;

TRIANGULATION_ORDER3, a dataset directory which contains examples of TRIANGULATION_ORDER3 files, a linear triangulation of a set of 2D points, using a pair of files to list the node coordinates and the 3 nodes that make up each triangle;

TRIANGULATION_ORDER3_CONTOUR, a MATLAB program which makes a contour plot of scattered data, or of data defined on an order 3 triangulation. In particular, it can display contour plots of scalar data output by fem2d_poisson or fem2d_poisson_sparse.

TRIANGULATION_ORDER4, a dataset directory which contains TRIANGULATION_ORDER4 files, a triangulation of a set of 2D points, using a pair of files to list the node coordinates and the 4 nodes that make up each triangle (3 vertices and the centroid);

TRIANGULATION_ORDER6, a data directory which defines TRIANGULATION_ORDER6 files, a quadratic triangulation of a set of 2D points, using a pair of files to list the node coordinates and the 6 nodes that make up each triangle.

TRIANGULATION_ORDER6, a dataset directory which contains TRIANGULATION_ORDER6 files, a quadratic triangulation of a set of 2D points, using a pair of files to list the node coordinates and the 6 nodes that make up each triangle.

TRIANGULATION_ORDER6_CONTOUR, a MATLAB program which makes contour plots of data defined on an order 6 triangulation.

TRIANGULATION_ORIENT, a C++ program which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;

TRIANGULATION_ORIENT, a FORTRAN90 program which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;

TRIANGULATION_ORIENT, a MATLAB program which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;

TRIANGULATION_PLOT, a C++ program which plots the nodes and elements of a triangulation as a PostScript (PS) file;

TRIANGULATION_PLOT, a FORTRAN90 program which plots the nodes and elements of a triangulation as a PostScript (PS) file;

TRIANGULATION_PLOT, a MATLAB program which plots the nodes and elements of a triangulation as a PostScript (PS) file;

TRIANGULATION_Q2L, a C++ program which reads information about a 6-node (quadratic) triangulation and creates data defining a corresponding 3-node (linear) triangulation;

TRIANGULATION_Q2L, a FORTRAN90 program which reads information about a 6-node (quadratic) triangulation and creates data defining a corresponding 3-node (linear) triangulation;

TRIANGULATION_Q2L, a MATLAB program which reads information about a 6-node (quadratic) triangulation and creates data defining a corresponding 3-node (linear) triangulation;

TRIANGULATION_QUAD, a C++ program which estimates the integral of a function over a triangulated region.

TRIANGULATION_QUAD, a FORTRAN90 program which estimates the integral of a function over a triangulated region.

TRIANGULATION_QUAD, a MATLAB program which estimates the integral of a function over a triangulated region.

TRIANGULATION_QUALITY, a C++ program which computes quality measures of a triangulation.

TRIANGULATION_QUALITY, a FORTRAN90 program which computes quality measures of a triangulation.

TRIANGULATION_QUALITY, a MATLAB program which computes quality measures of a triangulation.

TRIANGULATION_RCM, a C++ program which reads files describing a triangulation of nodes in 2D, and applies the Reverse Cuthill McKee (RCM) algorithm to produce a renumbering of the triangulation with a reduced bandwidth.

TRIANGULATION_RCM, a FORTRAN90 program which reads files describing a triangulation of nodes in 2D, and applies the Reverse Cuthill McKee (RCM) algorithm to produce a renumbering of the triangulation with a reduced bandwidth.

TRIANGULATION_RCM, a MATLAB program which reads files describing a triangulation of nodes in 2D, and applies the Reverse Cuthill McKee (RCM) algorithm to produce a renumbering of the triangulation with a reduced bandwidth.

TRIANGULATION_REFINE, a C++ program which refines a triangulation.

TRIANGULATION_REFINE, a FORTRAN90 program which refines a triangulation.

TRIANGULATION_REFINE, a MATLAB program which refines a triangulation.

TRIANGULATION_REFINE_LOCAL, a MATLAB program which refines a triangulation locally; a single triangular element is replaced by four smaller triangles, and neighboring information is updated.

TRIANGULATION_SVG, a C program which creates a Scalable Vector Graphics (SVG) image of a triangulation, which can be displayed by a web browser.

TRIANGULATION_SVG, a C++ program which creates a Scalable Vector Graphics (SVG) image of a triangulation, which can be displayed by a web browser.

TRIANGULATION_SVG, a FORTRAN77 program which creates a Scalable Vector Graphics (SVG) image of a triangulation, which can be displayed by a web browser.

TRIANGULATION_SVG, a FORTRAN90 program which creates a Scalable Vector Graphics (SVG) image of a triangulation, which can be displayed by a web browser.

TRIANGULATION_SVG, a MATLAB program which creates a Scalable Vector Graphics (SVG) image of a triangulation, which can be displayed by a web browser.

TRIANGULATION_T3_TO_T4, a C++ program which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation (vertices + centroid);

TRIANGULATION_T3_TO_T4, a FORTRAN90 program which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation (vertices + centroid);

TRIANGULATION_T3_TO_T4, a MATLAB program which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation (vertices + centroid);

TRIANGULATION_TRIANGLE_NEIGHBORS, a C program which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.

TRIANGULATION_TRIANGLE_NEIGHBORS, a C++ program which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.

TRIANGULATION_TRIANGLE_NEIGHBORS, a FORTRAN90 program which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.

TRIANGULATION_TRIANGLE_NEIGHBORS, a MATLAB program which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.

TRIG_TO_NEIB, a C program which reads NODE and ELE files (a format prescribed by triangle) describing a triangulation, and produces a file defining the neighbor triangles of each element, and information about the Voronoi diagram, by Lili Ju.

TRIMMOMATIC, examples which illustrate the use of TRIMMOMATIC, which is a collectionn of programs which can apply various filters to trim Illumina NGS sequence data.

TRINITYRNASEQ, examples which illustrate the use of TRINITYRNASEQ, which is a program which assembles transcript sequences from Illumina RNA-Seq data.

TRIOLA, a dataset directory which contains datasets used for statistical analysis.

TRIPACK, a FORTRAN77 library which computes the Delaunay triangulation of points in the plane, ACM TOMS algorithm 751, by Robert Renka.

TRIPACK, a FORTRAN90 library which computes the Delaunay triangulation of points in the plane, ACM TOMS algorithm 751, by Robert Renka.

TRUEL_SIMULATION, a MATLAB program which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.

TRUNCATED_NORMAL, a C library which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.

TRUNCATED_NORMAL, a C++ library which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.

TRUNCATED_NORMAL, a FORTRAN77 library which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.

TRUNCATED_NORMAL, a FORTRAN90 library which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.

TRUNCATED_NORMAL, a MATLAB library which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.

TRUNCATED_NORMAL, a Python library which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.

TRUNCATED_NORMAL_RULE, a C program which computes a quadrature rule for a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].

TRUNCATED_NORMAL_RULE, a C++ program which computes a quadrature rule for a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].

TRUNCATED_NORMAL_RULE, a FORTRAN77 program which computes a quadrature rule for a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].

TRUNCATED_NORMAL_RULE, a FORTRAN90 program which computes a quadrature rule for a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].

TRUNCATED_NORMAL_RULE, a MATLAB program which computes a quadrature rule for a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].

TRUNCATED_NORMAL_RULE, a Python program which computes a quadrature rule for a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].

TRUNCATED_NORMAL_SPARSE_GRID, a MATLAB program which computes a sparse grid based on a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].

TSEARCH, a MATLAB library which compares several replacements for MATLAB's obsolete tsearch() function, which searched a Delaunay triangulation to find the triangle that encloses a given point.

TSG, C++ programs which demonstrate the use of the TasmanianSparseGrid package, which implements routines for working with sparse grids, to efficiently estimate integrals or compute interpolants of scalar functions of multidimensional arguments, by Miroslav Stoyanov.

TSG, FORTRAN90 programs which demonstrate the use of the TasmanianSparseGrid package, which implements routines for working with sparse grids, to efficiently estimate integrals or compute interpolants of scalar functions of multidimensional arguments. The FORTRAN90 version is an experimental and limited interface to the C++ library, by Miroslav Stoyanov.

TSG, a MATLAB library which demonstrate the use of the TasmanianSparseGrid package, which implements routines for working with sparse grids, to efficiently estimate integrals or compute interpolants of scalar functions of multidimensional arguments. The MATLAB version is an interface to the C++ library, by Miroslav Stoyanov.

tsp, a dataset directory which contains test data for the traveling salesperson problem;

tsp_brute, a C program which reads a file of city-to-city distances and solves the traveling salesperson problem, using brute force.

tsp_brute, a C++ program which reads a file of city-to-city distances and solves the traveling salesperson problem, using brute force.

tsp_brute, a FORTRAN77 program which reads a file of city-to-city distances and solves the traveling salesperson problem, using brute force.

tsp_brute, a FORTRAN90 program which reads a file of city-to-city distances and solves the traveling salesperson problem, using brute force.

tsp_brute, a MATLAB program which reads a file of city-to-city distances and solves the traveling salesperson problem, using brute force.

tsp_brute, a Python script which reads a file of city-to-city distances and solves the traveling salesperson problem, using brute force.

tsp_brute_test

tsp_brute_test

tsp_descent is a MATLAB program which is given a city-to-city distance map, chooses an initial tour at random, and then tries a number of simple variations, seeking to quickly find a tour of lower cost.

tsp_greedy, a MATLAB program which reads a file of city-to-city distances, picks a starting city, and then successively visits the nearest unvisited city.

tsp_random, a MATLAB program which reads a file of city-to-city distances, and then randomly samples a number of possible tours, to quickly seek a tour of lower length.

TSP_IO, a FORTRAN90 library which reads or writes files in the TSP format used for examples of the traveling salesperson problem.

TSP_LAU, a FORTRAN90 library which implements a heuristic algorithm for the solution of the traveling salesperson problem.

TUMOR, a MATLAB program which demonstrates a model of tumor growth;

TWO_BODY_SIMULATION, a FORTRAN90 program which simulates the behavior of two bodies, constrained to lie in a plane, moving under the influence of gravity, with one body much more massive than the other, creating graphics files for processing by gnuplot.

TWO_BODY_SIMULATION, a MATLAB program which simulates the behavior of two bodies, constrained to lie in a plane, moving under the influence of gravity, with one body much more massive than the other.

TWOD, a MATLAB library which contains functions useful for implementing the finite element method (FEM) over a 2D region, by Jeff Borggaard.

TWOD_PLOTC, a MATLAB program which makes a color contour plot of scalar data defined on a 2D mesh associated with the finite element method (FEM), by Jeff Borggaard.

TWOD_TO_VTK, a MATLAB program which accepts finite element method (FEM) data computed for a 2D fluid governed by the Navier Stokes equations (NSE) and writes it to a VTK legacy file for postprocessing by the paraview interactive visualization program.

TWOD_TO_VTU, (archived) a MATLAB program which accepts finite element method (FEM) data computed for a 2D fluid governed by the Navier Stokes equations (NSE) and writes it to a VTK unstructured grid file for postprocessing by the paraview interactive visualization program.

TXT_TO_DAT, a FORTRAN77 program which demonstrates how to copy text data into a binary file.

UBVEC, a C library which demonstrates how unsigned binary vectors, strings of 0's and 1's, can represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.

UBVEC, a C++ library which demonstrates how unsigned binary vectors, strings of 0's and 1's, can represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.

UBVEC, a FORTRAN90 library which demonstrates how unsigned binary vectors, strings of 0's and 1's, can represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.

UBVEC, a MATLAB library which demonstrates how unsigned binary vectors, strings of 0's and 1's, can represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.

UBVEC, a Python library which demonstrates how unsigned binary vectors, strings of 0's and 1's, can represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.

UCD, a data directory which contains examples of Unstructured Cell Data (UCD), a format supported by AVS.

umfpack_test, C programs which call umfpack to solve a sparse linear system.

umfpack_test, C++ programs which call umfpack to solve a sparse linear system.

UMFPACK, FORTRAN77 programs which illustrate how to solve a sparse linear system by calling the C library UMFPACK, by Timothy Davis.

umfpack_test, FORTRAN90 programs which call umfpack to solve a sparse linear system.

UMFPACK_2.0, a FORTRAN77 library which solves unsymmetric sparse linear systems, this is an obsolete FORTRAN77 version of UMFPACK, which has since been rewritten in C, by Timothy Davis, Iain Duff.

UNCMIN, a FORTRAN77 library which seeks the unconstrained minimization of a scalar function of several variables.

UNCONTROL, a C++ program which makes a copy of a text file which contains no control characters.

UNICYCLE, a C library which considers permutations containing a single cycle, sometimes called cyclic permutations.

UNICYCLE, a C++ library which considers permutations containing a single cycle, sometimes called cyclic permutations.

UNICYCLE, a FORTRAN77 library which considers permutations containing a single cycle, sometimes called cyclic permutations.

UNICYCLE, a FORTRAN90 library which considers permutations containing a single cycle, sometimes called cyclic permutations.

UNICYCLE, a MATLAB library which considers permutations containing a single cycle, sometimes called cyclic permutations.

UNICYCLE, a Python library which considers permutations containing a single cycle, sometimes called cyclic permutations.

UNIFORM, a dataset directory which contains samples from uniform random number generators (RNG's).

UNIFORM, a C library which contains uniform random number generators (RNG's) for several arithmetic types.

UNIFORM, a C++ library which contains uniform random number generators (RNG's) for several arithmetic types.

UNIFORM, a FORTRAN77 library which contains uniform random number generators (RNG's) for several arithmetic types.

UNIFORM, a FORTRAN90 library which contains uniform random number generators (RNG's) for several arithmetic types.

UNIFORM, a MATHEMATICA library which contains uniform random number generators (RNG's) for several arithmetic types.

UNIFORM, a MATLAB library which contains uniform random number generators (RNG's) for several arithmetic types.

UNIFORM, a Python library which contains uniform random number generators (RNG's) for several arithmetic types.

UNIFORM_DATASET, a C++ program which generates a dataset of uniform pseudorandom values and writes them to a file.

UNIFORM_DATASET, a FORTRAN90 program which generates a dataset of multivariate uniform pseudorandom values and writes them to a file.

UNIFORM_DATASET, a MATLAB program which generates a dataset of uniform pseudorandom values and writes them to a file.

UPC, a C library which can determine the check digit for a Uniform Product Code (UPC) or report whether a given UPC is valid.

UPC, a C++ library which can determine the check digit for a Uniform Product Code (UPC) or report whether a given UPC is valid.

UPC, a FORTRAN90 library which can determine the check digit for a Uniform Product Code (UPC) or report whether a given UPC is valid.

UPC, a MATLAB library which can determine the check digit for a Uniform Product Code (UPC) or report whether a given UPC is valid.

UPC, a Python library which can determine the check digit for a Uniform Product Code (UPC) or report whether a given UPC is valid.

USA_CVT_GEO, MATLAB programs which explore the creation of a centroidal Voronoi Tessellation (CVT) of the continental United States, based solely on geometric considerations.

UUID, examples which illustrate the use of UUID, which is a program which generates universally unique identifiers.

valgrind_test C programs which illustrate the use of the valgrind suite of programs which includes a memory leak detector.

valgrind_test C++ programs which illustrate the use of the valgrind suite of programs which includes a memory leak detector.

valgrind_test, examples which illustrate the use of VALGRIND, which reports illegal memory references, use of uninitialized variables, and memory leaks;

VALGRIND FORTRAN77 programs which illustrate the use of the valgrind suite of programs which includes a memory leak detector.

VALGRIND FORTRAN90 programs which illustrate the use of the valgrind suite of programs which includes a memory leak detector.

VAN_DER_CORPUT, a dataset directory which contains examples of the one-dimensional van der Corput, for various bases;

VAN_DER_CORPUT, a C library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.

VAN_DER_CORPUT, a C++ library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.

VAN_DER_CORPUT, a FORTRAN90 library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.

VAN_DER_CORPUT, a MATLAB library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.

VAN_DER_CORPUT, a Python library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.

VAN_DER_CORPUT_ADVANCED, a C++ library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence, allowing the user more advanced and sophisticated input.

VAN_DER_CORPUT_ADVANCED, a FORTRAN90 library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence, allowing the user more advanced and sophisticated input.

VAN_DER_CORPUT_ADVANCED, a MATLAB library which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence, allowing the user more advanced and sophisticated input.

VAN_DER_CORPUT_DATASET, a C++ program which creates a van der Corput Quasi Monte Carlo (QMC) sequence and writes it to a file.

VAN_DER_CORPUT_DATASET, a FORTRAN90 program which creates a van der Corput Quasi Monte Carlo (QMC) sequence and writes it to a file.

VAN_DER_CORPUT_DATASET, a MATLAB program which creates a van der Corput Quasi Monte Carlo (QMC) sequence and writes it to a file.

VANDERMONDE, a C library which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.

VANDERMONDE, a C++ library which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.

VANDERMONDE, a FORTRAN77 library which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.

VANDERMONDE, a FORTRAN90 library which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.

VANDERMONDE, a MATLAB library which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.

VANDERMONDE_APPROX_1D, a C library which finds a polynomial approximant to data of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_APPROX_1D, a C++ library which finds a polynomial approximant to data of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_APPROX_1D, a FORTRAN77 library which finds a polynomial approximant to data of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_APPROX_1D, a FORTRAN90 library which finds a polynomial approximant to data of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_APPROX_1D, a MATLAB library which finds a polynomial approximant to data of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_APPROX_2D, a C library which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.

VANDERMONDE_APPROX_2D, a C++ library which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.

VANDERMONDE_APPROX_2D, a FORTRAN77 library which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.

VANDERMONDE_APPROX_2D, a FORTRAN90 library which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.

VANDERMONDE_APPROX_2D, a MATLAB library which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.

VANDERMONDE_INTERP_1D, a C library which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix, creating graphics files for processing by gnuplot.

VANDERMONDE_INTERP_1D, a C++ library which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix, creating graphics files for processing by gnuplot.

VANDERMONDE_INTERP_1D, a FORTRAN77 library which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix, creating graphics files for processing by gnuplot.

VANDERMONDE_INTERP_1D, a FORTRAN90 library which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix, creating graphics files for processing by gnuplot.

VANDERMONDE_INTERP_1D, a MATLAB library which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_INTERP_1D, a Python library which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_INTERP_2D, a C library which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_INTERP_2D, a C++ library which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_INTERP_2D, a FORTRAN77 library which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_INTERP_2D, a FORTRAN90 library which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.

VANDERMONDE_INTERP_2D, a MATLAB library which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.

VASP, examples which illustrate the use of VASP, which is a program which performs ab-initio quantum-mechanical molecular dynamics (MD) simulations using pseudopotentials or the projector-augmented wave method and a plane wave basis set.

VASP-GPU, examples which illustrate the use of VASP-GPU, which is a GPU version of the VASP molecular dynamics program.

VEC_IO, a FORTRAN90 library which reads and writes vectors of fixed size, to and from a disk file, in any order;

vector_magnitude_grid, a MATLAB program which reads vector data at scattered points, computes an interpolatory function, evaluates it on a uniform grid of user-specified density, and produces a contour plot of the vector magnitude.

vector_plot, a FORTRAN90 program which plots velocity fields and the velocity direction fields.

vector_read, a C++ library which reads, one line at a time, numeric data, storing it in a vector returned to the user;

velvet, examples which illustrate the use of VELVET, which is a program for de novo genome assembly and short read sequencing alignments.

viennacl, examples which illustrate the use of VIENNACL, which is the Vienna Computing Library, a free open-source scientific computing library written in C++, providing CUDA, OpenCL and OpenMP computing backends.

visit, examples which illustrate the use of the visit interactive graphics program.

voronoi_city, a MATLAB program which displays the steps involved in computing the Voronoi diagram of 3 points, which we think of as cities connected by roads.

voronoi_diagram, examples which illustrate the computation and use of a Voronoi diagram.

voronoi_display, a MATLAB program which computes the exact Voronoi diagram using geompack(), and displays it.

voronoi_mountains, a MATLAB program which makes a mountain plot of a Voronoi diagram, that is, a surface plot of the distance from each point to its nearest Voronoi generator.

voronoi_neighbors, a MATLAB program which is given a set of points in the plane and determines the Voronoi adjacency structure, that is, which points share an edge of the Voronoi diagram.

voronoi_plot, a FORTRAN90 program which plots the Voronoi neighborhoods of points in the 2D unit square, using L1, L2, LInfinity or arbitrary LP norms;

voronoi_plot, a MATLAB program which plots the Voronoi neighborhoods of points using L1, L2, LInfinity or arbitrary LP norms;

voronoi_plot, a Python program which plots the Voronoi neighborhoods of points in the 2D unit square, using L1, L2, LInfinity or arbitrary LP norms;

voronoi_test, a Python script which demonstrates the use of the scipy.spatial function Voronoi(), to compute a Voronoi diagram, and voronoi_plot_2d(), to display it.

voronoi_weight, a FORTRAN90 program which estimates the volume of the Voronoi cells associated with N points in the M dimensional unit hypercube;

vpa, MATLAB programs which use the Variable Precision Arithmetic (VPA) feature of the Symbolic Math Toolbox to compute arbitrary precision quantities.

vtk, a data directory which contains examples of legacy VTK files, a file format used by the Visualization Toolkit, and which can be displayed by programs such as paraview and visit;

vtk_io, a FORTRAN90 library which reads and writes files in the VTK format.

vts, a data directory which contains examples of VTS files, a file format used by the Visualization Toolkit, which contains information associated with a curvilinear or structured grid, which can be displayed by the paraview interactive visualization program;

vtu, (archived) a data directory which contains examples of VTU files, an XML-based file format used by the Visualization Toolkit for unstructured grids, which can be displayed by the paraview interactive visualization program;

vu, a data directory which contains examples of VU files, a file format used by the VU program;

walker_sample, a C library which efficiently samples a discrete probability vector using Walker sampling.

walker_sample, a C++ library which efficiently samples a discrete probability vector using Walker sampling.

walker_sample, a FORTRAN90 library which efficiently samples a discrete probability vector using Walker sampling.

walker_sample, a MATLAB library which efficiently samples a discrete probability vector using Walker sampling.

walker_sample, a Python library which efficiently samples a discrete probability vector using Walker sampling.

walsh, a C library which implements versions of the Walsh and Haar transforms.

walsh, a C++ library which implements versions of the Walsh and Haar transforms.

walsh, a FORTRAN77 library which implements versions of the Walsh and Haar transforms.

walsh, a FORTRAN90 library which implements versions of the Walsh and Haar transforms.

walsh, a MATLAB library which implements versions of the Walsh and Haar transforms.

walsh, a Python library which implements versions of the Walsh and Haar transforms.

wannier90, examples which illustrate the wannier90 program which computes maximally localized Wannier functions, for solving the electronic structure of periodic materials.

wathen, a C library which compares storage schemes (full, banded, sparse triplet) and solution strategies (Linpack full, Linpack banded, conjugate gradient (CG)) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).

wathen, a C++ library which compares storage schemes (full, banded, sparse triplet) and solution strategies (Linpack full, Linpack banded, conjugate gradient (CG)) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).

wathen, a FORTRAN77 library which compares storage schemes (full, banded, sparse triplet) and solution strategies (Linpack full, Linpack banded, conjugate gradient (CG)) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).

wathen, a FORTRAN90 library which compares storage schemes (full, banded, sparse triplet) and solution strategies (Linpack full, Linpack banded, conjugate gradient (CG)) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).

wathen, a MATLAB library which compares storage schemes (full, banded, sparse triplet, sparse) and solution strategies (A\x, Linpack, conjugate gradient (CG)) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).

wathen, a Python library which compares storage schemes (full, banded, sparse triplet, sparse) and solution strategies (A\x, Linpack, conjugate gradient (CG)) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).

wave_mpi, a C program which uses the finite difference method (FDM) to estimate a solution to the wave equation, using MPI for parallel execution.

wave_mpi, a C++ program which uses the finite difference method (FDM) to estimate a solution to the wave equation, using MPI for parallel execution.

wave_mpi, a FORTRAN77 program which uses the finite difference method (FDM) to estimate a solution to the wave equation, using MPI for parallel execution.

wave_mpi, a FORTRAN90 program which uses the finite difference method (FDM) to estimate a solution to the wave equation, using MPI for parallel execution.

wavelet, a C library which does some simple calculations with wavelet transforms;

wavelet, a C++ library which does some simple calculations with wavelet transforms;

wavelet, a FORTRAN77 library which does some simple calculations with wavelet transforms;

wavelet, a FORTRAN90 library which does some simple calculations with wavelet transforms;

wavelet, a MATLAB library which does some simple calculations with wavelet transforms;

wedge_exactness, a C program which investigates the monomial exactness of a quadrature rule over the interior of the unit wedge in 3D.

wedge_exactness, a C++ program which investigates the monomial exactness of a quadrature rule over the interior of the unit wedge in 3D.

wedge_exactness, a FORTRAN77 program which investigates the monomial exactness of a quadrature rule over the interior of the unit wedge in 3D.

wedge_exactness, a FORTRAN90 program which investigates the monomial exactness of a quadrature rule over the interior of the unit wedge in 3D.

wedge_exactness, a MATLAB program which investigates the monomial exactness of a quadrature rule over the interior of the unit wedge in 3D.

wedge_felippa_rule, a C library which returns quadratures rules for approximating integrals over the interior of the unit wedge in 3D.

wedge_felippa_rule, a C++ library which returns quadratures rules for approximating integrals over the interior of the unit wedge in 3D.

wedge_felippa_rule, a FORTRAN77 library which returns quadratures rules for approximating integrals over the interior of the unit wedge in 3D.

wedge_felippa_rule, a FORTRAN90 library which returns quadratures rules for approximating integrals over the interior of the unit wedge in 3D.

wedge_felippa_rule, a MATLAB library which returns quadratures rules for approximating integrals over the interior of the unit wedge in 3D.

wedge_grid, a C library which computes a grid of points over the interior of the unit wedge in 3D.

wedge_grid, a C++ library which computes a grid of points over the interior of the unit wedge in 3D.

wedge_grid, a FORTRAN77 library which computes a grid of points over the interior of the unit wedge in 3D.

wedge_grid, a FORTRAN90 library which computes a grid of points over the interior of the unit wedge in 3D.

wedge_grid, a MATLAB library which computes a grid of points over the interior of the unit wedge in 3D.

wedge_grid, a Python library which computes a grid of points over the interior of the unit wedge in 3D.

wedge_integrals, a C library which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.

wedge_integrals, a C++ library which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.

wedge_integrals, a FORTRAN77 library which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.

wedge_integrals, a FORTRAN90 library which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.

wedge_integrals, a MATLAB library which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.

wedge_integrals, a Python library which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.

wedge_monte_carlo, a C library which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.

wedge_monte_carlo, a C++ library which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.

wedge_monte_carlo, a FORTRAN77 library which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.

wedge_monte_carlo, a FORTRAN90 library which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.

wedge_monte_carlo, a MATLAB library which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.

wedge_monte_carlo, a Python library which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.

weekday, a C library which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.

weekday, a C++ library which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.

weekday, a FORTRAN77+ library which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.

weekday, a FORTRAN90 library which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.

weekday, a MATLAB library which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.

width, a C++ program which returns the length and location of the longest line in a text file;

will_you_be_alive, a MATLAB library which contains the scripts used to carry out the probability simulations described in Paul Nahin's "Will You Be Alive 10 Years From Now?";

wishart, a C library which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.

wishart, a C++ library which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.

wishart, a FORTRAN77 library which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.

wishart, a FORTRAN90 library which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.

wishart, a MATLAB library which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.

words, a dataset directory which contains lists of words;

wordsnake, a FORTRAN90 program which rearranges a list of words so that they have maximum overlap;

wrap, a C++ program which makes a copy of a text file in which no line is longer than a user-specified wrap length.

wrap2, a C++ program which wraps long lines in a text file, but which wraps some lines early, so as to avoid breaking words.

wrf, examples which illustrate the use of WRF, which is a numerical weather prediction program.

wtime, a C library which returns a reading of the wall clock time in seconds.

wtime, a C++ library which returns a reading of the wall clock time in seconds.

wtime, a FORTRAN77 library which returns a reading of the wall clock time in seconds.

wtime, a FORTRAN90 library which returns a reading of the wall clock time in seconds.

wtime, a MATLAB library which returns a reading of the wall clock time in seconds.

wtime, a Python library which returns a reading of the wall clock time in seconds.

x_window_test, C programs which demonstrates some simple uses of the X Window library.

x_window_test, C++ programs which demonstrates some simple uses of the X Window library.

x_window_display, examples which illustrate the problems that arise when trying to use an X-window program remotely.

x264, examples which illustrate the use of X264, which is a library for encoding video streams into the H.264/MPEG-4 AVC format.

xboids, a C program which simulates the behavior of a flying flock of animals, displaying the results using X Windows, by Conrad Parker.

xdr, a C library which allows a user to transfer data between computers which have different data storage conventions.

xerror, a FORTRAN77 library which reports and handles errors detected during program execution.

xerror, a FORTRAN90 library which reports and handles errors detected during program execution.

xising, a C program which simulates the variation in ferromagnetism in a material, displaying the results using X Windows, by Michael Creutz.

xlf_intrinsicsS, a FORTRAN90 program which demonstrates the use of intrinsic functions supplied by the IBM XLF compiler for FORTRAN90.

xls_io , R programs which illustrate how data can be shared between Microsoft EXCEL and R, using XLS and CSV files.

xml, a data directory which contains examples of XML files, a standard, general datafile format.

xml_to_fem, a Python program which reads an XML file created by FENICS or DOLFIN, describing a mesh in 1D, 2D, or 3D, and creates corresponding FEM files, namely, a file of node coordinates, and a file of element connectivities.

xml2struct, a MATLAB program which reads an XML file and converts the data into a MATLAB struct.

xwaves, a C program which simulates the behavior of solution of certain forms of the wave equation, displaying the results using X Windows, by Michael Creutz.

xy, a data directory which contains examples of XY files, a simple 2D graphics point format;

xy_display, a MATLAB program which reads XY information defining points in 2D, and displays an image in a MATLAB graphics window;

xy_display_opengl, a C++ program which reads XY information defining points in 2D, and displays an image using OpenGL.

xy_io, a C++ library which reads and writes files in the XY, XYL and XYF formats.

xy_io, a FORTRAN90 library which reads and writes files in the XY, XYL and XYF formats.

xy_io, a MATLAB library which reads and writes files in the XY, XYL and XYF formats.

xyf, a data directory which contains examples of XYF files, a simple 2D graphics point and face format;

xyf_display, a MATLAB program which reads XYF information defining points and faces in 2D, and displays an image in a MATLAB graphics window.

xyf_display_opengl, a C++ program which reads XYF information defining points and faces in 2D, and displays an image using OpenGL.

xyl, a data directory which contains examples of XYL files, a simple 2D graphics point and line format;

xyl_display, a MATLAB program which reads XYL information defining points and lines in 2D, and displays an image in a MATLAB graphics window.

xyl_display_opengl, a C++ program which reads XYL information defining points and lines in 2D, and displays an image using OpenGL.

xyz, a data directory which contains examples of XYZ files, a simple 3D graphics point format;

xyz_display, a MATLAB program which reads XYZ information defining points in 3D, and displays an image in the MATLAB graphics window.

xyz_display_opengl, a C++ program which reads XYZ information defining points in 3D, and displays an image using OpenGL.

xyz_io, a C++ library which reads and writes files in the XYZ, XYZL, and XYZF formats.

xyz_io, a FORTRAN90 library which reads and writes files in the XYZ, XYZL, and XYZF formats.

xyz_io, a MATLAB library which reads and writes files in the XYZ, XYZL, and XYZF formats.

xyz_plot, a FORTRAN90 program which an interactive plotter.

xyz_to_pdb, a FORTRAN90 program which reads an XYZ file of spatial coordinates, and rewrites the information as atomic coordinates in a Protein Data Base (PDB) file.

xyzf, a data directory which contains examples of XYZF files, a simple 3D graphics point and face format;

xyzf_display, a MATLAB program which reads XYZF information defining points and faces in 3D, and displays an image using OpenGL.

xyzf_display_opengl, a C++ program which reads XYZF information defining points and faces in 3D, and displays an image using OpenGL.

xyzl, a data directory which contains examples of XYZL files, a simple 3D graphics point and l

xyzl_display, a MATLAB program which reads XYZL information defining points and lines in 3D, and displays an image in a MATLAB graphics window.

xyzl_display_opengl, a C++ program which reads XYZL information defining points and lines in 3D, and displays an image using OpenGL.

yasm examples which illustrate the use of YASM, which is an assembler program that supports multiple assembler syntaxes, including NASM and GNU AS, as well as multiple output object formats and instruction sets.

zero_rc, a C library which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.

zero_rc, a C++ library which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.

zero_rc, a FORTRAN77 library which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.

zero_rc, a FORTRAN90 library which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.

zero_rc, a MATLAB library which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.

zero_rc, a Python library which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.

ziggurat, a C library which implements uniform, normal and exponential random number generators (RNG's) using the ziggurat method, by Marsaglia and Tsang.

ziggurat, a C++ library which implements uniform, normal and exponential random number generators (RNG's) using the ziggurat method, by Marsaglia and Tsang.

ziggurat, a FORTRAN77 library which implements uniform, normal and exponential random number generators (RNG's) using the ziggurat method, by Marsaglia and Tsang.

ziggurat, a FORTRAN90 library which implements uniform, normal and exponential random number generators (RNG's) using the ziggurat method, by Marsaglia and Tsang.

ziggurat, a MATLAB library which implements uniform, normal and exponential random number generators (RNG's) using the ziggurat method, by Marsaglia and Tsang.

ziggurat_inline, a C library which implements uniform, normal and exponential random number generators (RNG's) using the ziggurat method, by Marsaglia and Tsang. In this version, the underlying generators are implemented inline, for increased speed.

ziggurat_inline, a C++ library which implements uniform, normal and exponential random number generators (RNG's) using the ziggurat method, by Marsaglia and Tsang. In this version, the underlying generators are implemented inline, for increased speed.

ziggurat_openmp, a C program which demonstrates the use of the ziggurat library as a random number generator (RNG) in an OpenMP parallel program.

ziggurat_openmp, a C++ program which demonstrates the use of the ziggurat library as a random number generator (RNG) in an OpenMP parallel program.

ziggurat_openmp, a FORTRAN77 program which demonstrates the use of the ziggurat library as a random number generator (RNG) in an OpenMP parallel program.

ziggurat_openmp, a FORTRAN90 program which demonstrates the use of the ziggurat library as a random number generator (RNG) in an OpenMP parallel program.

zlib examples which illustrate the use of ZLIB, which is a lossless data compression library.

zombies, a MATLAB library which uses a generalized SIR infection model to simulate a zombie attack, developed by Philip Munz.

You can go up one level to the HTML page,.


Last revised on 27 November 2018.