1brc_data, a C code which creates a file of randomly generated temperature readings to be associated with weather stations at 413 world cities. A file like this, with 1 billion records, is used for the one billion row challenge.
1brc_naive, a C code which reads a file of randomly generated temperature readings, associated with weather stations at 413 world cities, and computes the minimum, mean, and maximum temperature for each weather station. It also reports the total execution time. Processing such a data file with one billion records is the substance of the one billion record challenge (1BRC).
abaqus, examples which use ABAQUS, which is a finite element code specifically designed for structural engineering problems, with additional modules for computational fluid dynamics and for electromagnetic problems.
adamsbashforth, an R code which uses an Adams Bashforth method to solve an ordinary differential equation (ODE).
adaptint, an R code which estimates an integral using an adaptive midpoint quadrature rule.
adjacency, a dataset directory which contains adjacency matrices associated with an undirected graph.
advection_pde, a MATLAB code which solves the advection PDE dudt + c * dudx = 0 in one spatial dimension and time, with a constant velocity c, and periodic boundary conditions, using the forward time centered space (FTCS) difference method.
advection_pde, an Octave code which solves the advection PDE dudt + c * dudx = 0 in one spatial dimension and time, with a constant velocity c, and periodic boundary conditions, using the forward time centered space (FTCS) difference method.
aitch, a Fortran90 code which solves for flow in an H-shaped region.
allen_cahn_pde, a MATLAB code which sets up and solves the Allen-Cahn reaction-diffusion system of partial differential equations (PDE) in 1 space dimension and time.
allen_cahn_pde, an Octave code which sets up the Allen-Cahn reaction-diffusion system of partial differential equations (PDE) in 1 space dimension and time.
allen_cahn_pde, a Python code which sets up the Allen-Cahn reaction-diffusion system of partial differential equations (PDE) in 1 space dimension and time.
allen_cahn_pde_etdrk4_test a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Allen-Cahn system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
allen_cahn_pde_etdrk4_test an Octave code which uses the exponential time differencing (ETD) RK4 method to solve the Allen-Cahn system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
allen_cahn_pde_euler a MATLAB code which uses the Euler method to solve the Allen-Cahn PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
allen_cahn_pde_euler an Octave code which uses the Euler method to solve the Allen-Cahn PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
allocatable_array_test, a C code 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_test, a C++ code 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_test, a Fortran90 code which demonstrates how to 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 caller.
alpert_rule, a C code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
alpert_rule, a C++ code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
alpert_rule, a Fortran90 code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
alpert_rule, a MATLAB code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
alpert_rule, an Octave code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
alpert_rule, a Python code which sets up an Alpert quadrature rule for functions which are regular, log(x) singular, or 1/sqrt(x) singular.
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++ code which determines anagrams of a string, by James Cherry;
analemma, a C code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot(), based on a C code by Brian Tung.
analemma, a C++ code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot(), based on a C code by Brian Tung.
analemma, a Fortran77 code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot(), based on a C code by Brian Tung.
analemma, a Fortran90 code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot(), based on a C code by Brian Tung.
analemma, a MATLAB code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, based on a C code by Brian Tung.
analemma, an Octave code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, based on a C code by Brian Tung.
analemma, a Python code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data that can be plotted by gnuplot(), based on a C code by Brian Tung.
animation_test, an Octave code which demonstrates how to create an animation as a GIF.
animation_test, a Python code which computes a sequence of solutions to a partial differential equation (PDE), using matplotlib(), displaying each solution to the screen without requiring the user to hit RETURN to see the next image.
anishchenko_ode, a MATLAB code which sets up and solves the Anishchenko ordinary differential equation (ODE), which has chaotic behavior and an attractor.
anishchenko_ode, an Octave code which sets up and solves the Anishchenko ordinary differential equation (ODE), which has chaotic behavior and an attractor.
anishchenko_ode, a Python code which sets up and solves the Anishchenko ordinary differential equation (ODE), which has chaotic behavior and an attractor.
ann, a C++ code which computes Approximate Nearest Neighbors, by David Mount, Sunil Arya;
ann_test, a C++ code which uses ann() to approximate the nearest neighbors of points stored in a file, by David Mount, Sunil Arya;
ann_to_fig, a C++ code which plots the search tree used by ann() while seeking the approximate nearest neighbors of points, by David Mount, Sunil Arya;
annulus_distance, a MATLAB code which estimates the typical distance between a pair of points randomly selected inside a circular annulus.
annulus_distance, an Octave code which estimates the typical distance between a pair of points randomly selected inside a circular annulus.
annulus_distance, a Python code which estimates the typical distance between a pair of points randomly selected inside a circular annulus.
annulus_flow, a FENICS code which simulates flow in a circular annulus, goverened by the time-dependent Navier Stokes equations (NSE).
annulus_grid, a MATLAB code which computes a grid of points over the interior of a circular annulus.
annulus_grid, an Octave code which computes a grid of points over the interior of a circular annulus.
annulus_grid, a Python code which computes a grid of points over the interior of a circular annulus.
annulus_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of a circular annulus centered at the origin.
annulus_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of a circular annulus centered at the origin.
annulus_integrals, a Python code which returns the exact value of the integral of any monomial over the interior of a circular annulus centered at the origin.
annulus_monte_carlo, a C code 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++ code 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 code 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 code 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 an Octave code which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.
-
annulus_rule, a C code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
annulus_rule, a C++ code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
annulus_rule, a Fortran90 code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
annulus_rule, a MATLAB code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
annulus_rule, an Octave code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
annulus_rule, a Python code which computes a quadrature rule for estimating integrals of a function over the interior of a circular annulus in 2D.
ansys, examples which use ANSYS, which provides solutions to physical problems posed in almost any area of engineering. ANSYS can handle fluids, structures, electronics, semiconductors, systems, and multiphysics.
aperiodic_tile, a MATLAB code which constructs several steps in the aperiodic tiling of the plane, using the monotile T(1,1), displaying the result graphically, by Henning Voss.
aperiodic_tile, an Octave code which constructs several steps in the aperiodic tiling of the plane, using the monotile T(1,1), displaying the result graphically, by Henning Voss.
apportionment, a Fortran90 code which demonstrates some of the methods used or proposed for fairly assigning seats in the House of Representatives to each state;
approx_bernstein, a MATLAB code which interactively approximates a function f(x) in the interval [a,b] by constructing a Bernstein polynomial of order n.
approx_bernstein, an Octave code which interactively approximates a function f(x) in the interval [a,b] by constructing a Bernstein polynomial of order n.
approx_bernstein, a Python code which approximates a function f(x) in the interval [a,b] by constructing a Bernstein polynomial of order n.
approx_chebyshev, a MATLAB code which interactively approximates a function f(x) in the interval [a,b] by constructing a Chebyshev polynomial interpolant that is often a good estimate of the minmax polynomial.
approx_chebyshev, an Octave code which interactively approximates a function f(x) in the interval [a,b] by constructing a Chebyshev polynomial interpolant that is often a good estimate of the minmax polynomial.
approx_leastsquares, a MATLAB code which interactively approximates a function f(x) in the interval [a,b] by constructing an m-degree polynomial which minimizes the square root of the sum of the squares of the error with n sample data points.
approx_leastsquares, an Octave code which interactively approximates a function f(x) in the interval [a,b] by constructing an m-degree polynomial which minimizes the square root of the sum of the squares of the error with n sample data points.
arbitrary_weight_rule, a Mathematica code which accepts a formula for an arbitrary, but nonnegative, weight function over an interval, and determines a corresponding Gaussian quadrature rule, by Fukuda, Katsuya, Alt and Matveenko;
arby4, a Fortran90 code which accepts solutions of a 2D fluid flow problem governed by the Navier Stokes equations (NSE), and analyzes it using the reduced basis method.
arclength, a MATLAB code which estimates the arclength of curves of the form (x,f(x)) or (x(t),y(t)).
arclength, an Octave code which estimates the arclength of curves of the form (x,f(x)) or (x(t),y(t)).
arclength, a Python code which estimates the arclength of curves of the form (x,f(x)) or (x(t),y(t)).
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).
arenstorf_ode, a MATLAB code which sets up an ordinary differential equation (ODE) which defines a stable periodic orbit of a spacecraft around the Earth and the Moon.
arenstorf_ode, an Octave code which sets up an ordinary differential equation (ODE) which defines a stable periodic orbit of a spacecraft around the Earth and the Moon.
arenstorf_ode, a Python code which sets up an ordinary differential equation (ODE) which defines a stable periodic orbit of a spacecraft around the Earth and the Moon.
args, a C code which reports the commandline arguments with which it was invoked;
args, a C++ code which reports the commandline arguments with which it was invoked;
args, a Fortran77 code which reports the commandline arguments with which it was invoked;
args, a Fortran90 code which reports the commandline arguments with which it was invoked;
args, a MATLAB code which reports the commandline arguments with which it was invoked;
args, an Octave code which reports the commandline arguments with which it was invoked;
args, a Python code which reports the commandline arguments with which it was invoked;
arneodo_ode, a MATLAB code which sets up and solves the Arneodo ordinary differential equation (ODE), which has chaotic behavior and an attractor.
arneodo_ode, an Octave code which sets up and solves the Arneodo ordinary differential equation (ODE), which has chaotic behavior and an attractor.
arneodo_ode, a Python code which sets up and solves the Arneodo ordinary differential equation (ODE), which has chaotic behavior and an attractor.
arpack, a Fortran90 code which is a numerical software library for solving large scale eigenvalue problems. The package is designed to compute a few eigenvalues and corresponding eigenvectors of large sparse or structured matrices, using the Implicitly Restarted Arnoldi Method (IRAM) or, in the case of symmetric matrices, the corresponding variant of the Lanczos algorithm. It is used by many popular numerical computing environments such as SciPy, Mathematica, GNU Octave and MATLAB to provide this functionality.
arpack_test, a MATLAB code which calls arpack() to compute eigenvalues and eigenvectors of large sparse matrices, accessible via the built-in eigs() command;
array2d, a FreeFem++ code which demonstrates how 2D arrays can be defined and manipulated.
artery_pde, a MATLAB code which solves a partial differential equation (PDE) in one spatial dimension and time, that models the displacement of arterial walls under pressure.
artery_pde, an Octave code which solves a partial differential equation (PDE) in one spatial dimension and time, that models the displacement of arterial walls under pressure.
asa_geometry_2011, a MATLAB code which was 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_geometry_2011, an Octave code which was 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_graphs_2011, a MATLAB code which was 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_graphs_2011, an Octave code which was 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_images_2011, a MATLAB code which was 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.
asa_images_2011, an Octave code which was 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 code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
asa005, a C++ code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
asa005, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
asa005, a Fortran90 code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
asa005, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
asa005, an Octave code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
asa005, a Python code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
asa006, a C code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
asa006, a C++ code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
asa006, a Fortran77 code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy; This is a version of Applied Statistics Algorithm 6;
asa006, a Fortran90 code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
asa006, a MATLAB code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
asa006, an Octave code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
asa006, a Python code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
asa007, a C code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
asa007, a C++ code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
asa007, a Fortran77 code which computes the inverse of a symmetric positive definite (SPD) matrix, The algorithm is by Michael Healy. This is a version of Applied Statistics Algorithm 7;
asa007, a Fortran90 code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
asa007, a MATLAB code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
asa007, an Octave code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
asa007, a Python code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
asa032, a C code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
asa032, a C++ code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
asa032, a Fortran77 code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32;
asa032, a Fortran90 code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
asa032, a MATLAB code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
asa032, an Octave code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
asa032, a Python code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
asa047, a C code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
asa047, a C++ code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
asa047, a Fortran77 code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47;
asa047, a Fortran90 code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
asa047, a MATLAB code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
asa047, an Octave code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
asa047, a Python code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
asa053, a C code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
asa053, a C++ code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
asa053, a Fortran77 code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
asa053, a Fortran90 code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
asa053, a MATLAB code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
asa053, an Octave code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
asa058, a C code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
asa058, a C++ code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
asa058, a Fortran77 code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58;
asa058, a Fortran90 code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
asa058, a MATLAB code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
asa058, an Octave code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
asa063, a C code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
asa063, a C++ code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
asa063, a Fortran77 code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63;
asa063, a Fortran90 code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
asa063, a MATLAB code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
asa063, an Octave code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
asa063, a Python code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
asa066, a C code 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++ code 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 code 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 code 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 code which evaluates the Cumulative Density Function (CDF) of the normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.
asa066, an Octave code 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 Python code which evaluates the Cumulative Density Function (CDF) of the normal distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.
asa076, a C code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
asa076, a C++ code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
asa076, a Fortran77 code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76;
asa076, a Fortran90 code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
asa076, a MATLAB code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
asa076, an Octave code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
asa076, a Python code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
asa082, a C code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
asa082, a C++ code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
asa082, a Fortran77 code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
asa082, a Fortran90 code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
asa082, a MATLAB code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
asa082, an Octave code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
asa082, a Python code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
asa091, a C code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
asa091, a C++ code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
asa091, a Fortran77 code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91;
asa091, a Fortran90 code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
asa091, a MATLAB code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
asa091, an Octave code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
asa091, a Python code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
asa103, a C code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
asa103, a C++ code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
asa103, a Fortran77 code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103;
asa103, a Fortran90 code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
asa103, a MATLAB code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
asa103, an Octave code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
asa103, a Python code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
asa109, a C code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
asa109, a C++ code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
asa109, a Fortran77 code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109;
asa109, a Fortran90 code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
asa109, a MATLAB code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
asa109, an Octave code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
asa109, a Python code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
asa111, a C code 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++ code 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 code 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 code 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 code which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.
asa111, an Octave code which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.
asa111, a Python code which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.
asa113, a C code 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++ code 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 code 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 code 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 code which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.
asa113, an Octave code which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.
asa121, a C code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
asa121, a C++ code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
asa121, a Fortran77 code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121;
asa121, a Fortran90 code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
asa121, a MATLAB code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
asa121, an Octave code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
asa136, a C code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
asa136, a C++ code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
asa136, a Fortran77 code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136;
asa136, a Fortran90 code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
asa136, a MATLAB code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
asa136, an Octave code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
asa144, a C code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
asa144, a C++ code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
asa144, a Fortran77 code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144;
asa144, a Fortran90 code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
asa144, a MATLAB code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
asa144, an Octave code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
asa147, a C code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
asa147, a C++ code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
asa147, a Fortran77 code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147;
asa147, a Fortran90 code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
asa147, a MATLAB code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
asa147, an Octave code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
asa147, a Python code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
asa152, a C code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;
asa152, a C++ code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;
asa152, a Fortran77 code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;
asa152, a Fortran90 code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152;
asa152, a MATLAB code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152.
asa152, an Octave code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152.
asa159, a C code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
asa159, a C++ code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
asa159, a Fortran77 code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159;
asa159, a Fortran90 code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
asa159, a MATLAB code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
asa159, an Octave code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
asa172, a C code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. This is a version of Applied Statistics Algorithm 172.
asa172, a C++ code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
asa172, a Fortran77 code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
asa172, a Fortran90 code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
asa172, a MATLAB code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
asa172, an Octave code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
asa183, a C code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
asa183, a C++ code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
asa183, a Fortran77 code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183;
asa183, a Fortran90 code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
asa183, a MATLAB code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
asa183, an Octave code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
asa183, a Python code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
asa189, a Fortran77 code which estimates the parameters of a beta binomial distribution based on a sample of values generated by the distribution, by D Smith; this is a version of Applied Statistics Algorithm 189;
asa189, a Fortran90 code which estimates the parameters of a beta binomial distribution based on a sample of values generated by the distribution, by D Smith; this is a version of Applied Statistics Algorithm 189;
asa205, a Fortran77 code which generates all the contingency tables corresponding to a given set of row and column sums. This is a version of Applied Statistics Algorithm 205;
asa205, a Fortran90 code which generates all the contingency tables corresponding to a given set of row and column sums. This is a version of Applied Statistics Algorithm 205.
asa226, a C code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
asa226, a C++ code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
asa226, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226;
asa226, a Fortran90 code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
asa226, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
asa226, an Octave code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
asa226, a Python code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
asa239, a C code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
asa239, a C++ code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
asa239, a Fortran77 code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239;
asa239, a Fortran90 code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
asa239, a MATLAB code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
asa239, an Octave code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
asa239, a Python code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
asa241, a C code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
asa241, a C++ code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
asa241, a Fortran77 code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241;
asa241, a Fortran90 code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
asa241, a MATLAB code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
asa241, an Octave code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
asa241, a Python code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
asa243, a C code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
asa243, a C++ code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
asa243, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 243;
asa243, a Fortran90 code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
asa243, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
asa243, an Octave code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
asa243, a Python code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
asa245, a C code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
asa245, a C++ code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
asa245, a Fortran77 code which evaluates the logarithm of the Gamma function, by Allan Mcleod; This is a version of Applied Statistics Algorithm 245;
asa245, a Fortran90 code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
asa245, a MATLAB code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
asa245, an Octave code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
asa245, a Python code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
asa266, a C code which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;
asa266, a C++ code which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;
asa266, a Fortran77 code which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;
asa266, a Fortran90 code which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;
asa266, a MATLAB code which evaluates various properties of the Dirichlet Probability Density Function (PDF); This is a version of Applied Statistics Algorithm 266.
asa266, an Octave code which evaluates various properties of the Dirichlet Probability Density Function (PDF); This is a version of Applied Statistics Algorithm 266.
asa299, a C code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
asa299, a C++ code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
asa299, a Fortran77 code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
asa299, a Fortran90 code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
asa299, a MATLAB code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
asa299, an Octave code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
asa299, a Python code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
asa310, a C code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
asa310, a C++ code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
asa310, a Fortran77 code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam. This is a version of Applied Statistics Algorithm 310;
asa310, a Fortran90 code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
asa310, a MATLAB code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
asa310, an Octave code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
asa314, a C code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
asa314, a C++ code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
asa314, a Fortran77 code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
asa314, a Fortran90 code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
asa314, a MATLAB code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
asa314, an Octave code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
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 code 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 code which tests ascii_to_mri.
atbash, a C code which applies the Atbash substitution cipher to a string of text.
atbash, a C++ code which applies the Atbash substitution cipher to a string of text.
atbash, a Fortran90 code which applies the Atbash substitution cipher to a string of text.
atbash, a MATLAB code which applies the Atbash substitution cipher to a string of text.
atbash, an Octave code which applies the Atbash substitution cipher to a string of text.
atbash, a Python code which applies the Atbash substitution cipher to a string of text.
atkinson, a Fortran77 code which contains examples from the text 'Elementary Numerical Analysis', by Atkinson.
atkinson, a MATLAB code which contains examples from the text 'Elementary Numerical Analysis', by Atkinson.
atkinson, an Octave code which contains examples from the text 'Elementary Numerical Analysis', by Atkinson.
atlas, examples which use ATLAS, 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.
autocatalytic_ode, a MATLAB code which sets up and solves the autocatalytic ordinary differential equation (ODE), which has chaotic behavior and an attractor.
autocatalytic_ode, an Octave code which sets up and solves the autocatalytic ordinary differential equation (ODE), which has chaotic behavior and an attractor.
autocatalytic_ode, a Python code which sets up and solves the autocatalytic ordinary differential equation (ODE), which has chaotic behavior and an attractor.
axon_ode, a MATLAB code which sets up the ordinary differential equations (ODE) for the Hodgkin-Huxley model of an axon.
axon_ode, an Octave code which sets up the ordinary differential equations (ODE) for the Hodgkin-Huxley model of an axon.
axon_ode, a Python code which sets up the ordinary differential equations (ODE) for the Hodgkin-Huxley model of an axon.
backtrack_binary_rc, a C code which carries out a backtrack search for binary decisions, using reverse communication (RC).
backtrack_binary_rc, a C++ code which carries out a backtrack search for binary decisions, using reverse communication (RC).
backtrack_binary_rc, a Fortran77 code which carries out a backtrack search for binary decisions, using reverse communication (RC).
backtrack_binary_rc, a Fortran90 code which carries out a backtrack search for binary decisions, using reverse communication (RC).
backtrack_binary_rc, a MATLAB code which carries out a backtrack search for binary decisions, using reverse communication (RC).
backtrack_binary_rc, an Octave code which carries out a backtrack search for binary decisions, using reverse communication (RC).
backtrack_binary_rc, a Python code which carries out a backtrack search for binary decisions, using reverse communication (RC).
backward_euler, a C code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a version of fsolve() for the implicit equation.
backward_euler, a C++ code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a version of fsolve() for the implicit equation.
backward_euler, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a version of fsolve() for the implicit equation.
backward_euler, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a version of fsolve() for the implicit equation.
backward_euler, a FreeFem++ code which uses the implicit backward Euler method to solve a time-dependent boundary value problem (BVP).
backward_euler, a MATLAB code which solves one or more ordinary differential equations (ODE) using the implicit backward Euler method, using fsolve() for the implicit equation.
backward_euler, an Octave code which solves one or more ordinary differential equations (ODE) using the implicit backward Euler method.
backward_euler, a Python code which solves one or more ordinary differential equations (ODE) using the implicit backward Euler method.
backward_euler, an R code which implements the implicit backward Euler method for solving an ordinary differential equation (ODE).
backward_euler_fixed, a MATLAB code which solves one or more ordinary differential equations (ODE) using the implicit backward Euler method, using a fixed point iteration for the implicit equation.
backward_euler_fixed, an Octave code which solves one or more ordinary differential equations (ODE) using the implicit backward Euler method, using a fixed point iteration for the implicit equation.
backward_euler_fixed, a Python code which solves one or more ordinary differential equations (ODE) using the implicit backward Euler method, using a fixed point iteration for the implicit equation.
backward_step, a FreeFem++ code which solves the Navier Stokes equations (NSE), for an increasing sequence of Reynolds numbers, in a backward step region.
ball_and_stick_display, a MATLAB code which demonstrates the creation of a 3D ball and stick image;
ball_and_stick_display, an Octave code which demonstrates the creation of a 3D ball and stick image;
ball_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit ball in 3D.
ball_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit ball in 3D.
ball_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit ball in 3D.
ball_grid, a C code which computes a grid of points over the interior of a ball in 3D.
ball_grid, a C++ code which computes a grid of points over the interior of a ball in 3D.
ball_grid, a Fortran77 code which computes a grid of points over the interior of a ball in 3D.
ball_grid, a Fortran90 code which computes a grid of points over the interior of a ball in 3D.
ball_grid, a MATLAB code which computes a grid of points over the interior of a ball in 3D.
ball_grid, an Octave code which computes a grid of points over the interior of a ball in 3D.
ball_grid, a Python code which computes a grid of points over the interior of a ball in 3D.
ball_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
ball_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
ball_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
ball_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
ball_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
ball_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
ball_integrals, a Python code 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 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
ball_monte_carlo, a C++ code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
ball_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
ball_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
ball_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
ball_monte_carlo, an Octave code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
ball_monte_carlo, a Python code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
ball_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit positive ball in 3D.
ball_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit positive ball in 3D.
ball_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit positive ball in 3D.
bamg, a data directory which contains geometry files that can be input to the BAMG meshing code.
bamg_test, a FreeFem++ code which displays 2D meshes created by BAMG.
band_qr, a Fortran77 code which computes the QR factorization of a banded matrix, and solves related linear systems, by Alfredo Remon, Enrique Quintana-Orti, Gregorio Quintana-Orti.
band_qr, a Fortran90 code which computes the QR factorization of a banded matrix, and solves related linear systems, by Alfredo Remon, Enrique Quintana-Orti, Gregorio Quintana-Orti.
bank, a C code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
bank, a C++ code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
bank, a Fortran90 code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
bank, a MATLAB code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
bank, an Octave code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
bank, a Python code which computes the check digit associated with a US Bank Routing Number check digit, or reports whether a 9-digit code is actually valid.
bar_plot, a Fortran90 code 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 code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates 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++ code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates 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 code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates 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 code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates 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 code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.
barycentric_interp_1d, an Octave code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates 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 code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates 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 use BASH, which is a shell scripting language.
basis_compare, a Fortran90 code which compares two sets, each containing N orthonormal M-dimensional vectors, to see if they span the same subspace.
batch, an R code which illustrates how an R code can be executed in batch mode.
bayes_beta, a Fortran90 code which uses Bayesian analysis to estimate the parameters in a beta distribution based on a series of sample data.
bayes_dice, a Fortran90 code which uses Bayesian analysis to adjust a model of loaded dice based on a sequence of experimental observations.
bayes_weight, a Fortran90 code which uses Bayesian analysis to adjust a model of loaded dice based on a sequence of experimental observations.
bdf2, a C code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
bdf2, a C++ code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
bdf2, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
bdf2, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
bdf2, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
bdf2, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
bdf2, a Python code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
bdmlib, a Fortran77 code which estimates the weights in a Dirichlet mixtured based on sample data;
bdmlib, a Fortran90 code which estimates the weights in a Dirichlet mixtured based on sample data;
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.
bellman_ford, a C code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
bellman_ford, a C++ code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
bellman_ford, a Fortran77 code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
bellman_ford, a Fortran90 code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
bellman_ford, a MATLAB code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
bellman_ford, an Octave code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
bellman_ford, a Python code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
bernstein_approximation, a MATLAB code which looks at some simple cases of approximation of a function f(x) by a Bernstein polynomial.
bernstein_approximation, an Octave code which looks at some simple cases of approximation of a function f(x) by a Bernstein polynomial.
bernstein_approximation, a Python code which looks at some simple cases of approximation of a function f(x) by a Bernstein polynomial.
bernstein_polynomial, a C code which evaluates the Bernstein polynomials, useful for uniform approximation of functions;
bernstein_polynomial, a C++ code which evaluates the Bernstein polynomials, useful for uniform approximation of functions;
bernstein_polynomial, a Fortran77 code which evaluates the Bernstein polynomials, useful for uniform approximation of functions;
bernstein_polynomial, a Fortran90 code which evaluates the Bernstein polynomials, useful for uniform approximation of functions;
bernstein_polynomial, a MATLAB code which evaluates the Bernstein polynomials, useful for uniform approximation of functions;
bernstein_polynomial, an Octave code which evaluates the Bernstein polynomials, useful for uniform approximation of functions;
bernstein_polynomial, a Python code which evaluates the Bernstein polynomials, useful for uniform approximation of functions;
besselj, a C code which evaluates Bessel J functions of noninteger order.
besselj, a C++ code which evaluates Bessel J functions of noninteger order.
besselj, a Fortran90 code which evaluates Bessel J functions of noninteger order.
besselj, a MATLAB code which evaluates Bessel J functions of noninteger order.
besselj, an Octave code which evaluates Bessel J functions of noninteger order.
besselj, a Python code which evaluates Bessel J functions of noninteger order.
besselzero, a MATLAB code which computes zeros of Bessel j or y functions, by Greg van Winckel and Jason Nicholson.
besselzero, an Octave code which computes zeros of Bessel j or y functions, by Greg van Winckel and Jason Nicholson.
beta_nc, a C code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.
beta_nc, a C++ code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.
beta_nc, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.
beta_nc, a Fortran90 code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.
beta_nc, a MATLAB code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.
beta_nc, an Octave code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution.
betis, a Fortran77 code which applies the boundary element method (BEM) to solve the Laplace 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 code which reads, writes, prints and manipulates data that defines a Bezier surface;
bezier_surface, a MATLAB code which reads, writes, prints and manipulates the data that defines a Bezier surface;
bezier_surface, an Octave code which reads, writes, prints and manipulates the data that defines a Bezier surface;
bezier_surface_display, a MATLAB code which displays a Bezier surface;
bezier_surface_display, an Octave code which displays a Bezier surface;
bicg, a MATLAB code which implements the biconjugate gradient method (BICG), which estimates the solution of a large sparse nonsymmetric linear system.
bicg, an Octave code which implements the biconjugate gradient method (BICG), which estimates the solution of a large sparse nonsymmetric linear system.
bicycle_lock, a C code which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.
bicycle_lock, a C++ code which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.
bicycle_lock, a Fortran90 code which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.
bicycle_lock, a MATLAB code which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.
bicycle_lock, a Python code which simulates the process of determining the secret combination of a bicycle lock, an integer between 000 and 999.
biharmonic_cheby1d, a MATLAB code which uses Chebyshev methods to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
biharmonic_cheby1d, an Octave code which uses Chebyshev methods to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
biharmonic_exact, a C code which evaluates exact solutions w(x,y) to the biharmonic equation del^2 w = 0 or wxxxx + 2 wxxyy + wyyyy = 0
biharmonic_exact, a C++ code which evaluates exact solutions w(x,y) to the biharmonic equation del^2 w = 0 or wxxxx + 2 wxxyy + wyyyy = 0
biharmonic_exact, a Fortran90 code which evaluates exact solutions w(x,y) to the biharmonic equation del^2 w = 0 or wxxxx + 2 wxxyy + wyyyy = 0
biharmonic_exact, a MATLAB code which evaluates exact solutions w(x,y) to the biharmonic equation del^2 w = 0 or wxxxx + 2 wxxyy + wyyyy = 0
biharmonic_exact, an Octave code which evaluates exact solutions w(x,y) to the biharmonic equation del^2 w = 0 or wxxxx + 2 wxxyy + wyyyy = 0
biharmonic_exact, a Python code which evaluates exact solutions w(x,y) to the biharmonic equation del^2 w = 0 or wxxxx + 2 wxxyy + wyyyy = 0
biharmonic_fd1d, a MATLAB code which applies the finite difference method (FDM) to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
biharmonic_fd1d, an Octave code which applies the finite difference method (FDM) to solve the biharmonic equation over an interval, a fourth order two point boundary value problem (BVP) in one spatial dimension.
biharmonic_fd2d, a Fortran77 code which solves a version of the biharmonic equation in two dimensions, by Petter Bjorstad.
biharmonic_fd2d, a MATLAB code which deals with the biharmonic equation in two dimensions, whose simplest form is uxxxx + 2uxxyy + uyyyy = f.
biharmonic_fd2d, an Octave code which deals with the biharmonic equation in two dimensions, whose simplest form is uxxxx + 2uxxyy + uyyyy = f.
bilinear, an R code which evaluates a bilinear interpolant;
bin_packing, a dataset directory which contains instances of the bin packing problem, in which objects are to be packed in the minimum possible number of uniform bins;
bins, a C++ code which orders, sorts and searches data using bins;
bins, a Fortran77 code which orders, sorts and searches data using bins;
bins, a Fortran90 code which orders, sorts and searches data using bins;
bio, a C code which manages binary I/O, by Greg Hood.
biochemical_linear_ode, a MATLAB code which sets up a linear biochemical ordinary differential equation (ODE).
biochemical_linear_ode, an Octave code which sets up a linear biochemical ordinary differential equation (ODE).
biochemical_linear_ode, a Python code which sets up a linear biochemical ordinary differential equation (ODE).
biochemical_nonlinear_ode, a MATLAB code which sets up a nonlinear biochemical ordinary differential equation (ODE).
biochemical_nonlinear_ode_test
biochemical_nonlinear_ode, an Octave code which sets up a nonlinear biochemical ordinary differential equation (ODE).
biochemical_nonlinear_ode_test
biochemical_nonlinear_ode, a Python code which sets up a nonlinear biochemical ordinary differential equation (ODE).
bioconvection_ode, a MATLAB code which approximates solutions to a system of ordinary differential equations (ODE) which model a bioconvection problem, and which are related to the Lorenz system.
bioconvection_ode, an Octave code which approximates solutions to a system of ordinary differential equations (ODE) which model a bioconvection problem, and which are related to the Lorenz system.
bioconvection_ode, a Python code which approximates solutions to a system of ordinary differential equations (ODE) which model a bioconvection problem, and which are related to the Lorenz system.
bird_egg, a MATLAB code which evaluates some formulas for the shapes of bird eggs.
bird_egg, an Octave code which evaluates some formulas for the shapes of bird eggs.
bird_egg, a Python code which evaluates some formulas for the shapes of bird eggs.
birthday_remote, a MATLAB code which runs a Monte Carlo simulation of the birthday paradox, and includes instructions on how to run the job, via the MATLAB batch facility, on a remote system.
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 code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using classes.
bisection, a C code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection, a C++ code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection, a Fortran90 code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection, a Julia code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection, a MATLAB code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection, an Octave code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection, a Python code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection, an R code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
bisection_integer, a C code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
bisection_integer, a C++ code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
bisection_integer, a Fortran77 code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
bisection_integer, a Fortran90 code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
bisection_integer, a MATLAB code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
bisection_integer, an Octave code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
bisection_rc, a C code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
bisection_rc, a C++ code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
bisection_rc, a Fortran77 code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
bisection_rc, a Fortran90 code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
bisection_rc, a MATLAB code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
bisection_rc, an Octave code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
bisection_rc, a Python code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
bits_to_ui, a C++ code which reads a text file of bits, stored as '0' and '1' characters, and writes a binary file in which groups of 32 bits have been interpreted as an unsigned integer;
bivar, a Fortran90 code which interpolates scattered bivariate data. This is a version of ACM TOMS algorithm 526, by Hiroshi Akima.
black_scholes, a C code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
black_scholes, a C++ code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
black_scholes, a Fortran77 code which implements some simple approaches to the Black-Scholes option valuation theory, creating graphics files for processing by gnuplot(), by Desmond Higham.
black_scholes, a Fortran90 code which implements some simple approaches to the Black-Scholes option valuation theory, creating graphics files for processing by gnuplot(), by Desmond Higham.
black_scholes, a MATLAB code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
black_scholes, an Octave code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
black_scholes, a Python code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
blacs_test, a Fortran90 code which tests 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 code 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 real 32 bit arithmetic, real 64 bit arithmetic, complex 32 bit arithmetic, and complex 64 bit arithmetic.
blas, a C++ code 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 real 32 bit arithmetic, real 64 bit arithmetic, complex 32 bit arithmetic, and complex 64 bit arithmetic.
blas, a Fortran77 code 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 real 32 bit arithmetic, real 64 bit arithmetic, complex 32 bit arithmetic, and complex 64 bit arithmetic.
blas, a Fortran90 code 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 real 32 bit arithmetic, real 64 bit arithmetic, complex 32 bit arithmetic, and complex 64 bit arithmetic.
blas, a MATLAB code 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 real 32 bit arithmetic, real 64 bit arithmetic, complex 32 bit arithmetic, and complex 64 bit arithmetic.
blas_osx_test, a C code which demonstrates how to access the BLAS library on a Macintosh that is running the OSX operating system.
blas_osx, a C++ code which demonstrates how to access the BLAS library on a Macintosh that is running the OSX operating system.
blas_osx, a Fortran90 code which demonstrates how to access the BLAS library on a Macintosh that is running the OSX operating system.
blas0, a C code which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).
blas0, a C++ code which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).
blas0, a Fortran77 code which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).
blas0, a Fortran90 code which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).
blas0, a MATLAB code which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).
blas1, a C++ code which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 vector-vector operations for real 32 bit arithmetic, real 64 bit arithmetic, complex 32 bit arithmetic, and complex 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1, a Fortran77 code which contains the Basic Linear Algebra Subprograms (BLAS) for level 1 vector-vector operations for real 32 bit arithmetic, real 64 bit arithmetic, complex 32 bit arithmetic, and complex 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_c, a C code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_c, a C++ code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_c, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_c, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_c, a MATLAB code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_d, a C code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_d, a C++ code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_d, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_d, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_d, a MATLAB code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_d, a Python code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_s, a C code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_s, a C++ code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_s, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_s, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_s, a MATLAB code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using real 32 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_z, a C code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_z, a C++ code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_z, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_z, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas1_z, a MATLAB code which contains basic linear algebra subprograms (BLAS) for vector-vector operations, using complex 64 bit arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
blas2_c, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using complex 32 bit arithmetic;
blas2_c, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using complex 32 bit arithmetic;
blas2_d, a C code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 64 bit arithmetic;
blas2_d, a C++ code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 64 bit arithmetic;
blas2_d, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 64 bit arithmetic;
blas2_d, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 64 bit arithmetic;
blas2_d, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 64 bit arithmetic;
blas2_d, a MATLAB code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 64 bit arithmetic;
blas2_s, a C code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 32 bit arithmetic;
blas2_s, a C++ code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 32 bit arithmetic;
blas2_s, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 32 bit arithmetic;
blas2_s, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 32 bit arithmetic;
blas2_s, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 32 bit arithmetic;
blas2_s, a MATLAB code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using real 32 bit arithmetic;
blas2_z, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using complex 64 bit arithmetic;
blas2_z, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-vector operations, using complex 64 bit arithmetic;
blas3_c, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using complex 32 bit arithmetic;
blas3_c, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using complex 32 bit arithmetic;
blas3_d, a C code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 64 bit arithmetic.
blas3_d, a C++ code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 64 bit arithmetic.
blas3_d, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 64 bit arithmetic;
blas3_d, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 64 bit arithmetic;
blas3_d, a MATLAB code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 64 bit arithmetic;
blas3_s, a C code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 32 bit arithmetic.
blas3_s, a C++ code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 32 bit arithmetic;
blas3_s, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 32 bit arithmetic;
blas3_s, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 32 bit arithmetic;
blas3_s, a MATLAB code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using real 32 bit arithmetic;
blas3_z, a Fortran77 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using complex 64 bit arithmetic;
blas3_z, a Fortran90 code which contains basic linear algebra subprograms (BLAS) for matrix-matrix operations, using complex 64 bit arithmetic;
blend, a C code which implements blended mapping or transfinite interpolation;
blend, a C++ code which implements blended mapping or transfinite interpolation;
blend, a Fortran77 code which implements blended mapping or transfinite interpolation;
blend, a Fortran90 code which implements blended mapping or transfinite interpolation;
blend, a MATLAB code which implements blended mapping or transfinite interpolation;
blend, an Octave code which implements blended mapping or transfinite interpolation;
blob_classify_kernelized_svm, a scikit-learn code which uses a kernelized support vector machine to classify an artificial dataset of groups of "blobs".
blob_classify_logistic_multi, a scikit-learn code which uses multiple applications of logistic regression to classify an artificial dataset of three groups of "blobs".
blob_cluster_kmeans, a scikit-learn code which uses the k-means algorithm to cluster four groups of "blobs".
blood_pressure_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which models the variation in blood pressure in the human artery.
blood_pressure_ode, an Octave code which sets up and solves an ordinary differential equation (ODE) which models the variation in blood pressure in the human artery.
blood_pressure_ode, a Python code which sets up and solves an ordinary differential equation (ODE) which models the variation in blood pressure in the human artery.
blowup_ode, a MATLAB code which sets up an ordinary differential equation (ODE) y'=y^2. whose solution blows up in finite time.
blowup_ode, an Octave code which sets up an ordinary differential equation (ODE) y'=y^2. whose solution blows up in finite time.
blowup_ode, a Python code which sets up an ordinary differential equation (ODE) y'=y^2. whose solution blows up in finite time.
blsprice_test, a MATLAB code which use blsprice() function, for Black-Scholes option pricing, from the MATLAB Financial Mathematics toolbox.
bmp_io, a C++ code which reads and writes information stored in a BMP graphics file;
bmp_to_ppma, a C++ code which converts a BMP graphics file to an ASCII Portable Pixel Map (PPM) file;
bmp_to_ppmb, a C++ code which converts a BMP graphics file to a binary Portable Pixel Map (PPM) file;
boat, a MATLAB code which considers the boat tiling puzzle, a smaller version of the eternity puzzle. The boat puzzle specifies a region R composed of 756 30-60-90 triangles, and a set of 21 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
boat, an Octave code which considers the boat tiling puzzle, a smaller version of the eternity puzzle. The boat puzzle specifies a region R composed of 756 30-60-90 triangles, and a set of 21 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
boat_cplex_test a BASH code which calls cplex(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
boat_cplex_test a BASH code which calls cplex(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
boat_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
boat_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the boat tiling problem, solve the linear programming problem, and write the solution to a file.
boomerang, a MATLAB code which considers the boomerang tiling puzzle, a smaller version of the eternity puzzle. The puzzle specifies a region R composed of 2376 30-60-90 triangles, and a set of 66 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
boomerang_cplex_test a BASH code which calls cplex(), to read the LP file defining the boomerang tiling problem, solve the linear programming problem, and write the solution to a file.
boost, examples which use boost(), which is a C++ code 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 use BOOST-MPI, which is a C++ code, part of the boost() distribution, specifically designed for MPI applications.
boost-ucs2, examples which use 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.
boston, a keras code which sets up a neural network to apply regression to predict housing prices, based on the Boston housing dataset, as read from internal data functions.
boston_housing, a keras code which sets up a neural network to apply regression to predict housing prices, based on the Boston housing dataset, as read from the keras dataset service.
boston_housing_external, a keras code which sets up a neural network to apply regression to predict housing prices, based on the Boston housing dataset, as read from external data files.
boundary_locus, a MATLAB code which uses the boundary locus method to display the region of absolute stability for a solver of ordinary differential equations (ODE), based on a procedure by Randall Leveque.
boundary_locus, an Octave code which uses the boundary locus method to display the region of absolute stability for a solver of ordinary differential equations (ODE), based on a procedure by Randall Leveque.
boundary_locus, a Python code which uses the boundary locus method to display the region of absolute stability for a solver of ordinary differential equations (ODE), based on a procedure by Randall Leveque.
boundary_locus2, a MATLAB code which uses the boundary locus method to plot the boundary of the absolute stability region for a solver of ordinary differential equations (ODE).
boundary_locus2, an Octave code which uses the boundary locus method to plot the boundary of the absolute stability region for a solver of ordinary differential equations (ODE).
boundary_locus2, a Python code which uses the boundary locus method to plot the boundary of the absolute stability region for a solver of ordinary differential equations (ODE).
boundary_node_list, a FreeFem++ code which defines a 2D mesh, and then shows how to determine the number of boundary elements, that is, sides of triangles, and how to list the indices of the pairs of nodes that form the boundary.
boundary_word_drafter, a MATLAB code which describes the outline of an object using a string of symbols that represent the sequence of steps tracing out the boundary, on a grid of drafters, or 30-60-90 triangles. The objects include tiles for the eternity, serenity and trinity puzzles, and the hat and turtle aperiodic monotiles.
boundary_word_drafter, an Octave code which describes the outline of an object using a string of symbols that represent the sequence of steps tracing out the boundary, on a grid of drafters, or 30-60-90 triangles. The objects include tiles for the eternity, serenity and trinity puzzles, and the hat and turtle aperiodic monotiles.
boundary_word_equilateral, a MATLAB code which describes the outline of an object on a grid of equilateral triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_equilateral_test
boundary_word_equilateral, an Octave code which describes the outline of an object on a grid of equilateral triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_equilateral_test
boundary_word_equilateral, a Python code which describes the outline of an object on a grid of equilateral triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_hexagon, a MATLAB code which describes the outline of an object on a grid of hexagons, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_hexagon, an Octave code which describes the outline of an object on a grid of hexagons, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_hexagon, a Python code which describes the outline of an object on a grid of hexagons, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_right, a MATLAB code which describes the outline of an object on a grid of isoceles right triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_right, an Octave code which describes the outline of an object on a grid of isoceles right triangles, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_square, a MATLAB code which describes the outline of an object on a grid of squares, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_square, an Octave code which describes the outline of an object on a grid of squares, using a string of symbols that represent the sequence of steps tracing out the boundary.
boundary_word_square, a Python code which describes the outline of an object on a grid of squares, using a string of symbols that represent the sequence of steps tracing out the boundary.
box_behnken, a C code which computes a Box-Behnken design, that is, arguments to sample the behavior of a function of multiple parameters;
box_behnken, a C++ code which computes a Box-Behnken design, that is, arguments to sample the behavior of a function of multiple parameters;
box_behnken, a Fortran77 code which computes a Box-Behnken design, that is, arguments to sample the behavior of a function of multiple parameters;
box_behnken, a Fortran90 code which computes a Box-Behnken design, that is, arguments to sample the behavior of a function of multiple parameters;
box_behnken, a MATLAB code which computes a Box-Behnken design, that is, arguments to sample the behavior of a function of multiple parameters;
box_behnken, an Octave code which computes a Box-Behnken design, that is, arguments to sample the behavior of a function of multiple parameters;
box_display, a MATLAB code which displays a box plot, over integer pairs of data, of a function defined by two formulas.
box_display, an Octave code which displays a box plot, over integer pairs of data, of a function defined by two formulas.
box_distance, a MATLAB code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a 3D box.
box_distance, an Octave code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a 3D box.
box_distance, a Python code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a 3D box.
box_flow, a MATLAB code which solves the Navier Stokes equations (NSE) in a 2D rectangular region, replacing the continuity equation with a pressure Poisson equation (PPE), by John Cornthwaite.
box_flow, an Octave code which solves the Navier Stokes equations (NSE) in a 2D rectangular region, replacing the continuity equation with a pressure Poisson equation (PPE), by John Cornthwaite.
box_games, a MATLAB code which contains utilities for creating and displaying simple board games, such as for checkers, or life, or a cellular automaton.
box_games, an Octave code which contains utilities for creating and displaying simple board games, such as for checkers, or life, or a cellular automaton.
box_plot, a MATLAB code which displays a box plot of data that consists of pairs of integers;
box_plot, an Octave code which displays a box plot of data that consists of pairs of integers;
brain_sensor_pod, a MATLAB code which applies the method of Proper Orthogonal Decomposition to seek underlying patterns in sets of 40 sensor readings of brain activity.
brent_old, a C++ code 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 including a reverse communication (RC) option, and some customizations by John Denker.
brent, a Fortran77 code which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, in the original format, by Richard Brent.
brownian_motion_simulation, a C code which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot().
brownian_motion_simulation_test
brownian_motion_simulation, a C++ code which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot().
brownian_motion_simulation_test
brownian_motion_simulation, a Fortran77 code which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot().
brownian_motion_simulation_test
brownian_motion_simulation, a Fortran90 code which simulates Brownian motion in an M-dimensional region, creating graphics files that can be displayed with gnuplot().
brownian_motion_simulation_test
brownian_motion_simulation, a MATLAB code which simulates Brownian motion in an M-dimensional region.
brownian_motion_simulation_test
brownian_motion_simulation, an Octave code which simulates Brownian motion in an M-dimensional region.
brownian_motion_simulation_test
brownian_motion_simulation, a Python code which simulates Brownian motion in an M-dimensional region.
broyden, a MATLAB code which implements the Broyden iterative method for solving a system of nonlinear equations, by Tim Kelley.
broyden, an Octave code which implements the Broyden iterative method for solving a system of nonlinear equations, by Tim Kelley.
broyden, a Python code which implements the Broyden iterative method for solving a system of nonlinear equations, by Tim Kelley.
brusselator_ode, a MATLAB code which sets up the Brusselator ordinary differential equation (ODE) system.
brusselator_ode, an Octave code which sets up the Brusselator ordinary differential equation (ODE) system.
brusselator_ode, a Python code which sets up the Brusselator ordinary differential equation (ODE) system.
bt_serial, a Fortran77 code which a serial version of the nas Block Tridiagonal (BT) Parallel Benchmark.
bt_serial, a Fortran90 code which a serial version of the nas Block Tridiagonal (BT) Parallel Benchmark .
buckling_spring, a Mathematica code which defines the buckling spring equations.
buckling_spring, a MATLAB code which defines the buckling spring equations.
buckling_spring, an Octave code which defines the buckling spring equations.
bufpak, a FORTRAN77 code which reads and writes data to an unformatted, direct access file.
build_layers, a FreeFem++ code which shows how a 3D mesh can be constructed using repeated layers of a 2D mesh.
bump, a Fortran90 code which solves a 2D steady incompressible flow problem set in a channel with a small bump.
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 code which solves the time dependent inviscid Burgers equation using the method of characteristics, by Mikel Landajuela.
burgers_pde_etdrk4, a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Burgers PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
burgers_pde_etdrk4, an Octave code which uses the exponential time differencing (ETD) RK4 method to solve the Burgers PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
burgers_exact, a C code which evaluates exact solutions of the time-dependent 1D viscous Burgers equation.
burgers_exact, a C++ code which evaluates exact solutions of time-dependent 1D viscous Burgers equation.
burgers_exact, a Fortran77 code which evaluates an exact solution of the time-dependent 1D viscous Burgers equation.
burgers_exact, a Fortran90 code which evaluates exact solutions of time-dependent 1D viscous Burgers equation.
burgers_exact, a MATLAB code which evaluates exact solutions of time-dependent 1D viscous Burgers equation.
burgers_exact, an Octave code which evaluates exact solutions of time-dependent 1D viscous Burgers equation.
burgers_exact, a Python code which evaluates exact solutions of time-dependent 1D viscous Burgers equation.
burgers_steady_viscous, a MATLAB code 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 the Newton method to solve the resulting nonlinear system.
burgers_steady_viscous, an Octave code 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 the Newton method to solve the resulting nonlinear system.
burgers_steady_viscous, a FENICS code which uses the finite element method (FEM) to solve a version of the steady viscous Burgers equation over the interval [-1,+1].
burgers_time_inviscid, a MATLAB code 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_inviscid, an Octave code 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 FENICS code which uses the finite element method (FEM) to solve a version of the time-dependent viscous Burgers equation over the interval [-1,+1].
burgers_time_viscous, a MATLAB code 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, an Octave code which solves the time-dependent viscous Burgers equation using a finite difference method (FDM) discretization of the conservative form of the equation.
bvec, a C code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
bvec, a C++ code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
bvec, a Fortran77 code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
bvec, a Fortran90 code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
bvec, a MATLAB code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
bvec, an Octave code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
bvec, a Python code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
bvls, a Fortran77 code 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 code 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, a FENICS code which solves two-point boundary value problems (BVP) in 1D.
bvp_fd, a MATLAB code which demonstrates the use of the finite difference method (FDM) to solve a boundary value problem (BVP).
bvp_fd, an Octave code which demonstrates the use of the finite difference method (FDM) to solve a boundary value problem (BVP).
bvp_fd, a Python code which demonstrates the use of the finite difference method (FDM) to solve a boundary value problem (BVP).
bvp_shooting_test, a MATLAB code which demonstrates the use of the shooting method to solve a boundary value problem (BVP).
bvp_shooting_test, an Octave code which demonstrates the use of the shooting method to solve a boundary value problem (BVP).
bvp4c_test, a MATLAB code which calls bvp4c(), which can solve boundary value problems (BVP) in one spatial dimension.
bvpexample, an R code which determines the correct additional initial condition to convert a boundary value problem (BVP) into an initial value problem (IVP).
bvpsol, a Fortran77 code which solves a highly nonlinear two point boundary value problem (BVP) using a local linear condensing algorithm solver or a global sparse linear solver for the solution of the arising linear subproblems, by Peter Deuflhard, Georg Bader, Lutz Weimann.
bwlabel_test, a MATLAB code which calls bwlabel(), which is given a binary matrix, and organizes the 1 values into labeled clusters, using 4-way or 8-way connectivity.
bwlabel_test, an Octave code which calls bwlabel(), which is given a binary matrix, and organizes the 1 values into labeled clusters, using 4-way or 8-way connectivity. For Octave, bwlabel() is part of the image() package.
bzip2, examples which use bzip2(), which compresses a single file, and bunzip2(), which reverses the compression.
c_test, a C code which illustrates some of the features of the C language.
c_arrays_test, a C code which uses vectors, matrices and tensors.
c_calls_f77_test, a C code which calls a Fortran77 subroutine.
c_calls_f90_test, a C code which calls a Fortran90 subroutine.
c_combinatorics, a C code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
c_comment, a Fortran90 code which makes a copy of a file where C++ style comments have been replaced by C-style comments.
c_condor, a C code which illustrates how a C code can be run in batch mode using the condor queueing system.
c_exact, a C code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
c_files_test, a C code which uses files.
c_intrinsics_test, a C code which use intrinsic functions.
c_mistake, a C code which illustrates some simple but devious mistakes in C.
c_monte_carlo, a C code which uses Monte Carlo sampling to estimate areas and integrals.
c_operators_test, a C code which uses the operators supplied by the C language.
c_random_test, a C code which uses random number generator (RNG) functions.
c_rule, a C code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as, a circle, a disk, an ellipse, a triangle, a quadrilateral, a polygon, a sphere, a ball, a hypercube, and which might include an associated weight function w(x).
c_shell, examples which illustrate the use of C shell scripts.
c_simulation, a C code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
c++_calls_c_test, a C++ code which calls a C function.
c++_calls_f77_test, a C++ code which calls a Fortran77 subroutine.
c++_calls_f90_test, a C++ code which calls a Fortran90 subroutine.
c++_condor, a C++ code which runs in batch mode using the Condor queueing system.
c4_complex_lib, a C code which defines a complex 32 bit (C4) variable as a structure, and implements certain corresponding elementary functions.
c4_complex_lib, a C++ code which defines a class called c4_complex for complex 32 bit arithmetic.
c4lib, a C code which implements certain elementary functions for complex 32 bit arithmetic using the C99 float complex datatype.
c4lib,
a C++ code which
implements certain elementary functions for
complex 32 bit (C4) variables
using the C++ complex
c4lib, a Fortran77 code which implements certain elementary functions for complex 32 bit (C4) variables;
c4lib, a Fortran90 code which implements certain elementary functions for complex 32 bit (C4) variables;
c4lib, a MATLAB code which implements certain elementary functions for complex 32 bit (C4) variables.
c4lib, a Python code which implements certain elementary functions for complex 32 bit (C4) variables.
c8_complex_lib, a C code which defines a complex 64 bit (C8) variable as a structure, and implements certain corresponding elementary functions.
c8_complex_lib, a C++ code which defines a class called c8_complex for complex 64 bit arithmetic.
c8lib, a C code which implements certain elementary functions for complex 64 bit arithmetic.
c8lib, a C++ code which implements certain elementary functions for complex 64 bit (C8) variables using the C++ complex <double> datatype.
c8lib, a Fortran77 code which implements certain elementary functions for complex 64 bit (C8) variables;
c8lib, a Fortran90 code which implements certain elementary functions for complex 64 bit (C8) variables;
c8lib, a MATLAB code which implements certain elementary functions for complex 64 bit (C8) variables;
c8lib, an Octave code which implements certain elementary functions for complex 64 bit (C8) variables;
c8lib, a Python code which implements certain elementary functions for complex 64 bit (C8) variables;
c8poly, a C code which operates on complex polynomials.
c8poly, a C++ code which operates on complex polynomials.
c8poly, a Fortran90 code which operates on complex polynomials.
caesar, a C code which applies a Caesar Shift Cipher to a string of text.
caesar, a C++ code which applies a Caesar Shift Cipher to a string of text.
caesar, a Fortran90 code which applies a Caesar Shift Cipher to a string of text.
caesar, a MATLAB code which applies a Caesar Shift Cipher to a string of text.
caesar, a Python code which applies a Caesar Shift Cipher to a string of text.
calcomp, a Fortran77 code which accepts several calls to Calcomp pen plotter routines, and tries to create a PostScript file corresponding to the desired image.
calendar_nyt, a Fortran90 code which shows the correspondence between dates and the New York Times volume and issue number;
calendar_nyt, a MATLAB code which shows the correspondence between dates and the New York Times volume and issue number;
calendar_nyt, an Octave code which shows the correspondence between dates and the New York Times volume and issue number;
calendar_rd, a C++ code which computes the representation of a given date in a number of calendrical systems, by Edward Reingold, Nachum Dershowitz.
calpak, a C code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
calpak, a C++ code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
calpak, a Fortran90 code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
calpak, a MATLAB code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
calpak, an Octave code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
calpak, a Python code which computes various simple calendrical quantities. It can work with various calendars including Egyptian, English, French Revolutionary, Gregorian, Julian, and Julian Ephemeris Date. It can convert a date from one calendar to another. It can return the day of the week for a given date. It can convert from day-number/year to day/month/year format. It can calculate the time difference between two dates.
cancer_classify_decision, a scikit-learn code which uses a decision tree algorithm to classify the breast cancer dataset, comparing the training and testing accuracy as the depth of the tree is varied.
cancer_classify_forest, a scikit-learn code which uses the random forest algorithm to classify the breast cancer dataset.
cancer_classify_gradboost, a scikit-learn code which uses the gradient boosting algorithm to classify the breast cancer dataset.
cancer_classify_knn, a scikit-learn code which uses the k-nearest neighbor algorithm to classify the breast cancer dataset, comparing the training and testing accuracy as the number of neighbors is increased.
cancer_classify_logistic, a scikit-learn code which uses logistic regression to classify the breast cancer dataset, investigating the influence of the C parameter.
cancer_classify_mlp, a scikit-learn code which uses a multilayer perceptron to classify the breast cancer dataset.
cancer_classify_svm_rbf, a scikit-learn code which uses the support vector algorithm with RBF kernel on the cancer dataset, showing that the data should be rescaled to avoid overfitting.
cancer_scale_minmax, a scikit-learn code which uses the min-max scaling to preprocess the cancer dataset.
cancer_visualize_histogram, a scikit-learn code which displays all 30 features of the cancer dataset as histograms of feature frequence for malignant versus benign cases.
cancer_visualize_pca, a scikit-learn code which uses principal component analysis (PCA) of the cancer dataset to visualize the difference between malignant and benign cases.
candy_count, a C code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
candy_count, a C++ code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
candy_count, a Fortran77 code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
candy_count, a Fortran90 code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
candy_count, a MATLAB code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
candy_count, an Octave code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
candy_count, a Python code which counts the types of candy in a rectangular container, which might be a vector, matrix, or 3D box. The candy is assumed to have C possible types, and to have been entered into the container in a cycle that begins with type 1. While the vector case is easy, it is already difficult to come up with a general formula for the MxN matrix case.
capacitor_2d, a FreeFem++ code which simulates the behavior of a 2D capacitor, and writes the resulting data to files, using the ffmatlib() interface, for subsequent graphics processing by MATLAB or Octave.
capacitor_2d_test, a MATLAB code which plots data from a model of a 2D capacitor, computed by FreeFem++() and transferred using ffmatlib().
capacitor_2d_test, an Octave code which plots data from a model of a 2D capacitor, computed by FreeFem++() and transferred using ffmatlib()=.
capacitor_3d, a FreeFem++ code which simulates the behavior of a 3D capacitor, and writes the resulting data to files, using ffmatlib(), for subsequent graphics processing by MATLAB or Octave.
capacitor_3d_test, a MATLAB code which plots data from a model of a 3D capacitor, computed by FreeFem++() and transferred using ffmatlib().
capacitor_3d_test, an Octave code which plots data from a model of a 3D capacitor, computed by FreeFem++() and transferred using ffmatlib().
case1_flow, a dataset directory which 401 solutions of a flow problem in a channel governed by the Navier Stokes equations (NSE);
casino_simulation, a MATLAB code which simulates a casino game that gives you 20% of your bet for heads, and only takes 17% for tails. How much will you end up winning?
casino_simulation, an Octave code which simulates a casino game that gives you 20% of your bet for heads, and only takes 17% for tails. How much will you end up winning?
casino_simulation, a Python code which simulates a casino game that gives you 20% of your bet for heads, and only takes 17% for tails. How much will you end up winning?
catalog, a C++ code which reads a C, C++, Fortran77, Fortran90, MATLAB, Octave, Python, or R code and prints every line that begins with a special index tag. If the code has been marked up expecting this convention, a convenient table of contents will be created.
cauchy_method, a MATLAB code which solves one or more ordinary differential equations (ODE) using the Cauchy method.
cauchy_method, a Python code which solves one or more ordinary differential equations (ODE) using the Cauchy method.
cauchy_principal_value, a C code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
cauchy_principal_value, a C++ code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
cauchy_principal_value, a Fortran77 code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
cauchy_principal_value, a Fortran90 code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
cauchy_principal_value, a MATLAB code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
cauchy_principal_value, an Octave code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
cauchy_principal_value, a Python code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
caustic, a MATLAB code which generates an image of a caustic curve, by drawing n equally spaced points in a circle, and then connecting specific pairs of points using a spacing parameter m.
caustic, an Octave code which generates an image of a caustic curve, by drawing n equally spaced points in a circle, and then connecting specific pairs of points using a spacing parameter m.
caustic, a Python code which generates an image of a caustic curve, by drawing n equally spaced points in a circle, and then connecting specific pairs of points using a spacing parameter m.
caustic_opengl, a C++ code which generates an image of a caustic curve, by drawing n equally spaced points in a circle, and then connecting specific pairs of points using a spacing parameter m, 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 code which displays a single velocity field solution for the driven cavity;
cavity_flow_display, an Octave code which displays a single velocity field solution for the driven cavity;
cavity_flow_movie, a MATLAB code which animates the velocity solutions for the driven cavity;
cbezier, an R code which evaluates a cubic Bezier curve.
cblas_test, a C code which uses cblas, which is a C translation of the Fortran77 Basic Linear Algebra Subprograms (BLAS), used by the C translation of the Fortran77 lapack() linear algebra library.
cblas_test, a C++ code which illustrates the use of the CBLAS, a C translation of the Fortran77 Basic Linear Algebra Subprograms (BLAS), used by the C translation of lapack().
cc_display, a MATLAB code which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
cc_display, an Octave code which displays the points used in a 2D Clenshaw-Curtis quadrature rule;
cc_project, a MATLAB code which computes generalized Clenshaw-Curtis quadrature rules for semi-infinite and infinite intervals, by John Boyd.
ccl_test, a MATLAB code 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.
ccl_test, an Octave code 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 code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
ccn_rule, a C++ code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
ccn_rule, a Fortran77 code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
ccn_rule, a Fortran90 code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
ccn_rule, a MATLAB code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
ccn_rule, an Octave code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
ccn_rule, a Python code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
ccs, a data directory which contains instances of the Compressed Column Storage (CCS) sparse matrix file format;
ccs_io, a C code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
ccs_io, a C++ code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
ccs_io, a Fortran77 code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
ccs_io, a Fortran90 code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
ccs_io, a MATLAB code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
ccs_io, an Octave code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
ccs_io, a Python code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
ccs_to_st, a C code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
ccs_to_st, a C++ code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
ccs_to_st, a Fortran77 code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
ccs_to_st, a Fortran90 code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
ccs_to_st, a MATLAB code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
ccs_to_st, an Octave code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
ccs_to_st, a Python code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
ccvt_reflect, a Fortran90 code which carries out a constrained Centroidal Voronoi Tessellation (CVT) calculation that tries to include points on the boundary as well as the interior, using a natural nonparametric technique;
ccvt_reflect, a MATLAB code which carries out a constrained Centroidal Voronoi Tessellation (CVT) calculation that tries to include points on the boundary as well as the interior, using a natural nonparametric technique;
ccvt_reflect, an Octave code which carries out a constrained Centroidal Voronoi Tessellation (CVT) calculation that tries to include points on the boundary as well as the interior, using a natural nonparametric technique;
cddlib, examples which use CDDLIB, which interprets 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 code 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++ code 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 code 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 ncdump();
cell, a C code which defines a cell array, a generalization of an array which compactly stores and retrieves vector or matrix data of varying size, such as the rows of a triangular matrix.
cell, a C++ code which defines a cell array, a generalization of an array which compactly stores and retrieves vector or matrix data of varying size, such as the rows of a triangular matrix.
cell, a Fortran77 code which defines a cell array, a generalization of an array which compactly stores and retrieves vector or matrix data of varying size, such as the rows of a triangular matrix.
cell, a Fortran90 code which defines a cell array, a generalization of an array which compactly stores and retrieves vector or matrix data of varying size, such as the rows of a triangular matrix.
cell, a MATLAB code which defines a cell array, a generalization of an array which compactly stores and retrieves vector or matrix data of varying size, such as the rows of a triangular matrix.
cell_detection_tasks, a MATLAB code which creates modified versions of a sequence of gray-scale tagged image files (TIF) containing images of cells; the processing of each file is carried out independently, using the task feature of the MATLAB parallel computing toolbox.
cellular_automaton, a C code which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.
cellular_automaton, a C++ code which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.
cellular_automaton, a Fortran77 code which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.
cellular_automaton, a Fortran90 code which demonstrates the behavior of the 1D Cellular Automaton known as rule #30.
cellular_automaton, a MATLAB code which prints or plots the evolution of Cellular Automaton rule #30.
cellular_automaton, an Octave code which prints or plots the evolution of Cellular Automaton rule #30.
cellular_automaton, a Python code which prints or plots the evolution of Cellular Automaton rule #30.
census, a dataset directory which contains US census data;
cfd_barba, a Python code which contains plain Python scripts of some of the iPython workbooks associated with the "12 Steps to Navier-Stokes Equations" (NSE) presentation by Lorena Barba.
cg, a C code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations where the matrix A is symmetric positive definite (SPD).
cg, a C++ code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations where the matrix A is symmetric positive definite (SPD).
cg, a Fortran77 code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations where the matrix A is symmetric positive definite (SPD).
cg, a Fortran90 code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations where the matrix A is symmetric positive definite (SPD).
cg, a MATLAB code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations where the matrix A is symmetric positive definite (SPD).
cg, an Octave code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations where the matrix A is symmetric positive definite (SPD).
cg, a Python code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations where the matrix A is symmetric positive definite (SPD).
cg_distributed, a MATLAB code which implements a version of the Conjugate Gradient (CG) NAS Parallel Benchmark using distributed memory.
cg_lab_triangles, a MATLAB code which implements a computer lab assignment on computational geometry and triangles;
cg_ne, a MATLAB code which implements the conjugate gradient method (CG) for the normal equations, that is, a method for solving a system of linear equations of the form A*x=b, where the matrix A is not symmetric positive definite (SPD). In this case, it is attempted to set up and solve the normal equations A'*A*x=A'*b.
cg_ne, an Octave code which implements the conjugate gradient method (CG) for the normal equations, that is, a method for solving a system of linear equations of the form A*x=b, where the matrix A is not symmetric positive definite (SPD). In this case, it is attempted to set up and solve the normal equations A'*A*x=A'*b.
cg_plus, a Fortran77 code which implements the conjugate gradient (CG) method for minimizing a scalar function of multiple variables.
cg_rc, a C code which implements the conjugate gradient (CG) method for solving a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
cg_rc, a C++ code which implements the conjugate gradient (CG) method for solving a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
cg_rc, a Fortran77 code which implements the conjugate gradient (CG) method for solvireversng a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
cg_rc, a Fortran90 code which implements the conjugate gradient (CG) method for solving a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
cg_rc, a MATLAB code which implements the conjugate gradient (CG) method for solving a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
cg_rc, a Python code which implements the conjugate gradient (CG) method for solving a symmetric positive definite (SPD) sparse linear system A*x=b, using reverse communication (RC).
cg_squared, a MATLAB code which implements the conjugate gradient squared (CGS) method for solving a nonsymmetric sparse linear system A*x=b.
cg_squared, an Octave code which implements the conjugate gradient squared (CGS) method for solving a nonsymmetric sparse linear system A*x=b.
chain_letter_tree, a MATLAB code 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_diophantine, a MATLAB code which sets up a Diophantine equation to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_diophantine, an Octave code which sets up a Diophantine equation to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_diophantine, a Python code which sets up a Diophantine equation to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_dynamic, a C code which uses dynamic programming to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_dynamic, a C++ code which uses dynamic programming to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_dynamic, a Fortran77 code which uses dynamic programming to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_dynamic, a Fortran90 code which uses dynamic programming to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_dynamic, a MATLAB code which uses dynamic programming to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_dynamic, an Octave code which uses dynamic programming to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_dynamic, a Python code which uses dynamic programming to solve the change making problem, which counts the number of ways a given sum can be formed using coins of various denominations.
change_greedy, a MATLAB code which uses the greedy method to seek a solution to the change making problem, which tries to match a given amount by selecting coins of various denominations.
change_greedy, an Octave code which uses the greedy method to seek a solution to the change making problem, which tries to match a given amount by selecting coins of various denominations.
change_greedy, a Python code which uses the greedy method to seek a solution to the change making problem, which tries to match a given amount by selecting coins of various denominations.
change_making, a dataset directory which contains test data for the change making problem;
change_polynomial, a MATLAB code which uses a polynomial multiplication algorithm to count the ways of making various sums using a given number of coins.
change_polynomial, an Octave code which uses a polynomial multiplication algorithm to count the ways of making various sums using a given number of coins.
change_polynomial, a Python code which uses a polynomial multiplication algorithm to count the ways of making various sums using a given number of coins.
channel, a Fortran90 code which computes the time-independent flow of a viscous incompressible fluid in a 2D channel.
channel_navier_stokes, a FreeFem++ code which sets up the time dependent Navier Stokes equations (NSE) for flow in a channel with a circular obstruction.
channel_stokes_steady, a FreeFem++ code which solves the time-independent Stokes equations for channel flow.
chebyshev, a C code which computes the Chebyshev interpolant or approximant to a given function over an interval.
chebyshev, a C++ code which computes the Chebyshev interpolant or approximant to a given function over an interval.
chebyshev, a Fortran77 code which computes the Chebyshev interpolant or approximant to a given function over an interval.
chebyshev, a Fortran90 code which computes the Chebyshev interpolant or approximant to a given function over an interval.
chebyshev, a MATLAB code which computes the Chebyshev interpolant or approximant to a given function over an interval.
chebyshev, an Octave code which computes the Chebyshev interpolant or approximant to a given function over an interval.
chebyshev, a Python code which computes the Chebyshev interpolant or approximant to a given function over an interval.
chebyshev_interp_1d, a C code which determines the combination of Chebyshev polynomials that interpolates data, so that p(x(i)) = y(i).
chebyshev_interp_1d, a C++ code which determines the combination of Chebyshev polynomials that interpolates data, so that p(x(i)) = y(i).
chebyshev_interp_1d, a Fortran77 code which determines the combination of Chebyshev polynomials that interpolates data, so that p(x(i)) = y(i).
chebyshev_interp_1d, a Fortran90 code which determines the combination of Chebyshev polynomials that interpolates data, so that p(x(i)) = y(i).
chebyshev_interp_1d, a MATLAB code which determines the combination of Chebyshev polynomials that interpolates data, so that p(x(i)) = y(i).
chebyshev_interp_1d, an Octave code which determines the combination of Chebyshev polynomials that interpolates data, so that p(x(i)) = y(i).
chebyshev_interp_1d, a Python code which determines the combination of Chebyshev polynomials that interpolates data, so that p(x(i)) = y(i).
chebyshev_matrix, a MATLAB code which defines the Chebyshev differentiation matrix, by Lloyd Trefethen.
chebyshev_matrix, an Octave code which defines the Chebyshev differentiation matrix, by Lloyd Trefethen.
chebyshev_polynomial, a C code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_polynomial, a C++ code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_polynomial, a Fortran77 code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_polynomial, a Fortran90 code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_polynomial, a MATLAB code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_polynomial, an Octave code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_polynomial, a Python code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
chebyshev_series, a C code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
chebyshev_series, a C++ code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
chebyshev_series, a Fortran77 code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
chebyshev_series, a Fortran90 code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
chebyshev_series, a MATLAB code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
chebyshev_series, an Octave code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two, three or four derivatives of the series, by Manfred Zimmer.
chebyshev1_exactness, a C++ code which tests the exactness of Gauss-Chebyshev type 1 quadrature rules.
chebyshev1_exactness, a Fortran90 code which tests the exactness of Gauss-Chebyshev type 1 quadrature rules.
chebyshev1_exactness, a MATLAB code which tests the exactness of Gauss-Chebyshev type 1 quadrature rules.
chebyshev1_exactness, an Octave code which tests the exactness of Gauss-Chebyshev type 1 quadrature rules.
chebyshev1_exactness, a Python code which tests the exactness of Gauss-Chebyshev type 1 quadrature rules.
chebyshev1_rule, a C++ code which computes a Gauss-Chebyshev type 1 quadrature rule.
chebyshev1_rule, a Fortran90 code which computes a Gauss-Chebyshev type 1 quadrature rule.
chebyshev1_rule, a MATLAB code which computes a Gauss-Chebyshev type 1 quadrature rule.
chebyshev1_rule, an Octave code which computes a Gauss-Chebyshev type 1 quadrature rule.
chebyshev1_rule, a Python code which computes a Gauss-Chebyshev type 1 quadrature rule.
chebyshev2_exactness, a C++ code which tests the exactness of Gauss-Chebyshev type 2 quadrature rules.
chebyshev2_exactness, a Fortran90 code which tests the exactness of Gauss-Chebyshev type 2 quadrature rules.
chebyshev2_exactness, a MATLAB code which tests the exactness of Gauss-Chebyshev type 2 quadrature rules.
chebyshev2_exactness, an Octave code which tests the exactness of Gauss-Chebyshev type 2 quadrature rules.
chebyshev2_exactness, a Python code which tests the exactness of Gauss-Chebyshev type 2 quadrature rules.
chebyshev2_rule, a C++ code which computes a Gauss-Chebyshev type 2 quadrature rule.
chebyshev2_rule, a Fortran90 code which computes a Gauss-Chebyshev type 2 quadrature rule.
chebyshev2_rule, a MATLAB code which computes a Gauss-Chebyshev type 2 quadrature rule.
chebyshev2_rule, an Octave code which computes a Gauss-Chebyshev type 2 quadrature rule.
chebyshev2_rule, a Python code which computes a Gauss-Chebyshev type 2 quadrature rule.
chemotaxis, a FreeFem++ code which models the time-dependent growth of cells which secrete a chemoattractant, causing patterns to form.
chen_ode, a MATLAB code which sets up and solves the Chen ordinary differential equation (ODE) which has chaotic behavior and an attractor.
chen_ode, an Octave code which sets up and solves the Chen ordinary differential equation (ODE) which has chaotic behavior and an attractor.
chen_ode, a Python code which sets up and solves the Chen ordinary differential equation (ODE) which has chaotic behavior and an attractor.
cheney_kincaid, a MATLAB code which contains examples from the text 'Numerical Mathematics and Computing', by Cheney and Kincaid.
cheney_kincaid, an Octave code which contains examples from the text 'Numerical Mathematics and Computing', by Cheney and Kincaid.
chinese_remainder_theorem, a MATLAB code which demonstrates the Chinese remainder theorem, for reconstructing a number based on its remainders against a set of bases.
chinese_remainder_theorem_test
chinese_remainder_theorem, an Octave code which demonstrates the Chinese remainder theorem, for reconstructing a number based on its remainders against a set of bases.
chinese_remainder_theorem_test
chinese_remainder_theorem, a Python code which demonstrates the Chinese remainder theorem, for reconstructing a number based on its remainders against a set of bases.
chirikov_iteration, a MATLAB code which applies the Chirikov map repeatedly to a given (x,y) initial condition.
chirikov_iteration, an Octave code which applies the Chirikov map repeatedly to a given (x,y) initial condition.
chladni_figures, a MATLAB code which creates Chladni figures of the eigenmodes of a thin vibrating plate, by Martin Gander and Felix Kwok.
chladni_figures, an Octave code which creates Chladni figures of the eigenmodes of a thin vibrating plate, by Martin Gander and Felix Kwok.
choleskymatrix, an R code which computes the Cholesky L*L' factorization of a matrix.
chrominoes, a MATLAB code which searches for tilings of a polygonal region using polyominoes, in which a coloring scheme is used to reduce the problem size and quickly eliminate certain arrangements.
chrpak, a C code which works with characters and strings.
chrpak, a C++ code which works with characters and strings.
chrpak, a Fortran77 code which works with characters and strings.
chrpak, a Fortran90 code which works with characters and strings.
chrpak, a MATLAB code which works with characters and strings.
chrpak, an Octave code which works with characters and strings.
chrpak, a Python code which works with characters and strings.
chuckaluck_simulation, a MATLAB code which simulates the Chuck-a-Luck gambling game.
chuckaluck_simulation, an Octave code which simulates the Chuck-a-Luck gambling game.
chuckaluck_simulation, a Python code which simulates the Chuck-a-Luck gambling game.
circle_arc_grid, a C code which computes a grid of points over the length of a circle or circular arc in 2D.
circle_arc_grid, a C++ code which computes a grid of points over the length of a circle or circular arc in 2D.
circle_arc_grid, a Fortran77 code which computes a grid of points over the length of a circle or circular arc in 2D.
circle_arc_grid, a Fortran90 code which computes a grid of points over the length of a circle or circular arc in 2D.
circle_arc_grid, a MATLAB code which computes a grid of points over the length of a circle or circular arc in 2D.
circle_arc_grid, an Octave code which computes a grid of points over the length of a circle or circular arc in 2D.
circle_arc_grid, a Python code which computes a grid of points over the length of a circle or circular arc in 2D.
circle_circles_packing, a MATLAB code which tries to randomly pack as many non-overlapping circles of equal size into a larger circle, with a typical final coverage density of about 0.547. This is an example of random sequential adsorption (RSA).
circle_circles_packing, an Octave code which tries to randomly pack as many non-overlapping circles of equal size into a larger circle, with a typical final coverage density of about 0.547. This is an example of random sequential adsorption (RSA).
circle_circles_packing, a Python code which tries to randomly pack as many non-overlapping circles of equal size into a larger circle, with a typical final coverage density of about 0.547. This is an example of random sequential adsorption (RSA).
circle_classify_gradboost, a scikit-learn code which uses the gradient boost algorithm to classify the artificial circle dataset, and then determines the prediction uncertainties.
circle_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the unit circle in 2D.
circle_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the unit circle in 2D.
circle_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the unit circle in 2D.
circle_grid_display, a MATLAB code which reads a matrix of integers, and draws a corresponding grid of circles filled with color.
circle_integrals, a C code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_integrals, a C++ code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_integrals, an Octave code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_integrals, a Python code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
circle_map, a MATLAB code which illustrates how a matrix maps points on the unit circle to an ellipse.
circle_map, an Octave code which illustrates how a matrix maps points on the unit circle to an ellipse.
circle_monte_carlo, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code which applies a Monte Carlo method to estimate the integral of a function on the circumference of the unit circle in 2D;
circle_packing, a Fortran90 code which performs a circle-packing test on the spacing for points;
circle_positive_distance, a MATLAB code which estimates the mean and variance of the distance between a random pair of points on the circumference of the unit positive circle in 2D.
circle_positive_distance, an Octave code which estimates the mean and variance of the distance between a random pair of points on the circumference of the unit positive circle in 2D.
circle_positive_distance, a Python code which estimates the mean and variance of the distance between a random pair of points on the circumference of the unit positive circle in 2D.
circle_rule, a C code which computes a quadrature rule for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
circle_rule, a C++ code which computes quadrature rules for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
circle_rule, a Fortran77 code which computes quadrature rules for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
circle_rule, a Fortran90 code which computes quadrature rules for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
circle_rule, a MATLAB code which computes quadrature rules for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
circle_rule, a Python code which computes quadrature rules for the unit circle in 2D, to approximate integrals of f(x,y) over the circumference of the circle of radius 1 and center (0,0).
circle_segment, a C code 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++ code 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 code 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 code 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 code which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.
circle_segment, an Octave code which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature.
circles, a MATLAB code which draws one or more circles, while controlling the center locations, radii, colors, edge colors, and transparency, by Chad Greene.
circles, an Octave code which draws one or more circles, while controlling the center locations, radii, colors, edge colors, and transparency, by Chad Greene.
cities, a dataset directory which contains sets of information about cities and the distances between them;
cities, a C++ code which handles various problems associated with cities on a map.
cities, a Fortran90 code which handles various problems associated with cities on a map.
cities, a MATLAB code which handles various problems associated with cities on a map.
cities, an Octave code which handles various problems associated with cities on a map.
clapack_test, a C code which uses clapack(), which is a C translation of the Fortran77 BLAS and lapack linear algebra libraries, including real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic.
clapack_test, a C++ code which uses clapack(), which is a C translation of the Fortran77 BLAS and lapack linear algebra libraries, including real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic.
clapack, examples which use clapack(), which is a C translation of the Fortran77 BLAS and lapack linear algebra libraries, including real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic.
clausen, a C code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
clausen, a C++ code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
clausen, a Fortran90 code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
clausen, a MATLAB code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
clausen, an Octave code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
clausen, a Python code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
clean77, a Fortran77 code which reformats a Fortran77 file, using some standard indenting and numbering conventions.
clebsch_gordan, a Fortran77 code which evaluates Clebsch-Gordan coefficients involved in angular momentum coupling in quantum mechanics;
clenshaw_curtis_grid, a C++ code which sets up a Clenshaw Curtis quadrature rule in multiple dimensions;
clenshaw_curtis_grid, a Fortran90 code which sets up a Clenshaw Curtis quadrature rule in multiple dimensions;
clenshaw_curtis_rule, a C code which defines a Clenshaw Curtis quadrature rule.
clenshaw_curtis_rule, a C++ code which defines a Clenshaw Curtis quadrature rule.
clenshaw_curtis_rule, a Fortran77 code which defines a Clenshaw Curtis quadrature rule.
clenshaw_curtis_rule, a Fortran90 code which defines a Clenshaw Curtis quadrature rule.
clenshaw_curtis_rule, a MATLAB code which defines a Clenshaw Curtis quadrature rule.
clenshaw_curtis_rule, an Octave code which defines a Clenshaw Curtis quadrature rule.
clenshaw_curtis_rule, a Python code which defines a Clenshaw Curtis quadrature rule.
clock_solitaire_simulation, a MATLAB code which simulates the game of clock solitaire. The deck is dealt into 13 piles of 4 cards each. Repeatedly, the top card a pile is removed, and its rank indicates the next pile to consider. Game continues until an empty pile is reached. The game is won if all piles are empty. The quantity of interest is the probability of winning.
clock_solitaire_simulation_test
clock_solitaire_simulation, an Octave code which simulates the game of clock solitaire. The deck is dealt into 13 piles of 4 cards each. Repeatedly, the top card a pile is removed, and its rank indicates the next pile to consider. Game continues until an empty pile is reached. The game is won if all piles are empty. The quantity of interest is the probability of winning.clock_solitaire_simulation_test
clock_solitaire_simulation, a Python code which simulates the game of clock solitaire. The deck is dealt into 13 piles of 4 cards each. Repeatedly, the top card a pile is removed, and its rank indicates the next pile to consider. Game continues until an empty pile is reached. The game is won if all piles are empty. The quantity of interest is the probability of winning.closest_pair_brute, a C code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
oclosest_pair_brute, a C++ code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
closest_pair_brute, a Fortran90 code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
closest_pair_brute, a MATLAB code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
closest_pair_brute, an Octave code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
closest_pair_brute, a Python code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
closest_pair_divcon, a MATLAB code which uses a divide and conquer approach to solve a 2D version of the closest pair problem.
closest_pair_divcon, an Octave code which uses a divide and conquer approach to solve a 2D version of the closest pair problem.
closest_pair_divcon, a Python code which uses a divide and conquer approach to solve a 2D version of the closest pair problem.
closest_point_brute, a C code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
closest_point_brute, a C++ code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
closest_point_brute, a Fortran77 code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
closest_point_brute, a Fortran90 code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
closest_point_brute, a MATLAB code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
closest_point_brute, an Octave code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
closest_point_brute, a Python code which uses brute force to find the nearest of a set of N points in D dimensions to a given test point. This is sometimes called a nearest neighbor calculation.
cloud, a FreeFem++ code which starts with a black and white drawing of a cloud, uses MATLAB to extract the boundary, reads the boundary into FreeFem++ and solves a Poisson problem over the region.
cluster_energy, a Fortran90 code which groups data into a given number of clusters to minimize the energy.
cmake, examples which use CMAKE, which is a software project management system.
cnf, a data directory which contains DIMACS Conjunctive Normal Form (CNF) files defining satisfiability problems in terms of a boolean formula.
cnf_io, a C++ code which reads or writes DIMACS Conjunctive Normal Form (CNF) files defining satisfiability problems in terms of a boolean formula.
cnf_io, a Fortran77 code which reads or writes DIMACS Conjunctive Normal Form (CNF) files defining satisfiability problems in terms of a boolean formula.
cnf_io, a Fortran90 code which reads or writes DIMACS Conjunctive Normal Form (CNF) files defining satisfiability problems in terms of a boolean formula.
cnoise, a C code which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
cnoise, a MATLAB code which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
cnoise, an Octave code which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
cobweb_plot, a MATLAB code which displays a cobweb plot illustrating the process of function iteration.
cobweb_plot, a Python code which displays a cobweb plot illustrating the process of function iteration, by John D Cook.
codepack, a Fortran90 code which determine if two graphs are isomorphic.
coin_simulation, a MATLAB code which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.
coin_simulation, an Octave code which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.
coin_simulation, a Python code which looks at ways of simulating or visualizing the results of many tosses of a fair or biased coin.
collatz, a Mathematica code which reads an integer from the user and computes the Collatz sequence based on that integer.
collatz, a MATLAB code which computes and analyzes the Collatz or hailstone or 3n+1 sequence;
collatz, an Octave code which computes and analyzes the Collatz or hailstone or 3n+1 sequence;
collatz, a Python code which computes and analyzes the Collatz or hailstone or 3n+1 sequence;
collatz_dict, a Python code which demonstrates how the Python dict variable type can be used to efficiently record data about the Collatz iteration.
collatz_parfor, a MATLAB code which seeks the maximum Collatz sequence between 1 and N, running in parallel using the parfor() feature.
collatz_polynomial, a MATLAB code which implements the Collatz polynomial iteration, a polynomial analog of the numerical iteration that is also known as the 3n+1 conjecture or the hailstone sequence.
collatz_polynomial, an Octave code which implements the Collatz polynomial iteration, a polynomial analog of the numerical iteration that is also known as the 3n+1 conjecture or the hailstone sequence.
collatz_polynomial, a Python code which implements the Collatz polynomial iteration, a polynomial analog of the numerical iteration that is also known as the 3n+1 conjecture or the hailstone sequence.
collatz_recursive, a C code which demonstrates recursive programming for the simple Collatz 3n+1 problem.
collatz_recursive, a C++ code which demonstrates recursive programming for the simple Collatz 3n+1 problem.
collatz_recursive, a Fortran90 code which demonstrates recursive programming for the simple Collatz 3n+1 problem.
collatz_recursive, a MATLAB code which demonstrates recursive programming for the simple Collatz 3n+1 problem.
collatz_recursive, an Octave code which demonstrates recursive programming for the simple Collatz 3n+1 problem.
collatz_recursive, a Python code which demonstrates recursive programming for the simple Collatz 3n+1 problem.
collocation, a MATLAB code which uses collocation to produce a function g(x) that satisfies the same constraints as a function f(x), but only at a discrete set of points.
collocation, an Octave code which uses 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 code which solves a boundary value problem (BVP), a mixed-order system of ordinary differential equations (ODE) subject to separated, multipoint boundary conditions, using collocation at Gaussian points, by Uri Ascher and Georg Bader.
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_digraph_adj, a Fortran90 code which carries out operations on color digraphs, a directed graph in which each node has been assigned a color. That information is stored in an adjacency matrix in which the diagonal elements record colors. Operations include counting the colors, computing in- and out-degrees, computing the in- and out-degree sequences, counting the edges, printing the adjacency matrix, generating fixed and random examples.
color_graph_adj, a Fortran90 code which carries out operations on color graphs, an undirected graph in which each node has been assigned a color. That information is stored in an adjacency matrix in which the diagonal elements record colors. Operations include counting the colors, computing degrees, computing the degree sequences, counting the edges, printing the adjacency matrix, generating fixed and random examples.
color_remote, a MATLAB code 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 the batch() facility, on a remote system.
colored_noise, a C code which generates samples of colored noise obeying a 1/f^alpha power law.
colored_noise, a C++ code which generates samples of colored noise obeying a 1/f^alpha power law.
colored_noise, a Fortran77 code which generates samples of colored noise obeying a 1/f^alpha power law.
colored_noise, a Fortran90 code which generates samples of colored noise obeying a 1/f^alpha power law.
colored_noise, a MATLAB code which generates samples of colored noise obeying a 1/f^alpha power law.
colors, a Fortran90 code which converts between various formats for describing colors;
columns, a Python code which copies columns clo:chi from a text file to a new text file.
combination_lock, a C code which simulates the process of determining the secret combination of a lock.
combination_lock, a C++ code which simulates the process of determining the secret combination of a lock.
combination_lock, a Fortran77 code which simulates the process of determining the secret combination of a lock.
combination_lock, a Fortran90 code which simulates the process of determining the secret combination of a lock.
combination_lock, a MATLAB code which simulates the process of determining the secret combination of a lock.
combination_lock, a Python code which simulates the process of determining the secret combination of a lock.
combo, a C code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
combo, a C++ code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
combo, a Fortran77 code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
combo, a Fortran90 code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
combo, a MATLAB code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
combo, an Octave code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
combo, a Python code which ranks, unranks, enumerates, lists and randomly selects balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
commandline_test, a FreeFem++ code which shows how a script accepts commandline input.
communicator_mpi, a C code which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.
communicator_mpi, a C++ code which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.
communicator_mpi, a Fortran77 code which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.
communicator_mpi, a Fortran90 code which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.
companion_matrix, a C code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
companion_matrix, a C++ code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
companion_matrix, a Fortran77 code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
companion_matrix, a Fortran90 code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
companion_matrix, a MATLAB code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
companion_matrix, an Octave code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
companion_matrix, a Python code which computes the companion matrix for a polynomial. The polynomial may be represented in the standard monomial basis, or as a sum of Chebyshev, Gegenbauer, Hermite, Laguerre, or Lagrange basis polynomials. All the roots of the polynomial can be determined as the eigenvalues of the corresponding companion matrix.
compass_search, a C code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
compass_search, a C++ code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
compass_search, a Fortran77 code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
compass_search, a Fortran90 code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
compass_search, a MATLAB code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
compass_search, an Octave code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
compass_search, a Python code 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_test, a C code which demonstrates some simple features involved in the use of complex numbers.
complex_numbers_test, a C++ code which demonstrates some simple features involved in the use of complex numbers.
complex_numbers_test, a Fortran77 code which demonstrates some simple features involved in the use of complex numbers.
complex_numbers_test, a Fortran90 code which demonstrates some simple features involved in the use of complex numbers.
complex_numbers_test, a MATLAB code which demonstrates some simple features involved in the use of complex numbers.
complex_numbers_test, an Octave code which demonstrates some simple features involved in the use of complex numbers.
complex_numbers_test, a Python code which demonstrates some simple features involved in the use of complex numbers.
components, a C code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
components, a C++ code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
components, a Fortran77 code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
components, a Fortran90 code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
components, a MATLAB code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
components, an Octave code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
components, a Python code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
condition, a C code which implements methods of computing or estimating the condition number of a matrix.
condition, a C++ code which implements methods of computing or estimating the condition number of a matrix.
condition, a Fortran77 code which implements methods of computing or estimating the condition number of a matrix.
condition, a Fortran90 code which implements methods of computing or estimating the condition number of a matrix.
condition, a MATLAB code which implements methods of computing or estimating the condition number of a matrix.
condition, an Octave code which implements methods of computing or estimating the condition number of a matrix.
condition, a Python code which implements methods of computing or estimating the condition number of a matrix.
condor, examples which use CONDOR, which is a job queueing system to submit jobs that run on a one or more remote machines.
conservation_ode, a MATLAB code which monitors the conservation of a quantity that should be constant, during the solution of an ordinary differential equation (ODE).
conservation_ode, an Octave code which monitors the conservation of a quantity that should be constant, during the solution of an ordinary differential equation (ODE).
conservation_ode, a Python code which monitors the conservation of a quantity that should be constant, during the solution of an ordinary differential equation (ODE).
conte_deboor, a Fortran77 code which contains examples from the text 'Elementary Numerical Analysis' by Conte and deBoor.
conte_deboor, a MATLAB code which contains examples from the text 'Elementary Numerical Analysis' by Conte and deBoor.
conte_deboor, an Octave code which contains examples from the text 'Elementary Numerical Analysis' by Conte and deBoor.
continuation, a MATLAB code which implements the continuation method for a simple 2D problem, involving finding a point on the unit circle, and then finding a sequence of nearby points that 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.
continuation, a Octave code which implements the continuation method for a simple 2D problem, involving finding a point on the unit circle, and then finding a sequence of nearby points that 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 code which deals with simple and generalized continued fractions.
continued_fraction, a C++ code which deals with simple and generalized continued fractions.
continued_fraction, a Fortran90 code which deals with simple and generalized continued fractions.
continued_fraction, a MATLAB code which deals with simple and generalized continued fractions.
continued_fraction, an Octave code which deals with simple and generalized continued fractions.
continued_fraction, a Python code which deals with simple and generalized continued fractions.
contour_gradient, a MATLAB code which displays contours and gradient vectors for a function f(x,y).
contour_gradient, an Octave code which displays contours and gradient vectors for a function f(x,y).
contour_gradient_3d, a MATLAB code which displays contours and gradient vectors for a function f(x,y) in a 3D plot.
contour_gradient_3d, an Octave code which displays contours and gradient vectors for a function f(x,y) in a 3D plot.
contour_sequence4, a MATLAB code 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 code 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 code which demonstrates the Single Program Multiple Data (SPMD) parallel programming feature for image operations; this improves the contrast_spmd() code by allowing the workers to share some data; this makes it possible to eliminate artificial seams in the processed image.
control_bio, a MATLAB code which optimizes a given cost functional of a biological model using optimal control, based on work by Suzanne Lenhart and John Workman.
control_bio, an Octave code which optimizes a given cost functional of a biological model using optimal control, based on work by Suzanne Lenhart and John Workman.
convect, a FreeFem++ code which shows how the FreeFem++ convect() function simulates the convection of a quantity by a velocity field.
convection, a FreeFem++ code which simulates the convection of a substance carried by a known velocity field through a winding closed channel.
convection_diffusion, a FENICS code which simulates a 1D convection diffusion problem.
convection_diffusion_stabilized, a FENICS code which simulates a 1D convection diffusion problem, using a stabilization scheme.
convective_rolls, a FreeFem++ code which calculates the convective rolling behavior of a fluid being heated from below, and writes the resulting data to files, using the ffmatlib() interface, for subsequent graphics processing by MATLAB or Octave.
convective_rolls_test, a MATLAB code which plots data describing the convective rolling behavior of a fluid being heated from below, as computed by FreeFem++() and transferred using ffmatlib().
convective_rolls_test, an Octave code which plots data describing the convective rolling behavior of a fluid being heated from below, as computed by FreeFem++() and transferred using ffmatlib().
convective_rolls_movie, a FreeFem++ code which calculates the convective rolling behavior of a fluid being heated from below, saves a snapshot at each timestep, and writes the resulting data to files, using the ffmatlib() interface, for subsequent animation by MATLAB or Octave.
convective_rolls_movie_test, a MATLAB code which animates data describing the convective rolling behavior of a fluid being heated from below, as computed by FreeFem++ and transferred using ffmatlib().
convergence, a FreeFem++ code which reports the convergence rate, as the mesh size is decreased, for the approximate solution of a simple boundary value problem (BVP).
convhull_test, a MATLAB code which demonstrates the use of the built-in function convhull() for the computation of the convex hull of 2D points.
convhull_test, an Octave code which demonstrates the use of the built-in function convhull() for the computation of the convex hull of 2D points.
ConvexHull_test, a Python code which calls ConvexHull(), which is a scipy.spatial function to compute the convex hull of a set of points.
coordinate_search, a MATLAB code which seeks the minimizer of a scalar function of several variables, by Jeff Borggaard.
coordinate_search, an Octave code which seeks the minimizer of a scalar function of several variables, by Jeff Borggaard.
cordic, a C code which uses the CORDIC method to compute certain elementary functions.
cordic, a C++ code which uses the CORDIC method to compute certain elementary functions.
cordic, a Fortran77 code which uses the CORDIC method to compute certain elementary functions.
cordic, a Fortran90 code which uses the CORDIC method to compute certain elementary functions.
cordic, a MATLAB code which uses the CORDIC method to compute certain elementary functions.
cordic, an Octave code which uses the CORDIC method to compute certain elementary functions.
cordic, a Python code which uses the CORDIC method to compute certain elementary functions.
correlation, a C code which contains examples of statistical correlation functions.
correlation, a C++ code which contains examples of statistical correlation functions.
correlation, a Fortran77 code which contains examples of statistical correlation functions.
correlation, a Fortran90 code which contains examples of statistical correlation functions.
correlation, a MATLAB code which contains examples of statistical correlation functions.
correlation, an Octave code which contains examples of statistical correlation functions.
cosine_transform, a C code which demonstrates some simple properties of the discrete cosine transform (DCT).
cosine_transform, a C++ code which demonstrates some simple properties of the discrete cosine transform (DCT).
cosine_transform, a Fortran90 code which demonstrates some simple properties of the discrete cosine transform (DCT).
cosine_transform, a MATLAB code which demonstrates some simple properties of the discrete cosine transform (DCT).
cosine_transform, an Octave code which demonstrates some simple properties of the discrete cosine transform (DCT).
cosine_transform, a Python code which demonstrates some simple properties of the discrete cosine transform (DCT).
counterfeit_detection, a MATLAB code which considers problems in which one or more counterfeit coins are to be identified by the fact that they do not have the standard weight.
counterfeit_detection, an Octave code which considers problems in which one or more counterfeit coins are to be identified by the fact that they do not have the standard weight.
counterfeit_detection, a Python code which considers problems in which one or more counterfeit coins are to be identified by the fact that they do not have the standard weight.
cplex, examples which call cplex(), which is an IBM optimization package which defines and solves 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 code which extracts solution data from a cplex() solution file; cplex() reads an LP problem definition file, which might have been created by polyomino_monohedral_matrix() or polyomino_multihedral_matrix(), and returns a solution file. This function opens the solution file and extracts the solution information in a standard vector format.
cplex_solution_read, an Octave code which extracts solution data from a cplex() solution file; cplex() reads an LP problem definition file, which might have been created by polyomino_monohedral_matrix() or polyomino_multihedral_matrix(), and returns a solution file. This function opens the solution file and extracts the solution information in a standard vector format.
cpp_arrays_test, a C++ code which uses vectors, matrices and tensors.
cpp_exact, a C++ code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
cpp_files_test, a C++ code which reads and writes external files.
cpp_intrinsics_test, a C++ code which illustrates the use of intrinsic functions.
cpp_monte_carlo, a C++ code which uses Monte Carlo sampling to estimate areas and integrals.
cpp_random_test, a C++ code which uses the random number generator (RNG) functions.
cpp_rule, a C++ code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as, a circle, a disk, an ellipse, a triangle, a quadrilateral, a polygon, a sphere, a ball, a hypercube, and which might include an associated weight function w(x).
cpp_simulation, a C++ code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
cpp_test, a C++ code which illustrates some features of the C++ language;
cpr, a MATLAB code which implements the Chebyshev Proxy Rootfinder (CPR) to locate all the real zeros of a smooth real function f(x) within an interval [a,b], by John Boyd.
cpr, an Octave code which implements the Chebyshev Proxy Rootfinder (CPR) to locate all the real zeros of a smooth real function f(x) within an interval [a,b], by John Boyd.
cpr, a Python code which implements the Chebyshev Proxy Rootfinder (CPR) to locate all the real zeros of a smooth real function f(x) within an interval [a,b], by John Boyd.
cr2crlf, a C++ code which reads a text file and replaces carriage returns by carriage returns + line feeds.
cr2lf, a C++ code which reads a text file and replaces carriage returns by line feeds.
craps_simulation, a MATLAB code which simulates the gambling game of craps, in which a player rolls two dice. On the first roll, the player wins immediately if a 7 or 11 is rolled, and loses immediately if a 2, 3 or 12 is rolled. Otherwise, the sum of the dice on this first roll is called the point. The player now continues to roll the dice, winning if the point is rolled again, and losing if a 7 is rolled.
craps_simulation, an Octave code which simulates the gambling game of craps, in which a player rolls two dice. On the first roll, the player wins immediately if a 7 or 11 is rolled, and loses immediately if a 2, 3 or 12 is rolled. Otherwise, the sum of the dice on this first roll is called the point. The player now continues to roll the dice, winning if the point is rolled again, and losing if a 7 is rolled.
craps_simulation, a Python code which simulates the gambling game of craps, in which a player rolls two dice. On the first roll, the player wins immediately if a 7 or 11 is rolled, and loses immediately if a 2, 3 or 12 is rolled. Otherwise, the sum of the dice on this first roll is called the point. The player now continues to roll the dice, winning if the point is rolled again, and losing if a 7 is rolled.
crc, a C++ code which computes the Cyclic Redundancy Checksum (CRC) as used by the Portable Network graphics (PNG) format.
crrm, a C++ code which reads a text file and removes the carriage return character.
crs, a dataset directory which contains examples of the Compressed Row Storage (CRS) sparse matrix file format;
crs_io, a MATLAB code which reads and writes sparse linear systems stored in the Compressed Row Storage (CRS) format.
crs_io, an Octave code which reads and writes sparse linear systems stored in the Compressed Row Storage (CRS) format.
crs_io, a Python code which reads and writes sparse linear systems stored in the Compressed Row Storage (CRS) format.
crystal_coordinates, a Fortran90 code which generates a file of 3-dimensional point coordinates defining the locations of molecules in a face-centered cubic (FCC) crystal.
csparse, a C code 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 code 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.
csv_test, a Python code which tests csv(), which reads and writes Comma Separated Value (CSV) data files.
ctangle, a C code which reads a CWEB file and creates the corresponding C source code file.
cubpack, a Fortran90 code 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 code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
cube_arbq_rule, a C++ code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
cube_arbq_rule, a Fortran77 code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
cube_arbq_rule, a Fortran90 code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
cube_arbq_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
cube_display, a MATLAB code which displays a cube plot, over integer triples of data, of a function defined by two formulas, using plotcube.m, by Thomas Montagnon.
cube_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit cube in 3D.
cube_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit cube in 3D.
cube_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit cube in 3D.
cube_exactness, a C code which computes the exactness of quadrature rules over the interior of a cube in 3D.
cube_exactness, a C++ code which computes the exactness of quadrature rules over the interior of a cube in 3D.
cube_exactness, a Fortran77 code which computes the exactness of quadrature rules over the interior of a cube in 3D.
cube_exactness, a Fortran90 code which computes the exactness of quadrature rules over the interior of a cube in 3D.
cube_exactness, a MATLAB code which computes the exactness of quadrature rules over the interior of a cube in 3D.
cube_exactness, an Octave code which computes the exactness of quadrature rules over the interior of a cube in 3D.
cube_exactness, a Python code which computes the exactness of quadrature rules over the interior of a cube in 3D.
cube_felippa_rule, a C code which returns a Felippa quadrature rule over the interior of a cube in 3D.
cube_felippa_rule, a C++ code which returns a Felippa quadrature rule over the interior of a cube in 3D.
cube_felippa_rule, a Fortran77 code which returns a Felippa quadrature rule over the interior of a cube in 3D.
cube_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule over the interior of a cube in 3D.
cube_felippa_rule, a MATLAB code which returns a Felippa quadrature rule over the interior of a cube in 3D.
cube_grid, a C code which computes a grid of points over the interior of a cube in 3D.
cube_grid, a C++ code which computes a grid of points over the interior of a cube in 3D.
cube_grid, a Fortran77 code which computes a grid of points over the interior of a cube in 3D.
cube_grid, a Fortran90 code which computes a grid of points over the interior of a cube in 3D.
cube_grid, a MATLAB code which computes a grid of points over the interior of a cube in 3D.
cube_grid, an Octave code which computes a grid of points over the interior of a cube in 3D.
cube_grid, a Python code which computes a grid of points over the interior of a cube in 3D.
cube_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
cube_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
cube_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
cube_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
cube_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
cube_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
cube_integrals, a Python code 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 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
cube_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
cube_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D;
cube_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D;
cube_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D;
cube_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D;
cube_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
cube_surface_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit cube.
cube_surface_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit cube.
cube_surface_distance, a Python code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit cube.
cubicspline, an R code which computes the cubic spline interpolant to data.
cuda, examples which use CUDA, which is an extension to the C language that enables parallel programming on a Graphics Processing Unit (GPU);
cuda_loop, a C code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
cuda_loop, a C++ code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
cuda_loop, a Fortran90 code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
cuda_loop, a MATLAB code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
cuda_loop, an Octave code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
cuda_loop, a Python code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
cvt, a dataset directory which contains examples of a Centroidal Voronoi Tessellation (CVT);
cvt, a C++ code which computes elements of a Centroidal Voronoi Tessellation (CVT).
cvt, a Fortran90 code which computes elements of a Centroidal Voronoi Tessellation (CVT).
cvt, a MATLAB code which computes elements of a Centroidal Voronoi Tessellation (CVT).
cvt, an Octave code which computes elements of a Centroidal Voronoi Tessellation (CVT).
cvt_1_movie, a MATLAB code which creates an animation of the evolution of a Centroidal Voronoi Tessellation (CVT) in the unit square.
cvt_2_movie, a MATLAB code which animates the generation of a Centroidal Voronoi Tessellation (CVT) in the unit square, which includes a random rebirth at every iteration.
cvt_3_movie, a MATLAB code which animates the generation of a Centroidal Voronoi Tessellation (CVT) for the holey pie region.
cvt_4_movie, a MATLAB code which creates a Centroidal Voronoi Tessellation (CVT) movie in the unit square, with a density function that drives points to the corners;
cvt_5_movie, a MATLAB code which repeats cvt_3_movie, but with hexagonal grid initialization, fixed points, and boundary projection;
cvt_5_movie_data, a Fortran90 code which creates and saves data of a Centroidal Voronoi Tessellation (CVT) iteration, for use in a movie;
cvt_1d_lloyd, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using the Lloyd iteration to compute the Voronoi regions exactly.
cvt_1d_lloyd, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using the Lloyd iteration to compute the Voronoi regions exactly.
cvt_1d_lloyd, a Python code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using the Lloyd iteration to compute the Voronoi regions exactly.
cvt_1d_lumping, a MATLAB code which allows the user to carry out a lumped version of the Lloyd iteration for a centroidal Voronoi Tessellation (CVT) in the interval [-1,+1], to compare a CVT and the Chebyshev Zero nodes.
cvt_1d_lumping, an Octave code which allows the user to carry out a lumped version of the Lloyd iteration for a centroidal Voronoi Tessellation (CVT) in the interval [-1,+1], to compare a CVT and the Chebyshev Zero nodes.
cvt_1d_nonuniform, a MATLAB code which computes an N-point Centroidal Voronoi Tessellation (CVT) in 1 dimension, under a nonuniform density, and plots the evolution of the locations of the generators during the iteration;
cvt_1d_nonuniform, an Octave code 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 code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using sampling to estimate the Voronoi regions.
cvt_1d_sampling, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the interval [0,1], under a uniform density, using sampling to estimate the Voronoi regions.
cvt_1d_sampling, a Python code 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 code 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_lumping, an Octave code 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 code 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, an Octave code 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 code 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 code 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_lumping, an Octave code 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 code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [0,1]^3, under a uniform density, using sampling to estimate the Voronoi regions.
cvt_3d_sampling, an Octave code which computes an N-point Centroidal Voronoi Tessellation (CVT) within the unit cube [0,1]^3, under a uniform density, using sampling to estimate the Voronoi regions.
cvt_basic, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) in a square with uniform density. It is intended as an introduction to the cvt_square_uniform() code.
cvt_basic, an Octave code which calculates a Centroidal Voronoi Tessellation (CVT) in a square with uniform density. It is intended as an introduction to the cvt_square_uniform() code.
cvt_basis, a Fortran90 code 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 code which extracts dominant solution modes from solutions of a flow problem governed by the Navier Stokes Equations (NSE) using Centroidal Voronoi Tessellation (CVT) methods.
cvt_box, a C++ code which calculates a Centroidal Voronoi Tessellation (CVT) constrained to a box region, with points projected to the boundary;
cvt_box, a Fortran90 code which calculates a Centroidal Voronoi Tessellation (CVT) constrained to a box region, with points projected to the boundary;
cvt_box, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) constrained to a box region, with points projected to the boundary;
cvt_circle_nonuniform, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) over a circle with nonuniform density.
cvt_circle_nonuniform, an Octave code which calculates a Centroidal Voronoi Tessellation (CVT) over a circle with nonuniform density.
cvt_circle_uniform, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) over a circle with uniform density.
cvt_circle_uniform, an Octave code which calculates a Centroidal Voronoi Tessellation (CVT) over a circle with uniform density.
cvt_corn, a MATLAB code 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_corn, an Octave code 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_corn_movie, a MATLAB code which makes a movie in which the growth of a corn kernel is simulated using a Centroidal Voronoi Tessellation (CVT).
cvt_dataset, a C++ code which computes a Centroidal Voronoi Tessellation (CVT) and writes it to a file.
cvt_dataset, a Fortran90 code which computes a Centroidal Voronoi Tessellation (CVT) and writes it to a file.
cvt_dataset, a MATLAB code which computes a Centroidal Voronoi Tessellation (CVT) and writes it to a file.
cvt_ellipse_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over an ellipse, with a uniform density.
cvt_ellipse_uniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over an ellipse, with a uniform density.
cvt_example_fifty_points, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) of the unit square, with 50 generator points.
cvt_example_five_points, a MATLAB code which calculates a Centroidal Voronoi Tessellation (CVT) of the unit square, with 5 generator points.
cvt_fixed, a Fortran90 code which computes a Centroidal Voronoi Tessellation (CVT), built on top of cvt_size(), that allows the user to fix the location of some generators;
cvt_fixed2, a Fortran90 code which implements a version of the Centroidal Voronoi Tessellation (CVT) algorithm that allows the user to fix some points;
cvt_metric, a MATLAB code which computes a Centroidal Voronoi Tessellation (CVT) under a spatially varying metric;
cvt_refine, a Fortran90 code which refines a Centroidal Voronoi Tessellation (CVT) by fixing the current points and adding new ones;
cvt_size, a Fortran90 code which controls Centroidal Voronoi Tessellation (CVT) cell sizes by specifying a weight function associated with each cell;
cvt_square_nonuniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a nonuniform density.
cvt_square_nonuniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a nonuniform density.
cvt_square_pdf_discrete, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a density derived from a discrete PDF.
cvt_square_pdf_discrete, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a density derived from a discrete PDF.
cvt_square_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a uniform density.
cvt_square_uniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a square, with a uniform density.
cvt_tet_mesh, a Fortran90 code which constructs a Centroidal Voronoi Tessellation (CVT) for a region specified by the test_tet_mesh();
cvt_triangle_uniform, a MATLAB code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a triangle, with a uniform density.
cvt_triangle_uniform, an Octave code which iteratively calculates a Centroidal Voronoi Tessellation (CVT) over a triangle, with a uniform density.
cvt_triangulation, a Fortran90 code which constructs a Centroidal Voronoi Tessellation (CVT) triangulation for certain regions from the test_triangulation() set of examples.
cvt_weight, a Fortran90 code which tried to control Centroidal Voronoi Tessellation (CVT) cell sizes by specifying a weight function associated with each cell;
cvtm_1d, a MATLAB code which estimates a mirror-periodic centroidal Voronoi Tessellation (CVTM) in the periodic interval [0,1], using a version of the Lloyd iteration.
cvtm_1d, an Octave code which estimates a mirror-periodic centroidal Voronoi Tessellation (CVTM) in the periodic interval [0,1], using a version of the Lloyd iteration.
cvtp, a dataset directory which contains examples of a CVTP, that is, a Centroidal Voronoi Tessellation (CVT) on a periodic domain.
cvtp, a Fortran90 code which creates a periodic Centroidal Voronoi Tessellation (CVTP).
cvtp, a MATLAB code which creates a periodic Centroidal Voronoi Tessellation (CVTP).
cvtp, an Octave code which creates a periodic Centroidal Voronoi Tessellation (CVTP).
cvtp_1d, a MATLAB code which estimates a periodic Centroidal Voronoi Tessellation (CVT) in the periodic interval [0,1], using a version of the Lloyd iteration.
cvtp_1d, an Octave code which estimates a periodic Centroidal Voronoi Tessellation (CVT) in the periodic interval [0,1], using a version of the Lloyd iteration.
cvxopt_svm, a Python code which solves a support vector machine (SVM) problem by formulating it as a quadratic programming problem to be solved by cvxopt().
cweave, a C code which reads a CWEB file and creates the corresponding TeX documentation file.
cwg_ode, a Fortran77 code which contains three solvers for a system of ordinary differential equations (ODE), by William Gear.
cycle_brent, a C code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
cycle_brent, a C++ code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
cycle_brent, a Fortran77 code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
cycle_brent, a Fortran90 code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
cycle_brent, a MATLAB code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
cycle_brent, an Octave code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
cycle_brent, a Python code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Brent method.
cycle_floyd, a C code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
cycle_floyd, a C++ code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
cycle_floyd, a Fortran77 code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
cycle_floyd, a Fortran90 code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
cycle_floyd, a MATLAB code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
cycle_floyd, an Octave code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
cycle_floyd, a Python code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle length, using the Floyd method.
cyclic_reduction, a C code which solves a tridiagonal linear system using cyclic reduction.
cyclic_reduction, a C++ code which solves a tridiagonal linear system using cyclic reduction.
cyclic_reduction, a Fortran77 code which solves a tridiagonal linear system using cyclic reduction.
cyclic_reduction, a Fortran90 code which solves a tridiagonal linear system using cyclic reduction.
cyclic_reduction, a MATLAB code which solves a tridiagonal linear system using cyclic reduction.
cyclic_reduction, an Octave code 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 code which uses the direct boundary element method (BEM) to analyze a problem in 2D elastic stress, by Prasanta Banerjee, Roy Butterfield.
deallii, examples which use DEAL.II, which is a finite element method (FEM) Differential Equations Analysis Library (DEAL), for the definition and solution of partial differential equations (PDE), by Wolfgang Bangerth and others.
dealii_osx, examples which use DEAL.II, which is a finite element method (FEM) Differential Equations Analysis Library (DEAL), for the definition and solution of partial differential equations (PDE), on a Macintosh running the OSX operating system, 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), by Wolfgang Bangerth and others, on the FSU Research Computing Center (RCC) cluster.
deblank, a C++ code which reads a text file and writes a copy that has no blank lines.
decomment, a C++ code which makes a copy of a text file that omits all comment lines, that begin with "#".
delaunay_lmap_2d, a Fortran90 code which computes the Delaunay triangulation of points in the plane subject to a linear mapping.
delaunay_test, a MATLAB code which calls the built-in function delaunay(), which computes the Delaunay triangulation of a set of points.
delaunay_test, an Octave code which calls the built-in function delaunay(), which computes the Delaunay triangulation of a set of points.
delaunay_test, a Python code 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++ code which computes the Delaunay triangulation of a 2D dataset, by Olivier Devillers.
delsq, a MATLAB code which is given a grid G, and returns a corresponding sparse matrix D that defines the Laplacian operator on G. MATLAB includes a built-in version of this function.
delsq, an Octave code which is given a grid G, and returns a corresponding sparse matrix D that defines the Laplacian operator on G.
delsq, a Python code which is given a grid G, and returns a corresponding sparse matrix D that defines the Laplacian operator on G.
detroff, a C++ code which removes from a file every occurrence of the TROFF overprint pair character+backspace, that makes a MAN page printable;
dfield9, a MATLAB code which allows a user to interactively specify the right hand side of an ordinary differential equation (ODE). The program then displays the corresponding direction field. If the user clicks on any point in the image as an initial condition, the program displays the corresponding solution curve. The original version of this code was by John Polking.
dfield9, an Octave code which allows a user to interactively specify the right hand side of an ordinary differential equation (ODE). The program then displays the corresponding direction field. If the user clicks on any point in the image as an initial condition, the program displays the corresponding solution curve. The original version of this code was by John Polking.
dg1d_advection, a MATLAB code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the advection Equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
dg1d_advection, an Octave code 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 code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D Burgers Equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
dg1d_burgers, an Octave code 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 code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the unsteady 1D heat Equation. The original version of the code was written by Jan Hesthaven and Tim Warburton.
dg1d_heat, an Octave code 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 code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the Maxwell equations. The original version of the code was written by Jan Hesthaven and Tim Warburton.
dg1d_maxwell, an Octave code which uses the Discontinuous Galerkin Method (DG) to approximate a solution of the Maxwell equations. The original version of the code was written by Jan Hesthaven and Tim Warburton.
dg1d_poisson, a MATLAB code which applies the discontinuous Galerkin method (DG) to a 1D version of the Poisson equation, by Beatrice Riviere.
dg1d_poisson, an Octave code which applies the discontinuous Galerkin method (DG) to a 1D version of the Poisson equation, by Beatrice Riviere.
dg1d_poisson, a Python code which applies the discontinuous Galerkin method (DG) to a 1D version of the Poisson equation, by Beatrice Riviere, modified by Alex Lindsay.
diaphony, a C code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
diaphony, a C++ code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
diaphony, a Fortran77 code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
diaphony, a Fortran90 code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
diaphony, a MATLAB code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
diaphony, an Octave code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
dice_simulation, a MATLAB code which simulates N tosses of M dice, making a histogram of the resulting sums.
dice_simulation, an Octave code which simulates N tosses of M dice, making a histogram of the resulting sums.
dice_simulation, a Python code which simulates N tosses of M dice, making a histogram of the resulting sums.
dictionary_code, a MATLAB code which compresses or decompresses a text file using a dictionary code.
dictionary_code, an Octave code which compresses or decompresses a text file using a dictionary code.
diff_test, a MATLAB code which calls diff(), which computes differences in a vector of data, which can be scaled to estimate derivatives of equally spaced data.
diff_center, a MATLAB code which interactively uses centered differences to estimate the derivative of a function f(x), using a stepsize h.
diff_center, an Octave code which interactively uses centered differences to estimate the derivative of a function f(x), using a stepsize h.
diff_forward, a MATLAB code which interactively uses forward differences to estimate the derivative of a function f(x), using a stepsize h.
diff_forward, an Octave code which interactively uses forward differences to estimate the derivative of a function f(x), using a stepsize h.
diff2_center, a MATLAB code which interactively uses centered differences to estimate the second derivative of a function f(x), using a stepsize h.
diff2_center, an Octave code which interactively uses centered differences to estimate the second derivative of a function f(x), using a stepsize h.
differ, a C code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
differ, a C++ code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
differ, a Fortran77 code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
differ, a Fortran90 code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
differ, a MATLAB code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
differ, an Octave code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
differ, a Python code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
diffusion_pde, a MATLAB code which solves the diffusion partial differential equation (PDE) dudt - mu * d2udx2 = 0 in one spatial dimension and time, with a constant diffusion coefficient mu, and periodic boundary conditions, using the forward time centered space (FTCS) difference method.
diffusion_pde, an Octave code which solves the diffusion partial differential equation (PDE) dudt - mu * d2udx2 = 0 in one spatial dimension and time, with a constant diffusion coefficient mu, and periodic boundary conditions, using the forward time centered space (FTCS) difference method.
diffusion_pde, a Python code which solves the diffusion partial differential equation (PDE) dudt - mu * d2udx2 = 0 in one spatial dimension and time, with a constant diffusion coefficient mu, and periodic boundary conditions, using the forward time centered space (FTCS) difference method.
digital_dice, a MATLAB code which carries out the probability simulations described in "Digital Dice", by Paul Nahin;
digital_dice, an Octave code which carries out the probability simulations described in "Digital Dice", by Paul Nahin;
digital_dice, a Python code which carries out the probability simulations described in "Digital Dice", by Paul Nahin;
digits_visualize_pca, a scikit-learn code which uses principal component analysis (PCA) of the digits dataset to visualize the grouping of data.
digits_visualize_tsne, a scikit-learn code which uses t-distributed stochastic neighbor embedding (tsne) of the digits dataset to visualize the grouping of data.
digraph_adj, a Fortran90 code which carries out operations on digraphs, a directed graph. Information is stored in an adjacency matrix. Operations include computing in- and out-degrees, computing the in- and out-degree sequences, counting the edges, printing the adjacency matrix, generating fixed and random examples.
digraph_adj, a Python code which carries out operations on digraphs, a directed graph. Information is stored in an adjacency matrix.
digraph_arc, a Fortran90 code which carries out operations on digraphs, a directed graph. Information is stored in an arc list, pairs of nodes forming edges. Operations include computing in- and out-degrees, computing the in- and out-degree sequences, counting the edges, printing the arc list, generating fixed and random examples.
digraph_dict, a Python code which carries out operations on abstract digraphs, with directed edges, represented by a Python dictionary. The dictionary has a key for each node; the values list the nodes which are immediately reachable from the key node.
dijkstra, a C code which implements the Dijkstra algorithm for finding the minimum distance from a given node of a weighted graph to all the other nodes.
dijkstra, a C++ code which implements the Dijkstra algorithm for finding the minimum distance from a given node of a weighted graph to all the other nodes.
dijkstra, a Fortran77 code which implements the Dijkstra algorithm for finding the minimum distance from a given node of a weighted graph to all the other nodes.
dijkstra, a Fortran90 code which implements the Dijkstra algorithm for finding the minimum distance from a given node of a weighted graph to all the other nodes.
dijkstra, a MATLAB code which implements the Dijkstra algorithm for finding the minimum distance from a given node of a weighted graph to all the other nodes.
dijkstra, an Octave code which implements the Dijkstra algorithm for finding the minimum distance from a given node of a weighted graph to all the other nodes.
dijkstra, a Python code which implements the Dijkstra algorithm for finding the minimum distance from a given node of a weighted graph to all the other nodes.
dijkstra_openmp, a C code which uses OpenMP to parallelize a simple example of the Dijkstra minimum distance algorithm for graphs.
dijkstra_openmp, a C++ code which uses OpenMP to parallelize a simple example of the Dijkstra minimum distance algorithm for graphs.
dijkstra_openmp, a Fortran77 code which uses OpenMP to parallelize a simple example of the Dijkstra minimum distance algorithm for graphs.
dijkstra_openmp, a Fortran90 code which uses OpenMP to parallelize a simple example of the Dijkstra minimum distance algorithm for graphs.
dijkstra_spmd, a MATLAB code which uses the Single Program Multiple Data (SPMD) feature to parallelize a simple example of the Dijkstra minimum distance algorithm for graphs.
diophantine, a MATLAB code which finds one solution of a Diophantine equation in any number of variables.
diophantine, an Octave code which finds one solution of a Diophantine equation in any number of variables.
diophantine, a Python code which finds one solution of a Diophantine equation in any number of variables.
diophantine_2d, a MATLAB code which is given a Diophantine equation in 2 variables, and characterizes all solutions, all strictly positive solutions, or all nonnegative solutions.
diophantine_3d, a MATLAB code which is given a Diophantine equation in 3 variables, and returns all strictly positive solutions, or all nonnegative solutions.
diophantine_4d, a MATLAB code which is given a Diophantine equation in 4 variables, and returns all strictly positive solutions, or all nonnegative solutions.
diophantine_5d, a MATLAB code which is given a Diophantine equation in 5 variables, and returns all strictly positive solutions, or all nonnegative solutions.
diophantine_nd, a MATLAB code which is given a Diophantine equation in N variables, and returns all strictly positive solutions, or all nonnegative solutions.
diophantine_nd, an Octave code which is given a Diophantine equation in N variables, and returns all strictly positive solutions, or all nonnegative solutions.
diophantine_nd, a Python code which is given a Diophantine equation in N variables, and returns all strictly positive solutions, or all nonnegative solutions.
discmethod, an R code which estimates the volume inside a surface of revolution using the disc method.
discrete_pdf_sample_2d, a C code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
discrete_pdf_sample_2d, a C++ code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
discrete_pdf_sample_2d, a Fortran90 code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
discrete_pdf_sample_2d, a Fortran77 code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
discrete_pdf_sample_2d, a MATLAB code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
discrete_pdf_sample_2d, an Octave code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
disk_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit disk in 2D.
disk_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit disk in 2D.
disk_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit disk in 2D.
disk_grid, a C code which computes grid points over the interior of the general disk in 2D;
disk_grid, a C++ code which computes grid points over the interior of the general disk in 2D;
disk_grid, a Fortran77 code which computes grid points over the interior of the general disk in 2D;
disk_grid, a Fortran90 code which computes grid points over the interior of the general disk in 2D;
disk_grid, a MATLAB code which computes grid points over the interior of the general disk in 2D;
disk_grid, an Octave code which computes grid points over the interior of the general disk in 2D;
disk_grid, a Python code which computes grid points over the interior of the general disk in 2D;
disk_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of a disk of radius R centered at the origin.
disk_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of a disk of radius R centered at the origin.
disk_integrals, a Python code which returns the exact value of the integral of any monomial over the interior of a disk of radius R centered at the origin.
disk_integrands, a Python code which defines several test integrals over the unit disk, making it possible to check the accuracy of quadrature rules.
disk_monte_carlo, a C code which applies a Monte Carlo method to estimate the integral of a function over the interior of a disk of radius R centered at the origin.
disk_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of a disk of radius R centered at the origin.
disk_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of a disk of radius R centered at the origin.
disk_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of a disk of radius R centered at the origin.
disk_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of a disk of radius R centered at the origin.
disk_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of a disk of radius R centered at the origin.
disk_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit positive disk in 2D.
disk_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit positive disk in 2D.
disk_positive_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit positive disk in 2D.
disk_rule, a C code which computes a quadrature rule over the interior of a disk of radius R centered at the origin.
disk_rule, a C++ code which computes quadrature rules over the interior of a disk of radius R centered at the origin.
disk_rule, a Fortran77 code which computes quadrature rules over the interior of a disk of radius R centered at the origin.
disk_rule, a Fortran90 code which computes quadrature rules over the interior of a disk of radius R centered at the origin.
disk_rule, a MATLAB code which computes quadrature rules over the interior of a disk of radius R centered at the origin.
disk_rule, a Python code which computes quadrature rules over the interior of a disk of radius R centered at the origin.
disk_triangle_picking, a Python code which estimates the expected value of the area of a triangle formed by three randomly selected points in the unit disk.
disk01_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit disk centered at the origin.
disk01_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of the unit disk centered at the origin.
disk01_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit disk centered at the origin.
disk01_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit disk centered at the origin.
disk01_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit disk centered at the origin.
disk01_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit disk centered at the origin.
disk01_integrals, a Python code which returns the exact value of the integral of any monomial over the interior of the unit disk centered at the origin.
disk01_integrands, a MATLAB code which defines several test integrals over the unit disk, making it possible to check the accuracy of quadrature rules.
disk01_integrands, a Python code which defines several test integrals over the unit disk, making it possible to check the accuracy of quadrature rules.
disk01_monte_carlo, a C code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk centered at the origin;
disk01_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk centered at the origin;
disk01_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk centered at the origin;
disk01_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk centered at the origin;
disk01_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk centered at the origin;
disk01_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk centered at the origin;
disk01_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit disk centered at the origin;
disk01_positive_monte_carlo, a C code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
disk01_positive_monte_carlo_test
disk01_positive_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
disk01_positive_monte_carlo_test
disk01_positive_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
disk01_positive_monte_carlo_test
disk01_positive_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
disk01_positive_monte_carlo_test
disk01_positive_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
disk01_positive_monte_carlo_test
disk01_positive_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
disk01_positive_rule, a MATLAB code which computes a quadrature rule over the interior of the unit positive disk in 2D, with radius 1 and center (0,0).
disk01_positive_rule, an Octave code which computes a quadrature rule over the interior of the unit positive disk in 2D, with radius 1 and center (0,0).
disk01_rule, a C code which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).
disk01_rule, a C++ code which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).
disk01_rule, a Fortran77 code which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).
disk01_rule, a Fortran90 code which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).
disk01_rule, a MATLAB code which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).
disk01_rule, a Python code which computes quadrature rules over the interior of the unit disk in 2D, with radius 1 and center (0,0).
dislin_test, a C code which uses dislin(), which is a scientific graphics package, by Helmut Michels.
dislin_test, a C++ code which uses dislin(), which is a scientific graphics package, by Helmut Michels.
dislin_test, a Fortran77 code which uses dislin(), which is a scientific graphics package, by Helmut Michels.
dislin_test, a Fortran90 code which uses dislin(), which is a scientific graphics package, by Helmut Michels.
dislin_osx_test, a C code which uses dislin(), which is a scientific graphics package, on a system that is running OSX, by Helmut Michels.
dislin_osx_test, a C++ code which uses dislin(), which is a scientific graphics package, on a system that is running OSX, by Helmut Michels.
dist_plot, a MATLAB code which makes contour plots of the distance function, as defined and used in the distmesh() code of Persson and Strang;
dist_plot, an Octave code which makes contour plots of the distance function, as defined and used in the distmesh() code of Persson and Strang;
distance_to_position, a Fortran90 code which estimates the positions of cities based on a city-to-city distance table.
distance_to_position, a MATLAB code which estimates the positions of cities based on a city-to-city distance table.
distance_to_position_sphere, a MATLAB code which estimates the positions of cities on a sphere (such as the earth) based on a city-to-city distance table.
distance_to_position_sphere_test
distmesh, a MATLAB code which carries out triangular or tetrahedral mesh generation, by Per-Olof Persson and Gilbert Strang.
distmesh_3d, a MATLAB code which constitutes the 3D subset of distmesh() for tetrahedral mesh generation, by Per-Olof Persson and Gilbert Strang.
distmesh_3d, an Octave code which constitutes the 3D subset of distmesh() for tetrahedral mesh generation, by Per-Olof Persson and Gilbert Strang.
divdif, a C code which uses divided differences to compute the polynomial interpolant to a given set of data.
divdif, a C++ code which uses divided differences to compute the polynomial interpolant to a given set of data.
divdif, a Fortran77 code which uses divided differences to compute the polynomial interpolant to a given set of data.
divdif, a Fortran90 code which uses divided differences to compute the polynomial interpolant to a given set of data.
divdif, a MATLAB code which uses divided differences to compute the polynomial interpolant to a given set of data.
divdif, an Octave code which uses divided differences to compute the polynomial interpolant to a given set of data.
dogs_vs_cats_data, a keras code which sets up test, train, and valid directories with data for the dogs versus cats example.
dogs_vs_cats1, a keras code which sets up a convolutional neural network to classify jpeg images as being of dogs or of cats.
dolfin-convert, a Python code which converts a mesh file from gmsh(), medit(), metis() or scotch() format to an XML mesh file suitable for use by dolfin() or fenics(), by Anders Logg.
dolfin_test, a Python code which uses dolfin() 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 code which creates a region starting with a circle, and then subtracting a rectangle and smaller circle.
doomsday, a C code which is given the year, month and day of a date, and uses the doomsday algorithm of John Conway to determine the corresponding day of the week.
doomsday, a C++ code which is given the year, month and day of a date, and uses the doomsday algorithm of John Conway to determine the corresponding day of the week.
doomsday, a Fortran77 code which is given the year, month and day of a date, and uses the doomsday algorithm of John Conway to determine the corresponding day of the week.
doomsday, a Fortran90 code which is given the year, month and day of a date, and uses the doomsday algorithm of John Conway to determine the corresponding day of the week.
doomsday, a MATLAB code which is given the year, month and day of a date, and uses the doomsday algorithm of John Conway to determine the corresponding day of the week.
doomsday, an Octave code which is given the year, month and day of a date, and uses the doomsday algorithm of John Conway to determine the corresponding day of the week.
doomsday, a Python code which is given the year, month and day of a date, and uses the doomsday algorithm of John Conway to determine the corresponding day of the week.
dosage_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) to simulate the blood levels of a medicinal drug that should stay between medicinal and toxic limits.
dosage_ode, an Octave code which sets up a system of ordinary differential equations (ODE) to simulate the blood levels of a medicinal drug that should stay between medicinal and toxic limits.
dosage_ode, a Python code which sets up a system of ordinary differential equations (ODE) to simulate the blood levels of a medicinal drug that should stay between medicinal and toxic limits.
dot_l2, a MATLAB code which estimates the L2 dot product of two functions over an interval [A,B], with the functions entered as a string.
dot_l2, an Octave code which estimates the L2 dot product of two functions over an interval [A,B], with the functions entered as a string.
double_c_data, a MATLAB code which generates, plots or writes 2D data that forms two interlocking C shapes.
double_well_ode, a MATLAB code which sets up an ordinary differential equation (ODE) which models the motion of a particle in a double well potential.
double_well_ode, an Octave code which sets up an ordinary differential equation (ODE) which models the motion of a particle in a double well potential.
double_well_ode, a Python code which sets up an ordinary differential equation (ODE) which models the motion of a particle in a double well potential.
dpg_bvp, a FENICS code which uses the Discontinuous Petrov Galerkin (DPG) method to solve a boundary value problem (BVP) over an interval, by Jay Gopalakrishnan.
dpg_laplace, a FENICS code 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 code 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 code which solves constrained least squares problems, including a reverse communication (RC) option, by Richard Hanson and Fred Krogh.
dqed, a Fortran90 code 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 code 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++ code 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 code 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 code 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.
driv, a FORTRAN77 code which includes solvers for systems of real or complex ordinary differential equations (ODE), by Kahaner and Sutherland.
driven_cavity_navier_stokes, a FreeFem++ code which solves the Navier-Stokes equations (NSE) for the driven cavity problem.
driven_cavity_navier_stokes_pod, a FreeFem++ code which applies Proper Orthogonal Decomposition (POD) to flow in the driven cavity, governed by the Navier-Stokes equations (NSE).
driven_cavity_stokes, a FreeFem++ code which solves the Stokes equations for the driven cavity problem.
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 code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
duel_simulation, a C++ code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
duel_simulation, a Fortran77 code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
duel_simulation, a Fortran90 code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
duel_simulation, a Mathematica code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
duel_simulation, a MATLAB code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
duel_simulation, an Octave code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
duel_simulation, a Python code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
dueling_idiots, a MATLAB code which carries out the probability simulations described in "Dueling Idiots", by Paul Nahin;
dueling_idiots, an Octave code which carries out the probability simulations described in "Dueling Idiots", by Paul Nahin;
dueling_idiots, a Python code which carries out the probability simulations described in "Dueling Idiots", by Paul Nahin;
duffing_ode, a MATLAB code which sets up a second-order ordinary differential equation (ODE) whose solution exhibits chaotic behavior.
duffing_ode, an Octave code which sets up a second-order ordinary differential equation (ODE) whose solution exhibits chaotic behavior.
duffing_ode, a Python code which sets up a second-order ordinary differential equation (ODE) whose solution exhibits chaotic behavior.
dutch, a Fortran90 code which carries out tasks in computational geometry.
e_spigot, a MATLAB code which produces N digits of the decimal expansion of e.
e_spigot, an Octave code which produces N digits of the decimal expansion of e.
e_spigot, a Python code which produces N digits of the decimal expansion of e.
earth_sphere, a MATLAB code which displays a 3D image of the earth, including oceans, continents, and topography, by Clay Thompson and Will Campbell.
edge, a C code 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++ code 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 code 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 code 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 code which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities.
edge, an Octave code 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.
eigen, examples which use EIGEN, which is 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.
eigenfaces, a MATLAB code which applies principal component analysis (PCA) to a collection of images.
eigenfaces, an Octave code which applies principal component analysis (PCA) to a collection of images.
eigs, a C code which computes the eigenvalues and eigenvectors of a matrix.
eigs, a C++ code which computes the eigenvalues and eigenvectors of a matrix.
eigs, a Fortran77 code which computes the eigenvalues and eigenvectors of a matrix.
eigs, a Fortran90 code which computes the eigenvalues and eigenvectors of a matrix.
eigs_test a MATLAB code which calls eigs(), which is a built-in system function which computes the eigenvalues and eigenvectors of a matrix.
eigs_test an Octave code which calls eigs(), which is a built-in system function which computes the eigenvalues and eigenvectors of a matrix.
eigs_test a Python code which calls np.linalg.eig(), which is a built-in system function which computes the eigenvalues and eigenvectors of a matrix.
eispack, a C code 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++ code 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 code 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 code which carries out eigenvalue computations. It includes a function to compute the singular value decomposition (SVD) of a rectangular matrix. superseded by lapack();
elastic_bar, a FreeFem++ code which models the deformation of an elastic bar under stress.
element_data, a Fortran77 code which preprocesses simple element-based data on a grid into a form that the display4() code can handle.
elements, a Python code which stores the atomic number, atomic weight, element name and element symbol for the chemical elements.
elfun, a MATLAB code which evaluates elliptic integrals, include Bulirsch's integrals cel(), cel1(), cel2(), cel3(), Carlson integrals rc(), rd(), rf(), rg(), rj(), and Jacobi functions cn(), dn(), sn(), by Milan Batista.
elfun, an Octave code which evaluates elliptic integrals, include Bulirsch's integrals cel(), cel1(), cel2(), cel3(), Carlson integrals rc(), rd(), rf(), rg(), rj(), and Jacobi functions cn(), dn(), sn(), by Milan Batista.
ell, a FENICS code which solves the Poisson equation on the L-shaped region.
ellipse, a C code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
ellipse, a C++ code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
ellipse, a Fortran90 code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
ellipse, a MATLAB code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
ellipse, an Octave code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
ellipse, a Python code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
ellipse_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the ellipse (x/a)^2+(y/b)^2=1 in 2D.
ellipse_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the ellipse (x/a)^2+(y/b)^2=1 in 2D.
ellipse_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected on the circumference of the ellipse (x/a)^2+(y/b)^2=1 in 2D.
ellipse_grid, a C code which computes a grid of points over the interior of an ellipse in 2D.
ellipse_grid, a C++ code which computes a grid of points over the interior of an ellipse in 2D.
ellipse_grid, a Fortran77 code which computes a grid of points over the interior of an ellipse in 2D.
ellipse_grid, a Fortran90 code which computes a grid of points over the interior of an ellipse in 2D.
ellipse_grid, a MATLAB code which computes a grid of points over the interior of an ellipse in 2D.
ellipse_grid, an Octave code which computes a grid of points over the interior of an ellipse in 2D.
ellipse_grid, a Python code which computes a grid of points over the interior of an ellipse in 2D.
ellipse_monte_carlo, a C code 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++ code 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 code 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 code 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 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.
ellipse_monte_carlo, an Octave code 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 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.
ellipsoid, a C code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
ellipsoid, a C++ code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
ellipsoid, a Fortran90 code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
ellipsoid, a MATLAB code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
ellipsoid, an Octave code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
ellipsoid, a Python code which carries out geometric calculations for ellipsoids, including area, random sampling, and volume.
ellipsoid_grid, a C code which computes a grid of points over the interior of an ellipsoid in 3D.
ellipsoid_grid, a C++ code which computes a grid of points over the interior of an ellipsoid in 3D.
ellipsoid_grid, a Fortran77 code which computes a grid of points over the interior of an ellipsoid in 3D.
ellipsoid_grid, a Fortran90 code which computes a grid of points over the interior of an ellipsoid in 3D.
ellipsoid_grid, a MATLAB code which computes a grid of points over the interior of an ellipsoid in 3D.
ellipsoid_grid, an Octave code which computes a grid of points over the interior of an ellipsoid in 3D.
ellipsoid_grid, a Python code which computes a grid of points over the interior of an ellipsoid in 3D.
ellipsoid_monte_carlo, a C code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
ellipsoid_monte_carlo, a C++ code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
ellipsoid_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
ellipsoid_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
ellipsoid_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
ellipsoid_monte_carlo, an Octave code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
ellipsoid_monte_carlo, a Python code 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 code which evaluates complete elliptic integrals of first, second and third kind, including the Jacobi elliptic functions sn(), cn(), and dn(), using the Carlson elliptic integral functions.
elliptic_integral, a C++ code which evaluates complete elliptic integrals of first, second and third kind, including the Jacobi elliptic functions sn(), cn(), and dn(), using the Carlson elliptic integral functions.
elliptic_integral, a Fortran77 code which evaluates complete elliptic integrals of first, second and third kind, including the Jacobi elliptic functions sn(), cn(), and dn(), using the Carlson elliptic integral functions.
elliptic_integral, a Fortran90 code which evaluates complete elliptic integrals of first, second and third kind, including the Jacobi elliptic functions sn(), cn(), and dn(), using the Carlson elliptic integral functions.
elliptic_integral, a MATLAB code which evaluates complete elliptic integrals of first, second and third kind, including the Jacobi elliptic functions sn(), cn(), and dn(), using the Carlson elliptic integral functions.
elliptic_integral, an Octave code which evaluates complete elliptic integrals of first, second and third kind, including the Jacobi elliptic functions sn(), cn(), and dn(), using the Carlson elliptic integral functions.
elliptic_integral, a Python code which evaluates complete elliptic integrals of first, second and third kind, including the Jacobi elliptic functions sn(), cn(), and dn(), using the Carlson elliptic integral functions.
entrust, a MATLAB code which minimizes a scalar function of several variables using trust-region methods, by Jeff Borggaard and Gene Cliff.
ep_serial, a Fortran77 code which a serial version of the nas Embarassingly Parallel (EP) Parallel Benchmark.
ep_serial, a Fortran90 code which a serial version of the nas Embarassingly Parallel (EP) Parallel Benchmark.
epicycloid, a MATLAB code which plots an epicycloid curve.
epicycloid, an Octave code which plots an epicycloid curve.
epicycloid, a Python code which plots an epicycloid curve.
eps, a data directory which contains examples of Encapsulated PostScript (EPS) files for 2D vector graphics;
eps_to_jpg, examples which automates the conversion of Encapsulated PostScript (EPS) files to JPEG format.
eps_to_png, examples which automate the conversion of Encapsulated PostScript (EPS) files to Portable Network graphics (PNG) format.
equidistribution, a MATLAB code which computes equidistribution properties relating to density functions and point sets.
eros, a MATLAB code which implements elementary row operations (ERO) for the interactive solution of a linear system of equations.
eros, an Octave code which implements elementary row operations (ERO) for the interactive solution of a linear system of equations.
eros, a Python code which implements elementary row operations (ERO) for the interactive solution of a system of linear equations.
eros, an R code which implements the Elementary Row Operations (ERO) used to define many matrix algorithms.
error_norms, a FreeFem++ code which computes L2 and H1 error norms of an approximation computed by the finite element method (FEM), and also shows how to project the exact solution onto the finite element space and plot it.
errors, a Fortran90 code which illustrates the failure of numerical algorithms;
errors, a MATLAB code which illustrates the failure of numerical algorithms;
errors, an Octave code which illustrates the failure of numerical algorithms;
etdrk4, a FORTRAN90 code which uses the exponential time differencing (ETD) RK4 method to solve systems of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
eternity, a MATLAB code which considers the eternity puzzle, which considers an irregular dodecagon shape that is to be tiled by 209 distinct pieces, each formed by 36 contiguous 30-60-90 triangles, known as polydrafters.
eternity, an Octave code which considers the eternity puzzle, which considers an irregular dodecagon shape that is to be tiled by 209 distinct pieces, each formed by 36 contiguous 30-60-90 triangles, known as polydrafters.
eternity_hexity, a MATLAB code which evaluates and manipulates a six-fold parity quantity associated with grids and tiles used in the Eternity puzzle.
eternity_hexity, an Octave code which evaluates and manipulates a six-fold parity quantity associated with grids and tiles used in the Eternity puzzle.
eternity_tile, a MATLAB code which considers the individual tiles of the eternity puzzle, 209 distinct pieces, each formed by 36 contiguous 30-60-90 triangles, known as polydrafters, as well as tiles for the serenity and trinity puzzles, and the hat and turtle aperiodic monotiles.
eternity_tile, an Octave code which considers the individual tiles of the eternity puzzle, 209 distinct pieces, each formed by 36 contiguous 30-60-90 triangles, known as polydrafters, as well as tiles for the serenity and trinity puzzles, and the hat and turtle aperiodic monotiles.
euclid, a MATLAB code which investigates various versions of Euclid's algorithm for computing the greatest common divisor (GCD) of two integers.
euclid, an Octave code which investigates various versions of Euclid's algorithm for computing the greatest common divisor (GCD) of two integers.
euclid, a Python code which investigates various versions of Euclid's algorithm for computing the greatest common divisor (GCD) of two integers.
euler, a C code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, a C++ code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, a FreeFem++ code which uses the forward Euler method to solve a time-dependent boundary value problem (BVP).
euler, a Julia code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, a MATLAB code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, an Octave code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, a Python code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
euler, an R code which uses the forward Euler method to solve a single ordinary differential equation (ODE).
eulersys, an R code which uses the Euler method to solve a system of ordinary differential equations (ODE).
exactness, a C code which computes 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++ code which computes 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 code which computes 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 code which computes 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 code which computes 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, an Octave code which computes 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 code which computes 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).
exec_test, a FreeFem++ code which uses the exec() statement to issue a system command, in this case, a call to gnuplot().
exit_test, a FreeFem++ code which uses the exit() statement to terminate a script early.
exm, a MATLAB code which contains scripts and data discussed in the electronic textbook "Experiments with Matlab", by Cleve Moler, including easter, Fast Fourier Transforms, Fibonacci numbers, the fractal fern, the game of Life, magic matrices, the Mandelbrot set, Morse code, Music, Ordinary Differential Equations, the page rank algorithm, planetary orbits, predator prey equations, the shallow water equations, Sudoku puzzles.
exm, an Octave code which contains scripts and data discussed in the electronic textbook "Experiments with Matlab", by Cleve Moler, including easter, Fast Fourier Transforms, Fibonacci numbers, the fractal fern, the game of Life, magic matrices, the Mandelbrot set, Morse code, Music, Ordinary Differential Equations, the page rank algorithm, planetary orbits, predator prey equations, the shallow water equations, Sudoku puzzles.
exp_ode, a MATLAB code which sets up an ordinary differential equation (ODE) whose solution is an exponential function.
exp_ode, an Octave code which sets up an ordinary differential equation (ODE) whose solution is an exponential function.
exp_ode, a Python code which sets up an ordinary differential equation (ODE) whose solution is an exponential function.
expokit, a Fortran77 code which solves various forms of the matrix exponential problem, by Roger Sidje.
expression_test, a FENICS code which demonstrates some properties of the objects created by the FENICS() Expression() function.
extract, a Fortran90 code which pulls a copy of a Fortran block data, function, module, program or subroutine from a big file, and saves the copy in a little file.
f77, a Fortran77 code which illustrates features of Fortran77;
f77_calls_c, a Fortran77 code which calls a C function.
f77_calls_c++, a Fortran77 code which calls a C++ function.
f77_calls_matlab, a Fortran77 code which calls a MATLAB function;
f77_class, a Fortran77 code which was used in a programming class.
f77_cleanup, a Fortran90 code which makes a copy of a Fortran77 file where some minor cleanups have been made.
f77_combinatorics, a Fortran77 code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
f77_condor, a Fortran77 code which runs in batch mode using the condor queueing system.
f77_exact, a Fortran77 code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
f77_intrinsics, a Fortran77 code which illustrates the use of intrinsic functions supplied by the Fortran77 language.
f77_return, a Fortran77 code which illustrates how a code returns a program status value to the calling environment.
f77_rule, a Fortran77 code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as, a circle, a disk, an ellipse, a triangle, a quadrilateral, a polygon, a sphere, a ball, a hypercube, and which might include an associated weight function w(x).
f77_to_f90, a Fortran90 code which converts a Fortran77 file to Fortran90 format, by Michael Metcalfe;
f77split, a C code which reads a Fortran77 file and creates individual files for every blockdata, function, module, program, or subroutine in the file.
f90_test, a Fortran90 code which illustrates features of the Fortran90 programming language;
f90_calls_c, a Fortran90 code which calls a C function.
f90_calls_c_and_mpi, a Fortran90 code which calls a C function while executing under the MPI parallel programming environment.
f90_calls_c++, a Fortran90 code which call a C++ function.
f90_calls_c++_and_mpi, a Fortran90 code which calls a C++ function while executing under the MPI parallel environment.
f90_calls_matlab, a Fortran90 code which calls a MATLAB function;
f90_combinatorics, a Fortran90 code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
f90_condor, a Fortran90 code which runs a Fortran90 program in batch mode using the condor queueing system.
f90_exact, a Fortran90 code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
f90_files_test, a Fortran90 code which uses files.
f90_intrinsics_test, a Fortran90 code which uses intrinsic functions.
f90_mistake_test, a Fortran90 code which illustrates certain mistakes in Fortran90.
f90_module_test, a Fortran90 code which uses the Fortran90 module feature (ugh).
f90_monte_carlo, a Fortran90 code which uses Monte Carlo sampling to estimate areas and integrals.
f90_random_test, a Fortran90 code which uses the random number generator (RNG) routines.
f90_return, a Fortran90 code which illustrates how a program prints a text message or returns a numeric program status value to the calling environment when executing the STOP statement.
f90_rule, a Fortran90 code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as, a circle, a disk, an ellipse, a triangle, a quadrilateral, a polygon, a sphere, a ball, a hypercube, and which might include an associated weight function w(x).
f90_simulation, a Fortran90 code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
f90_to_f77, a Fortran90 code which assists in the conversion of a Fortran90 file to Fortran77 format.
f90split, a C code which reads a Fortran file and creates individual files for every blockdata, function, module, program, or subroutine in the file.
f90split, a Fortran90 code which reads a Fortran file and creates individual files for every blockdata, function, module, program, or subroutine in the file.
face_spmd, a MATLAB code 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.
faces, a dataset directory which contains images for facial recognition applications.
faces_angela_merkel, a dataset directory which contains images of Angela Merkel for facial recognition applications.
faces_arnold_schwarzenegger, a dataset directory which contains images of Arnold Schwarzenegger for facial recognition applications.
faces_average, a MATLAB code which averages several images of the same face;
faces_average, an Octave code which averages several images of the same face;
faces_classify_knn, a scikit-learn code which uses the k-nearest neighbor algorithm to match new faces with images in the faces dataset.
faces_classify_nmf, a scikit-learn code which uses the nonnegative matrix factorization algorithm to match new faces with images in the faces dataset.
faces_classify_pca, a scikit-learn code which uses principal component analysis (PCA) to match new faces with images in the faces dataset.
faces_emma_stone, a dataset directory which contains images of Emma Stone for facial recognition applications.
faces_matt_damon, a dataset directory which contains images of Matt Damon for facial recognition applications.
faces_michael_caine, a dataset directory which contains images of Michael Caine for facial recognition applications.
faces_sylvester_stallone, a dataset directory which contains images of Sylvester Stallone for facial recognition applications.
faces_taylor_swift, a dataset directory which contains images of Taylor Swift for facial recognition applications.
fair_dice_simulation, a C code which simulates N games where two fair dice are thrown and summed, creating graphics files for processing by gnuplot().
fair_dice_simulation, a C++ code which simulates N games where two fair dice are thrown and summed, creating graphics files for processing by gnuplot().
fair_dice_simulation, a Fortran77 code which simulates N games where two fair dice are thrown and summed, creating graphics files for processing by gnuplot().
fair_dice_simulation, a Fortran90 code which simulates N games where two fair dice are thrown and summed, creating graphics files for processing by gnuplot().
fair_dice_simulation, a MATLAB code which simulates N tosses of 2 dice, making a histogram of the resulting sums.
fair_dice_simulation, an Octave code which simulates N tosses of 2 dice, making a histogram of the resulting sums.
fair_dice_simulation, a Python code which simulates N tosses of 2 dice, making a histogram of the resulting sums.
faure, a dataset directory which contains examples of the Faure Quasi Monte Carlo (QMC) sequence;
faure, a C++ code which computes elements of a Faure Quasi Monte Carlo (QMC) sequence.
faure, a Fortran90 code which computes elements of a Faure Quasi Monte Carlo (QMC) sequence.
faure, a MATLAB code which computes elements of a Faure Quasi Monte Carlo (QMC) sequence.
faure, an Octave code which computes elements of a Faure Quasi Monte Carlo (QMC) sequence.
faure_dataset, a C++ code which creates a Faure Quasi Monte Carlo (QMC) dataset;
faure_dataset, a Fortran90 code which creates a Faure Quasi Monte Carlo (QMC) dataset;
faure_dataset, a MATLAB code which creates a Faure Quasi Monte Carlo (QMC) dataset;
fd_predator_prey, a C code which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.
fd_predator_prey, a C++ code which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.
fd_predator_prey, a Fortran77 code which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.
fd_predator_prey, a Fortran90 code which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation, and plots the data with gnuplot().
fd_predator_prey, a MATLAB code which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.
fd_predator_prey, an Octave code which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.
fd_predator_prey, a Python code which applies the finite difference method (FDM) to a predator-prey system with time dependence and no spatial variation.
fd_to_tec, a MATLAB code which converts finite difference method (FDM) 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 code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot().
fd1d_advection_diffusion_steady_test
fd1d_advection_diffusion_steady, a C++ code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot().
fd1d_advection_diffusion_steady_test
fd1d_advection_diffusion_steady, a Fortran77 code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot().
fd1d_advection_diffusion_steady_test
fd1d_advection_diffusion_steady, a Fortran90 code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot().
fd1d_advection_diffusion_steady_test
fd1d_advection_diffusion_steady, a MATLAB code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k.
fd1d_advection_diffusion_steady_test
fd1d_advection_diffusion_steady, an Octave code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k.
fd1d_advection_diffusion_steady_test
fd1d_advection_ftcs, a C code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot().
fd1d_advection_ftcs, a C++ code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot().
fd1d_advection_ftcs, a Fortran77 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot().
fd1d_advection_ftcs, a Fortran90 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method, writing graphics files for processing by gnuplot().
fd1d_advection_ftcs, a MATLAB code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method.
fd1d_advection_ftcs, an Octave code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time, centered space (FTCS) difference method.
fd1d_advection_lax, a C code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax, a C++ code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax, a Fortran77 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax, a Fortran90 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax, a MATLAB code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative.
fd1d_advection_lax, an Octave code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to treat the time derivative.
fd1d_advection_lax_wendroff, a C code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax_wendroff_test
fd1d_advection_lax_wendroff, a C++ code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax_wendroff_test
fd1d_advection_lax_wendroff, a Fortran77 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax_wendroff_test
fd1d_advection_lax_wendroff, a Fortran90 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative, writing graphics files for processing by gnuplot().
fd1d_advection_lax_wendroff_test
fd1d_advection_lax_wendroff, a MATLAB code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative.
fd1d_advection_lax_wendroff_test
fd1d_advection_lax_wendroff, an Octave code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative.
fd1d_advection_lax_wendroff_test
fd1d_advection_lax_wendroff, a Python code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to treat the time derivative.
fd1d_burgers_lax, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
fd1d_bvp, a C++ code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
fd1d_bvp, a Fortran77 code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
fd1d_bvp, a Fortran90 code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
fd1d_bvp, a MATLAB code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
fd1d_bvp, an Octave code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
fd1d_bvp, a Python code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
fd1d_display, a MATLAB code which reads a pair of files defining a 1D finite difference method (FDM) model, and plots the data.
fd1d_display, an Octave code which reads a pair of files defining a 1D finite difference method (FDM) model, and plots the data.
fd1d_heat_explicit, a C code 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++ code 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 code 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 code 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 code which uses the finite difference method (FDM) and explicit time stepping to solve the time dependent heat equation in 1D.
fd1d_heat_explicit, an Octave code 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 code 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 code 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++ code 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 code 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 code 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 code which uses the finite difference method (FDM) and implicit time stepping to solve the time dependent heat equation in 1D.
fd1d_heat_implicit, an Octave code 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 code 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 code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.
fd1d_heat_steady, a C++ code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.
fd1d_heat_steady, a Fortran77 code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.
fd1d_heat_steady, a Fortran90 code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.
fd1d_heat_steady, a MATLAB code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.
fd1d_heat_steady, an Octave code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 1D.
fd1d_poisson, a MATLAB code which solves a Poisson equation over a user-specified discretized interval, with given functions f(x) (right hand side) and g(x) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
fd1d_poisson, an Octave code which solves a Poisson equation over a user-specified discretized interval, with given functions f(x) (right hand side) and g(x) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
fd1d_predator_prey, a Fortran77 code which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence, by Marcus Garvie.
fd1d_predator_prey, a Fortran90 code which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence, by Marcus Garvie.
fd1d_predator_prey, a MATLAB code which implements the finite difference method (FDM) for predator-prey system with time and 1D spatial dependence, by Marcus Garvie.
fd1d_predator_prey, an Octave code 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 code which plots solutions of a system of predator prey ordinary differential equations (ODE), by Marcus Garvie.
fd1d_predator_prey_plot, an Octave code which plots solutions of a system of predator prey ordinary differential equations (ODE), by Marcus Garvie.
fd1d_wave, a C code 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++ code 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 code 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 code 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 code which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.
fd1d_wave, an Octave code 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 describe models created with the finite difference method (FDM).
fd2d_convergence_test, a MATLAB code which calls fd2d_poisson(), which repeatedly solves a Poisson equation on a sequence of finer meshes, so that the relationship between mesh size H and error norm E can be explored.
fd2d_convergence_test, an Octave code which calls fd2d_poisson(), which repeatedly solves a Poisson equation on a sequence of finer meshes, so that the relationship between mesh size H and error norm E can be explored.
fd2d_heat_explicit_spmd, a MATLAB code 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. The Single Program Multiple Data (SPMD) facility is used to carry out the computation in parallel.
fd2d_heat_steady, a C code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.
fd2d_heat_steady, a C++ code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.
fd2d_heat_steady, a Fortran77 code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.
fd2d_heat_steady, a Fortran90 code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.
fd2d_heat_steady, a MATLAB code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.
fd2d_heat_steady, an Octave code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.
fd2d_heat_steady, a Python code which uses the finite difference method (FDM) to solve the steady (time independent) heat equation in 2D.
fd2d_poisson, a MATLAB code which solves a Poisson equation over a user-specified discretized rectangle, with given functions f(x,y) (right hand side) and g(x,y) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
fd2d_poisson, an Octave code which solves a Poisson equation over a user-specified discretized rectangle, with given functions f(x,y) (right hand side) and g(x,y) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
fd2d_predator_prey, a Fortran90 code 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 code which implements the finite difference method (FDM) for a predator-prey system with time and 2D spatial dependence, by Marcus Garvie.
fd2d_predator_prey, an Octave code 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).
fd3d_poisson, a MATLAB code which solves a Poisson equation over a user-specified discretized 3d block, with given functions f(x,y,z) (right hand side) and g(x,y,z) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
fd3d_poisson, an Octave code which solves a Poisson equation over a user-specified discretized 3d block, with given functions f(x,y,z) (right hand side) and g(x,y,z) (Dirichlet boundary conditions), using the Finite Difference Method (FDM).
felippa, a Mathematica code which defines Felippa quadrature rules for lines, triangles, quadrilaterals, pyramids, wedges, tetrahedrons and hexahedrons.
fem_50, a MATLAB code 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 code which implements a finite element method (FEM) for the heat equation, by Jochen Alberty, Carsten Carstensen, Stefan Funken.
fem_basis, a C code which defines 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++ code which defines 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 code which defines 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 code which defines 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 code which defines 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, an Octave code which defines 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 code which defines 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 code which displays a finite element method (FEM) basis function associated with a linear quadrilateral (Q4) mesh.
fem_basis_q4_display, an Octave code which displays a finite element method (FEM) basis function associated with a linear quadrilateral (Q4) mesh.
fem_basis_t3_display, a MATLAB code which displays a finite element method (FEM) basis function associated with a 3-node triangle (T3) mesh.
fem_basis_t3_display, an Octave code which displays a finite element method (FEM) basis function associated with a 3-node triangle (T3) mesh.
fem_basis_t4_display, a MATLAB code which displays a finite element method (FEM) basis function associated with a 4-node triangle (T4) mesh.
fem_basis_t4_display, an Octave code which displays a finite element method (FEM) basis function associated with a 4-node triangle (T4) mesh.
fem_basis_t6_display, a MATLAB code which displays a finite element method (FEM) basis function associated with a 6-node triangle (T6) mesh.
fem_io, a C code which reads or writes node, element and data files defining a model associated with the finite element method (FEM).
fem_io, a C++ code which reads or writes node, element and data files defining a model associated with the finite element method (FEM).
fem_io, a Fortran77 code which reads or writes node, element and data files defining a model associated with the finite element method (FEM).
fem_io, a Fortran90 code which reads or writes node, element and data files defining a model associated with the finite element method (FEM).
fem_io, a MATLAB code which reads or writes node, element and data files defining a model associated with the finite element method (FEM).
fem_io, an Octave code which reads or writes node, element and data files defining a model associated with the finite element method (FEM).
fem_meshing, examples which look at some simple issues in defining a geometric mesh for the finite element method (FEM) in 2D.
fem_neumann, a MATLAB code which sets up a time-dependent reaction-diffusion equation in 1D, with Neumann boundary conditions, discretized using the finite element method (FEM).
fem_neumann, an Octave code 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 code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding medit() MESH file.
fem_to_medit, a C++ code which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding medit() MESH file.
fem_to_medit, a Fortran77 code which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding medit() MESH file.
fem_to_medit, a Fortran90 code which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding medit() MESH file.
fem_to_medit, a MATLAB code which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding medit() MESH file.
fem_to_medit, an Octave code which reads a pair of FEM files defining node coordinates and elements, and creates a corresponding medit() MESH file.
fem_to_tec, a Fortran90 code which converts FEM models into tecplot() ASCII files.
fem_to_tec, a MATLAB code which converts FEM models into tecplot() ASCII files.
fem_to_triangle, a C code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
fem_to_triangle, a C++ code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
fem_to_triangle, a Fortran77 code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
fem_to_triangle, a Fortran90 code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
fem_to_triangle, a MATLAB code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
fem_to_triangle, an Octave code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
fem_to_xml, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code 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 code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d, a C++ code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d, a Fortran77 code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d, a Fortran90 code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d, a MATLAB code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d, an Octave code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d, a Python code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d_adaptive, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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_approximate, a MATLAB code which uses the finite element method (FEM) and piecewise linear (PWL) basis functions to approximate data points, while controlling the variation in the derivative.
fem1d_approximate, an Octave code which uses the finite element method (FEM) and piecewise linear (PWL) basis functions to approximate data points, while controlling the variation in the derivative.
fem1d_bvp_linear, a C code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_linear, a C++ code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_linear, a Fortran77 code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_linear, a Fortran90 code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_linear, a MATLAB code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_linear, an Octave code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_linear, a Python code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_quadratic, a C code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_quadratic, a C++ code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_quadratic, a Fortran77 code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_quadratic, a Fortran90 code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_quadratic, a MATLAB code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_quadratic, an Octave code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
fem1d_bvp_quadratic, a Python code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension.
fem1d_classes, a Python code 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 code which reads three files defining a 1D arbitrary degree function associated with the finite element method (FEM), and displays a plot.
fem1d_display, an Octave code 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 code which reads three files defining a 1D piecewise linear (PWL) finite element method (FEM) function and displays a plot.
fem1d_display_function_10_test
fem1d_function_10_display, an Octave code which reads three files defining a 1D piecewise linear (PWL) finite element method (FEM) function and displays a plot.
fem1d_display_function_10_test
fem1d_heat_explicit, a MATLAB code which uses the finite element method (FEM) and explicit time stepping to solve the time dependent heat equation in 1D.
fem1d_heat_explicit, an Octave code 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 code 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 code which uses the finite element method (FEM) and implicit time stepping to solve the time dependent heat equation in 1D.
fem1d_heat_implicit, an Octave code 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 code which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.
fem1d_heat_steady, a C++ code which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.
fem1d_heat_steady, a Fortran77 code which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.
fem1d_heat_steady, a Fortran90 code which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.
fem1d_heat_steady, a MATLAB code which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.
fem1d_heat_steady, an Octave code which uses the finite element method (FEM) to solve the steady (time independent) heat equation in 1D.
fem1d_lagrange, a C code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
fem1d_lagrange, a C++ code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
fem1d_lagrange, a Fortran77 code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
fem1d_lagrange, a Fortran90 code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
fem1d_lagrange, a MATLAB code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
fem1d_lagrange, an Octave code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
fem1d_model, a Python code which applies the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d_nonlinear, a C code which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).
fem1d_nonlinear, a C++ code which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).
fem1d_nonlinear, a Fortran77 code which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).
fem1d_nonlinear, a Fortran90 code which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).
fem1d_nonlinear, a MATLAB code which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).
fem1d_nonlinear, an Octave code which applies the finite element method (FEM) to a 1D nonlinear two point boundary value problem (BVP).
fem1d_oden, a Fortran77 code which applies the finite element method (FEM) to a linear two point boundary value problem (BVP) in one spatial dimension; this code is an example for the Texas Finite Element Series, by Eric Becker, Graham Carey and J Tinsley Oden.
fem1d_pack, a C code which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.
fem1d_pack, a C++ code which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.
fem1d_pack, a Fortran77 code which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.
fem1d_pack, a Fortran90 code which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.
fem1d_pack, a MATLAB code which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.
fem1d_pack, an Octave code which contains utilities for calculations with the finite element method (FEM) on a 1D geometry.
fem1d_pmethod, a C code 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++ code 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 code 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 code 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 code which applies the p-method version of the finite element method (FEM) to a 1D linear two point boundary value problem (BVP).
fem1d_pmethod, an Octave code 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 code which projects a function into a function space associated with the finite element method (FEM), using least squares or projection methods, especially for cases in which data must be transferred from one mesh to another.
fem1d_project, a C++ code which projects a function into a function space associated with the finite element method (FEM), using least squares or projection methods, especially for cases in which data must be transferred from one mesh to another.
fem1d_project, a Fortran77 code which projects a function into a function space associated with the finite element method (FEM), using least squares or projection methods, especially for cases in which data must be transferred from one mesh to another.
fem1d_project, a Fortran90 code which projects a function into a function space associated with the finite element method (FEM), using least squares or projection methods, especially for cases in which data must be transferred from one mesh to another.
fem1d_project, a MATLAB code which projects a function into a function space associated with the finite element method (FEM), using least squares or projection methods, especially for cases in which data must be transferred from one mesh to another.
fem1d_project, an Octave code which projects a function into a function space associated with the finite element method (FEM), using least squares or projection methods, especially for cases in which data must be transferred from one mesh to another.
fem1d_sample, a C code which samples a scalar or vector function of one variable, modeled by the finite element method (FEM), and returns interpolated values at sample points.
fem1d_sample, a C++ code which samples a scalar or vector function of one variable, modeled by the finite element method (FEM), and returns interpolated values at sample points.
fem1d_sample, a Fortran77 code which samples a scalar or vector function of one variable, modeled by the finite element method (FEM), and returns interpolated values at sample points.
fem1d_sample, a Fortran90 code which samples a scalar or vector function of one variable, modeled by the finite element method (FEM), and returns interpolated values at sample points.
fem1d_sample, a MATLAB code which samples a scalar or vector function of one variable, modeled by the finite element method (FEM), and returns interpolated values at sample points.
fem1d_sample, an Octave code which samples a scalar or vector function of one variable, modeled by the finite element method (FEM), and returns interpolated values at sample points.
fem1d_spectral_numeric, a MATLAB code 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 the MATLAB quad() function, by Miro Stoyanov.
fem1d_spectral_symbolic, a MATLAB code 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 the MATLAB 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 code which applies the finite element method (FEM), with piecewise linear (PWL) 2D 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++ code which applies the finite element method (FEM), with piecewise linear (PWL) 2D 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 code which applies the finite element method (FEM), with piecewise linear (PWL) 2D 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 code which applies the finite element method (FEM), with piecewise linear (PWL) 2D 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 code which applies the finite element method (FEM), with piecewise linear (PWL) 2D 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, an Octave code which applies the finite element method (FEM), with piecewise linear (PWL) 2D 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 code which applies the finite element method (FEM), with piecewise linear (PWL) 2D elements, to a 2D boundary value problem (BVP) in a rectangle.
fem2d_bvp_quadratic, a C code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_quadratic, a C++ code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_quadratic, a Fortran77 code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_quadratic, a Fortran90 code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_quadratic, a MATLAB code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_quadratic, an Octave code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_serene, a C code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_serene, a C++ code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_serene, a Fortran77 code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_serene, a Fortran90 code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_serene, a MATLAB code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_bvp_serene, an Octave code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
fem2d_heat, a C++ code 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 code 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 code 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++ code 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 code 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 code 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, an Octave code 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 code which uses the 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 code which uses the finite element method (FEM) to solve the time dependent heat equation in an arbitrary triangulated 2D region, using the sparse matrix storage format and solver.
fem2d_heat_sparse, an Octave code which uses the finite element method (FEM) to solve the time dependent heat equation in an arbitrary triangulated 2D region, using the sparse matrix storage format and solver.
fem2d_mesh_display, a MATLAB code 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, an Octave code 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++ code which reads the finite element method (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_mesh_display_opengl_test
fem2d_navier_stokes, a C++ code 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 code 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 code 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++ code which contains the user-supplied routines necessary to run fem2d_navier_stokes() on the cavity problem.
fem2d_navier_stokes_cavity, a Fortran90 code which contains the user-supplied routines necessary to run fem2d_navier_stokes() on the cavity problem.
fem2d_navier_stokes_cavity, a MATLAB code which contains the user-supplied routines necessary to run fem2d_navier_stokes() on the cavity problem.
fem2d_navier_stokes_channel, a C++ code which contains the user-supplied routines necessary to run fem2d_navier_stokes() on the channel problem.
fem2d_navier_stokes_channel, a Fortran90 code which contains the user-supplied routines necessary to run fem2d_navier_stokes() on the channel problem.
fem2d_navier_stokes_channel, a MATLAB code which contains the user-supplied routines necessary to run fem2d_navier_stokes() on the channel problem.
fem2d_navier_stokes_inout, a C++ code which contains the user-supplied routines necessary to run fem2d_navier_stokes on the inout problem.
fem2d_navier_stokes_inout, a Fortran90 code which contains the user-supplied routines necessary to run fem2d_navier_stokes on the inout problem.
fem2d_navier_stokes_sparse, a MATLAB code which uses the finite element method (FEM) to solve the steady (time independent) incompressible Navier Stokes equations (NSE) on an arbitrary triangulated region, using the sparse() facility.
fem2d_navier_stokes_sparse_big_cavity, a MATLAB code 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 code which contains the user-supplied routines necessary to run fem2d_navier_stokes_sparse() on the cavity problem.
fem2d_navier_stokes_sparse_channel, a MATLAB code which contains the user-supplied routines necessary to run fem2d_navier_stokes_sparse() on the channel problem.
fem2d_navier_stokes_sparse_inout, a MATLAB code which contains the user-supplied routines necessary to run fem2d_navier_stokes_sparse() on the inout problem.
fem2d_oden, a Fortran77 code which implements a 2D calculations for the finite element method (FEM);
fem2d_pack, a C code which contains utilities for 2D finite element method (FEM) calculations.
fem2d_pack, a C++ code which contains utilities for 2D finite element method (FEM) calculations.
fem2d_pack, a Fortran77 code which contains utilities for 2D finite element method (FEM) calculations.
fem2d_pack, a Fortran90 code which contains utilities for 2D finite element method (FEM) calculations.
fem2d_pack, a MATLAB code which contains utilities for 2D finite element method (FEM) calculations.
fem2d_pack, an Octave code which contains utilities for 2D finite element method (FEM) calculations.
fem2d_poisson, a C++ code which solves the Poisson equation on a triangulated region, using the finite element method (FEM) and a banded solver.
fem2d_poisson, a Fortran90 code which solves the Poisson equation on a triangulated region, using the finite element method (FEM) and a banded solver.
fem2d_poisson_cg, a C++ code which solves the Poisson equation on a triangulated region, using the finite element method (FEM), sparse storage, and a conjugate gradient solver.
fem2d_poisson_cg, a Fortran90 code which solves the Poisson equation on a triangulated region, using the finite element method (FEM), sparse storage, and a conjugate gradient solver.
fem2d_poisson_cg, a MATLAB code which solves the Poisson equation on a triangulated region, using the finite element method (FEM), sparse storage, and a conjugate gradient solver.
fem2d_poisson_cg_baffle, a C++ code 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 code 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++ code 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 code 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++ code 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 code 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++ code 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 code 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++ code 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 code 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 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), triangular elements, and piecewise quadratic (PWQ) basis functions.
fem2d_poisson_rectangle, a C++ code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), triangular elements, and piecewise quadratic (PWQ) basis functions.
fem2d_poisson_rectangle, a Fortran77 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), triangular elements, and piecewise quadratic (PWQ) basis functions.
fem2d_poisson_rectangle, a Fortran90 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), triangular elements, and piecewise quadratic (PWQ) basis functions.
fem2d_poisson_rectangle, a MATLAB code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), triangular elements, and piecewise quadratic (PWQ) basis functions.
fem2d_poisson_rectangle, an Octave code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), triangular elements, and piecewise quadratic (PWQ) basis functions.
fem2d_poisson_rectangle_linear, a C code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear (PWL) triangular elements.
fem2d_poisson_rectangle_linear_test
fem2d_poisson_rectangle_linear, a C++ code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear (PWL) triangular elements.
fem2d_poisson_rectangle_linear_test
fem2d_poisson_rectangle_linear, a Fortran77 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear (PWL) triangular elements.
fem2d_poisson_rectangle_linear_test
fem2d_poisson_rectangle_linear, a Fortran90 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear (PWL) triangular elements.
fem2d_poisson_rectangle_linear_test
fem2d_poisson_rectangle_linear, a MATLAB code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear (PWL) triangular elements.
fem2d_poisson_rectangle_linear_test
fem2d_poisson_sparse, a C++ code 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 code 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 code 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++ code 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 code 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 code 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++ code 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 code 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 code 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++ code 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 code 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 code 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_predator_prey_fast, a MATLAB code which implements 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 optimizations, by Marcus Garvie.
fem2d_predator_prey_fast, an Octave code which implements 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 optimizations, by Marcus Garvie.
fem2d_project, a C++ code which projects a function f(x,y), given as a data, into a given finite element method (FEM) space of piecewise linear (PWL) triangular elements.
fem2d_project, a Fortran90 code which projects a function f(x,y), given as a data, into a given finite element method (FEM) space of piecewise linear (PWL) triangular elements.
fem2d_project, a MATLAB code which projects a function f(x,y), given as data, into a given finite element method (FEM) space for piecewise linear (PWL) triangular elements.
fem2d_project_function, a C++ code which projects a function f(x,y), given as a formula, into a given finite element method (FEM) space of piecewise linear (PWL) triangular elements.
fem2d_project_function, a Fortran90 code which projects a function f(x,y), given as a formula, into a given finite element method (FEM) space of piecewise linear (PWL) triangular elements.
fem2d_project_function, a MATLAB code which projects a function f(x,y), given as a formula, into a given finite element method (FEM) space of piecewise linear (PWL) triangular elements.
fem2d_project_function, an Octave code which projects a function f(x,y), given as a formula, into a given finite element method (FEM) space of piecewise linear (PWL) triangular elements.
fem2d_sample, a C++ code which evaluates a finite element method (FEM) function defined on an order 3 or order 6 triangulation of a 2D region.
fem2d_sample, a Fortran77 code which evaluates a finite element method (FEM) function defined on an order 3 or order 6 triangulation of a 2D region.
fem2d_sample, a Fortran90 code which evaluates a finite element method (FEM) function defined on an order 3 or order 6 triangulation of a 2D region.
fem2d_sample, a MATLAB code which evaluates a finite element method (FEM) function defined on an order 3 or order 6 triangulation of a 2D region.
fem2d_sample, an Octave code which evaluates a finite element method (FEM) function defined on an order 3 or order 6 triangulation of a 2D region.
fem2d_scalar_display, a MATLAB code 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).
fem2d_scalar_display, an Octave code 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).
fem2d_scalar_display_brief, a MATLAB code 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), in 5 lines of code.
fem2d_scalar_display_brief_test
fem2d_scalar_display_brief, an Octave code 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), in 5 lines of code.
fem2d_scalar_display_brief_test
fem2d_scalar_display_gpl, a MATLAB code 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), that can be displayed by gnuplot().
fem2d_scalar_display_gpl, an Octave code 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), that can be displayed by gnuplot().
fem2d_stokes, a C++ code 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 code 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++ code which contains the user-supplied routines necessary to run fem2d_stokes on the cavity problem.
fem2d_stokes_cavity, a Fortran90 code which contains the user-supplied routines necessary to run fem2d_stokes on the cavity problem.
fem2d_stokes_channel, a C++ code which contains the user-supplied routines necessary to run fem2d_stokes on the channel problem.
fem2d_stokes_channel, a Fortran90 code which contains the user-supplied routines necessary to run fem2d_stokes on the channel problem.
fem2d_stokes_inout, a C++ code which contains the user-supplied routines necessary to run fem2d_stokes on the inout problem.
fem2d_stokes_inout, a Fortran90 code which contains the user-supplied routines necessary to run fem2d_stokes on the inout problem.
fem2d_stokes_inout, a MATLAB code which contains the user-supplied routines necessary to run fem2d_stokes on the inout problem.
fem2d_stokes_sparse, a MATLAB code which solves the steady (time independent) incompressible Stokes equations on an arbitrary triangulated region, using the finite element method (FEM) and the MATLAB sparse() function.
fem2d_stokes_sparse_big_cavity, a MATLAB code which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the big cavity problem.
fem2d_stokes_sparse_cavity, a MATLAB code which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the cavity problem.
fem2d_stokes_sparse_channel, a MATLAB code which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the channel problem.
fem2d_stokes_sparse_inout, a MATLAB code which contains the user-supplied routines necessary to run fem2d_stokes_sparse on the inout problem.
fem2d_stokes_sparse_spiral, a MATLAB code 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++ code which contains utilities for 3D finite element method (FEM) calculations.
fem3d_pack, a Fortran90 code which contains utilities for 3D finite element method (FEM) calculations.
fem3d_pack, a MATLAB code which contains utilities for 3D finite element method (FEM) calculations.
fem3d_pack, an Octave code which contains utilities for 3D finite element method (FEM) calculations.
fem3d_project, a C++ code which projects a function F(X,Y,Z), given as tabulated data, into a space of piecewise linear (PWL) tetrahedral elements associated with the finite element method (FEM).
fem3d_project, a Fortran90 code which projects a function F(X,Y,Z), given as tabulated data, into a space of piecewise linear (PWL) tetrahedral elements associated with the finite element method (FEM).
fem3d_project, a MATLAB code which projects a function F(X,Y,Z), given as tabulated data, into a space of piecewise linear (PWL) tetrahedral elements associated with the finite element method (FEM).
fem3d_project, an Octave code which projects a function F(X,Y,Z), given as tabulated data, into a space of piecewise linear (PWL) tetrahedral elements associated with the finite element method (FEM).
fem3d_sample, a C++ code which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
fem3d_sample, a Fortran90 code which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
fem3d_sample, a MATLAB code which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
fem3d_sample, an Octave code which evaluates a function defined on a 3D tetrahedral mesh as part of the finite element method (FEM).
fenics_to_fem, a FENICS code which writes a mesh or scalar function to FEM files, to create images, or as input to meshing programs or other analysis tools.
fenics_to_txyv, a FENICS code which writes a mesh or scalar function to a t file (triangulation), a v file (a scalar field) and an xy file (spatial coordinates), to create images, or as input to meshing programs or other analysis tools.
fenics_to_txyz, a FENICS code which writes a mesh or scalar function to a t file (triangulation) and an xyz file (spatial coordinates and associated scalar value), to create images, or as input to meshing programs or other analysis tools.
fenics_to_fem, a FENICS code which writes a mesh or scalar function to FEM files, used to create images, or as input to meshing programs or other analysis tools.
fern, a MATLAB code which displays the Barnsley fractal fern.
fern, an Octave code which displays the Barnsley fractal fern.
fern, a Python code which displays the Barnsley fractal fern.
fern_opengl, a C code which uses OpenGL to display the Barnsley fractal fern.
fern_opengl, a C++ code which uses OpenGL to display the Barnsley fractal fern.
feynman_kac_1d, a C code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 1D interval by averaging stochastic paths to the boundary.
feynman_kac_1d, a C++ code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 1D interval by averaging stochastic paths to the boundary.
feynman_kac_1d, a Fortran77 code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 1D interval by averaging stochastic paths to the boundary.
feynman_kac_1d, a Fortran90 code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 1D interval by averaging stochastic paths to the boundary.
feynman_kac_1d, a MATLAB code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 1D interval by averaging stochastic paths to the boundary.
feynman_kac_1d, an Octave code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 1D interval by averaging stochastic paths to the boundary.
feynman_kac_2d, a C code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 2D ellipse by averaging stochastic paths to the boundary.
feynman_kac_2d, a C++ code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 2D ellipse by averaging stochastic paths to the boundary.
feynman_kac_2d, a Fortran77 code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 2D ellipse by averaging stochastic paths to the boundary.
feynman_kac_2d, a Fortran90 code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 2D ellipse by averaging stochastic paths to the boundary.
feynman_kac_2d, a MATLAB code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 2D ellipse by averaging stochastic paths to the boundary.
feynman_kac_2d, an Octave code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 2D ellipse by averaging stochastic paths to the boundary.
feynman_kac_3d, a C code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
feynman_kac_3d, a C++ code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
feynman_kac_3d, a Fortran77 code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
feynman_kac_3d, a Fortran90 code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
feynman_kac_3d, a MATLAB code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
feynman_kac_3d, an Octave code which demonstrates the use of the Feynman-Kac algorithm to solve the Poisson equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
ffmatlib, a MATLAB code which allows the user to plot finite element method (FEM) results from data computed by FreeFem++().
ffmatlib, an Octave code which allows the user to plot finite element method (FEM) results from data computed by FreeFem++().
fft_openmp, a C code which computes a Fast Fourier Transform (FFT) in parallel, using OpenMP.
fft_openmp, a C++ code which computes a Fast Fourier Transform (FFT) in parallel, using OpenMP.
fft_openmp, a Fortran77 code which computes a Fast Fourier Transform (FFT) in parallel, using OpenMP.
fft_openmp, a Fortran90 code which computes a Fast Fourier Transform (FFT) in parallel, using OpenMP.
fft_serial, a C code 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++ code 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 code 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 code 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 code which demonstrates the computation of a Fast Fourier Transform (FFT), and is intended as a starting point for implementing a parallel version.
fft_serial, an Octave code 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 code which computes Fast Fourier Transforms (FFT), by Paul Swarztrauber and Dick Valent, translated by Andrew Fernandes;
fftpack4, a Fortran90 code which computes Fast Fourier Transforms (FFT), by Paul Swarztrauber and Dick Valent;
fftpack5, a Fortran77 code which computes Fast Fourier Transforms (FFT), by Paul Swarztrauber and Dick Valent;
fftpack5, a Fortran90 code which computes Fast Fourier Transforms (FFT), by Paul Swarztrauber and Dick Valent;
fftpack5.1, a Fortran77 code which computes Fast Fourier Transforms (FFT), by Paul Swarztrauber and Dick Valent;
fftpack5.1, a Fortran90 code which computes Fast Fourier Transforms (FFT), using real 64 bit arithmetic, by Paul Swarztrauber and Dick Valent;
fftpack5.1_single, a Fortran90 code which computes Fast Fourier Transforms (FFT), using real 32 bit arithmetic, by Paul Swarztrauber and Dick Valent;
fftw_test, a C code which uses fftw(), which computes Fast Fourier Transforms (FFT), by Matteo Frigo and Steven Johnson.
fftw_test, a Fortran77 code which uses fftw(), which computes Fast Fourier Transforms (FFT), by Matteo Frigo and Steven Johnson.
fftw_test, a Fortran90 code which uses fftw(), which computes Fast Fourier Transforms (FFT), by Matteo Frigo and Steven Johnson.
fibonacci, an R code which evaluates the Fibonacci sequence.
fibonacci_spiral, a MATLAB code which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.
fibonacci_spiral, an Octave code which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.
fibonacci_spiral, a Python code which displays points on a Fibonacci spiral, suggesting the arrangement of seeds in a sunflower, for instance.
file_column_reverse, a Fortran90 code which creates a copy of a file in which the columns are reversed, that is, the characters on each line appear in reverse order.
file_increment, a MATLAB code which makes a copy of a file containing an integer array, after incrementing each entry by a given value.
file_increment, an Octave code which makes a copy of a file containing an integer array, after incrementing each entry by a given value.
file_merge, a Fortran90 code which merges two sorted files.
file_name_sequence, a C code which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.
file_name_sequence, a C++ code which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.
file_name_sequence, a Fortran77 code which generates a sequence of filenames that can be used when generating images for an animation.
file_name_sequence, a Fortran90 code which generates a sequence of filenames that can be used when generating images for an animation.
file_name_sequence, a MATLAB code which generates a sequence of filenames that can be used when generating images for an animation.
file_name_sequence, an Octave code which generates a sequence of filenames that can be used when generating images for an animation.
file_name_sequence, a Python code which demonstrates ways to generate a sequence of filenames that can be used when generating images for an animation.
file_row_reverse, a Fortran90 code which makes a copy of a file with the lines (rows) in reverse order.
file_transpose, a Fortran90 code which makes a transposed copy of a file, where the I-th word of the J-th line becomes the J-th word of the I-th line.
files_multiple, a C code which demonstrates how to open multiple output files at one time, and write data to any one specific file it chooses.
files_multiple, a C++ code which demonstrates how to open multiple output files at one time, and write data to any one specific file it chooses.
files_multiple, a Fortran77 code which demonstrates how to open multiple output files at one time, and write data to any one specific file it chooses.
files_multiple, a Fortran90 code which demonstrates how to open multiple output files at one time, and write data to any one specific file it chooses.
files_multiple_test, a MATLAB code which demonstrates how to open multiple output files at one time, and write data to any one specific file it chooses.
files_multiple_test, an Octave code which demonstrates how to open multiple output files at one time, and write data to any one specific file it chooses.
filon_rule, a C code which uses Filon's method to approximate integrals including an oscillatory factor of sin(k*x) or cos(k*x).
filon_rule, a C++ code which uses Filon's method to approximate integrals including an oscillatory factor of sin(k*x) or cos(k*x).
filon_rule, a Fortran77 code which uses Filon's method to approximate integrals including an oscillatory factor of sin(k*x) or cos(k*x).
filon_rule, a Fortran90 code which uses Filon's method to approximate integrals including an oscillatory factor of sin(k*x) or cos(k*x).
filon_rule, a MATLAB code which uses Filon's method to approximate integrals including an oscillatory factor of sin(k*x) or cos(k*x).
filon_rule, an Octave code which uses Filon's method to approximate integrals including an oscillatory factor of sin(k*x) or cos(k*x).
filum, a C code which works with information in text files.
filum, a C++ code which works with information in text files.
filum, a Fortran77 code which works with information in text files.
filum, a Fortran90 code which works with information in text files.
filum, a Mathematica code which works with information in text files.
filum, a MATLAB code which works with information in text files.
filum, an Octave code which works with information in text files.
filum, a Python code which works with information in text files.
findiff, an R code which applies the forward finite difference method (FDM) formula to a function.
fingerprints, a dataset directory which contains a few images of fingerprints.
fire_simulation, a C code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
fire_simulation, a C++ code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
fire_simulation, a Fortran77 code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
fire_simulation, a Fortran90 code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
fire_simulation, a MATLAB code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
fire_simulation, an Octave code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
fire_simulation, a Python code which simulates a forest fire over a rectangular array of trees, starting at a single random location.
fisher_exact, a C code which returns an exact solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u).
fisher_exact, a C++ code which returns an exact solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u).
fisher_exact, a Fortran90 code which returns an exact solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u).
fisher_exact, a MATLAB code which returns an exact solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u).
fisher_exact, an Octave code which returns an exact solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u).
fisher_exact, a Python code which returns an exact solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u).
fishpack, a Fortran77 code which solves the Poisson, Laplace, or Helmholtz equation in 2D or 3D on a variety of geometries, by Paul Swarztrauber and Roland Sweet.
fitnlm_test, a MATLAB code which tests the MATLAB fitnlm() function, which fits a nonlinear regression model.
fitzhugh_nagumo_ode, a MATLAB code which sets up the Fitzhugh-Nagumo system of ordinary differential equations (ODE).
fitzhugh_nagumo_ode, an Octave code which sets up the Fitzhugh-Nagumo system of ordinary differential equations (ODE).
fitzhugh_nagumo_ode, a Python code which sets up the Fitzhugh-Nagumo system of ordinary differential equations (ODE).
fixcon, a Fortran90 code which reads a Fortran file using Fortran77 continuation statements, and makes a copy that uses Fortran90 continuation instead.
flame_exact, a C code which returns the exact solution of an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_exact, a C++ code which returns the exact solution of an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_exact, a Fortran90 code which returns the exact solution of an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_exact, a MATLAB code which returns the exact solution of an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_exact, an Octave code which returns the exact solution of an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_exact, a Python code which returns the exact solution of an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_ode, a MATLAB code which sets up an ordinary differential equation (ODE) that models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_ode, an Octave code which sets up an ordinary differential equation (ODE) that models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_ode, a Python code which sets up an ordinary differential equation (ODE) that models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flame_odefun, a Python code which uses odefun() from the multiple precision package mpmath() to solve an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
flies_simulation, a MATLAB code which simulates an experiment in which two flies land on a plate of radius 1. By repeating the experiment many times, the average distance between the flies is to be estimated.
flies_simulation, an Octave code which simulates an experiment in which two flies land on a plate of radius 1. By repeating the experiment many times, the average distance between the flies is to be estimated.
flies_simulation, a Python code which simulates an experiment in which two flies land on a plate of radius 1. By repeating the experiment many times, the average distance between the flies is to be estimated.
flood_opengl, a C code 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, a MATLAB code which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based solely on geometric considerations.
florida_cvt_geo, Python functions which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based solely on geometric considerations.
florida_cvt_pop, a MATLAB code which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based on population density.
florida_cvt_pop, a Python code which creates a centroidal Voronoi Tessellation (CVT) of the state of Florida, based on population density.
floyd, a C code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
floyd, a C++ code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
floyd, a Fortran77 code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
floyd, a Fortran90 code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
floyd, a MATLAB code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
floyd, an Octave code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
floyd, a Python code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
floyd_parallel, a MATLAB code which attempts to run a parallel implementation of the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
fly_simulation, a MATLAB code which simulates an experiment in which a fly lands on a plate of radius 1. By repeating the experiment many times, the average distance of the fly from the center is to be estimated.
fly_simulation, an Octave code which simulates an experiment in which a fly lands on a plate of radius 1. By repeating the experiment many times, the average distance of the fly from the center is to be estimated.
fly_simulation, a Python code which simulates an experiment in which a fly lands on a plate of radius 1. By repeating the experiment many times, the average distance of the fly from the center is to be estimated.
fmincon_parallel, a MATLAB code which demonstrates the use of the MATLAB fmincon() constrained minimization function, taking advantage of the MATLAB Parallel Computing Toolbox for faster execution.
fmincon_test, a MATLAB code which calls fmincon(), which seeks the minimizer of a scalar function of multiple variables, within a region specified by linear constraints and bounds. fmincon() is part of the MATLAB Optimization Toolbox.
fmm2d, a Fortran77 code which implements the fast multipole method, by Leslie Greengard and Zydrunas Gimbutas.
fn, a C code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson 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++ code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson 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 code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson 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 code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson 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 code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson 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 code which evaluates elementary and special functions using Chebyshev polynomials, including Airy, Bessel I, Bessel J, Bessel K, Bessel Y, beta, confluent hypergeometric, cosine integral, the Dawson 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.
fokker_planck, a FreeFem++ code which solves the Fokker-Planck equation for a Probability Density Function (PDF) describing a system of two molecular species X and Y governed by five reactions with stochastic behavior.
football_dynamic, a C code which uses dynamic programming to count the ways of achieving a given score in football, respecting the order of events.
football_dynamic, a C++ code which uses dynamic programming to count the ways of achieving a given score in football, respecting the order of events.
football_dynamic, a Fortran90 code which uses dynamic programming to count the ways of achieving a given score in football, respecting the order of events.
football_dynamic, a MATLAB code which uses dynamic programming to count the ways of achieving a given score in football, respecting the order of events.
football_dynamic, an Octave code which uses dynamic programming to count the ways of achieving a given score in football, respecting the order of events.
football_dynamic, a Python code which uses dynamic programming to count the ways of achieving a given score in football, respecting the order of events.
football_rank, a Fortran90 code which is given a set of game scores, and produces a ranking of college football teams.
football2_diophantine, a Python code which uses diophantine analysis to count the ways of achieving a given score in football, ignoring the ordering of events.
football2_dynamic, a Python code which uses dynamic programming to count the ways of achieving a given score in football, respecting the order of events.
forest_fire_simulation, a C code which simulates the occurrence of fires and regrowth in a forest, displaying the results using X Windows, by Michael Creutz.
forge_classify_knn, a scikit-learn code which uses the k-nearest neighbor algorithm to choose one of two classes for each of 26 items in the forge dataset, involving two features.
forge_classify_svm, a scikit-learn code which uses the support vector machine (SVM) classifier to choose one of two classes for each of 26 items in the forge dataset, involving two features.
four_fifths, a MATLAB code 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.
four_fifths, an Octave code 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.
four_fifths, a Python code 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.
fractal_coastline, a MATLAB code which uses perturbed Bezier interpolation to create a fractal coastline from a crude outline of a state, country, island, or even any general closed polygonal curve.
fractal_coastline, an Octave code which uses perturbed Bezier interpolation to create a fractal coastline from a crude outline of a state, country, island, or even any general closed polygonal curve.
freefem, examples which use FreeFem++, which is a high-level integrated development environment for the numerical solution of nonlinear multiphysics partial differential equations (PDE) in 2D and 3D.
freefem_msh, a data directory which contains examples of the FreeFem++() MSH files.
freefem_msh_io, a C code which reads and writes FreeFem++() MSH files.
freefem_msh_io, a C++ code which reads and writes FreeFem++() MSH files.
freefem_msh_io, a Fortran90 code which reads and writes FreeFem++() MSH files.
freefem_msh_io, a MATLAB code which reads and writes FreeFem++() MSH files.
freefem_msh_io, an Octave code which reads and writes FreeFem++() MSH files.
freefem_msh_io, a Python code which reads and writes FreeFem++ MSH files.
frieze, a Fortran90 code which maps a pattern repeatedly into a (distorted) 2D region to create a sort of wallpaper;
frobenius, a Mathematica code which is useful for the Froebenius problem, also known as the postage stamp problem.
fsolve, a C code which solves systems of nonlinear equations, inspired by the fsolve() function in minpack(), with special interfaces fsolve_bdf2(), fsolve_be() and fsolve_tr() for handling systems associated with implicit ODE solvers of type bdf2, backward Euler, midpoint, or trapezoidal.
fsolve, a C++ code which solves systems of nonlinear equations, inspired by the fsolve() function in minpack(), with special interfaces fsolve_bdf2(), fsolve_be() and fsolve_tr() for handling systems associated with implicit ODE solvers of type bdf2, backward Euler, midpoint, or trapezoidal.
fsolve, a Fortran77 code which solves systems of nonlinear equations, inspired by the fsolve() function in minpack(), with special interfaces fsolve_bdf2(), fsolve_be() and fsolve_tr() for handling systems associated with implicit ODE solvers of type bdf2, backward Euler, midpoint, or trapezoidal.
fsolve, a Fortran90 code which solves systems of nonlinear equations, inspired by the fsolve() function in minpack(), with special interfaces fsolve_bdf2(), fsolve_be() and fsolve_tr() for handling systems associated with implicit ODE solvers of type bdf2, backward Euler, midpoint, or trapezoidal.
fsolve_test, a MATLAB code which calls fsolve() which seeks the solution x of one or more nonlinear equations f(x)=0.
fsolve_test, an Octave code which calls fsolve() which seeks the solution x of one or more nonlinear equations f(x)=0.
fsolve_test, a Python code which calls fsolve() which seeks the solution x of one or more nonlinear equations f(x)=0.
fsolve_test, an R code which calls fsolve() which seeks the solution x of one or more nonlinear equations f(x)=0.
fsolve_bdf2, a C code which solves systems of nonlinear equations represented as an implicit backward difference formula order 2 (BDF2) residual.
fsolve_bdf2, a C++ code which solves systems of nonlinear equations represented as an implicit backward difference formula order 2 (BDF2) residual.
fsolve_bdf2, a Fortran90 code which solves systems of nonlinear equations represented as an implicit backward difference formula order 2 (BDF2) residual.
fsolve_be, a C code which solves systems of nonlinear equations represented as an implicit backward Euler residual.
fsolve_be, a C++ code which solves systems of nonlinear equations represented as an implicit backward Euler residual.
fsolve_be, a Fortran77 code which solves systems of nonlinear equations represented as an implicit backward Euler residual.
fsolve_be, a Fortran90 code which solves systems of nonlinear equations represented as an implicit backward Euler residual.
fsolve_tr, a C code which solves systems of nonlinear equations represented as an implicit trapezoidal ODE solver residual.
fsolve_tr, a C++ code which solves systems of nonlinear equations represented as an implicit trapezoidal ODE solver residual.
fsolve_tr, a Fortran90 code which solves systems of nonlinear equations represented as an implicit trapezoidal ODE solver residual.
fsplit, a Fortran90 code which reads a Fortran file and creates individual files for every function, program, or subroutine in the file, by Van Snyder.
fsu_dakota, a C++ code which implements a variety of methods for the generation of Quasi Monte Carlo (QMC) numbers, submitted for inclusion in the Sandia Labs dakota() package;
full_deck_simulation, a MATLAB code which simulates a process in which a random card is drawn from a deck of 52, and then replaced, continuing until every card has been seen at least once.
full_deck_simulation, an Octave code which simulates a process in which a random card is drawn from a deck of 52, and then replaced, continuing until every card has been seen at least once.
full_deck_simulation, a Python code which simulates a process in which a random card is drawn from a deck of 52, and then replaced, continuing until every card has been seen at least once.
functions_openmp, a C code which demonstrates the behavior of a few of the OpenMP intrinsic functions.
g++_intrinsics_test, a C++ code which uses G++ intrinsic functions.
g++_quadmath_test, a C++ code which uses G++ real 128 bit arithmetic.
g77_intrinsics, a Fortran77 code which use intrinsic functions provided by the Gnu G77 compiler for Fortran77.
g95_intrinsics, a Fortran90 code which illustrates the use of intrinsic functions provided by the G95 compiler for Fortran.
g95_quadmath, a Fortran90 code which illustrates the use of real 128 bit arithmetic provided on some systems by the G95 compiler for Fortran.
gamblers_ruin_simulation, a MATLAB code which simulates a game in which a gambler starts with a fixed bankroll, and then repeatedly makes the same bet until going bankrupt.
gamblers_ruin_simulation, an Octave code which simulates a game in which a gambler starts with a fixed bankroll, and then repeatedly makes the same bet until going bankrupt.
gamblers_ruin_simulation, a Python code which simulates a game in which a gambler starts with a fixed bankroll, and then repeatedly makes the same bet until going bankrupt.
gauss_seidel, a C code which uses the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel, a C++ code which uses the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel, a Fortran90 code which uses the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel, a MATLAB code which uses the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel, an Octave code which uses the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel, a Python code which uses the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel, an R code which uses the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel_poisson_1d, a MATLAB code 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.
gauss_seidel_poisson_1d, an Octave code 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.
gauss_seidel_stochastic, a MATLAB code which uses a stochastic version of the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel_stochastic, an Octave code which uses a stochastic version of the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gauss_seidel_stochastic, a Python code which uses a stochastic version of the Gauss-Seidel iteration to solve a linear system with a symmetric positive definite (SPD) matrix.
gaussian, a MATLAB code which evaluates the Gaussian function and its derivatives.
gaussian, an Octave code which evaluates the Gaussian function and its derivatives.
gaussian, a Python code which evaluates the Gaussian function and its derivatives.
gaussian_2d, a MATLAB code which evaluates a general Gaussian function of a 2D argument.
gaussian_2d, an Octave code which evaluates a general Gaussian function of a 2D argument.
gaussian_prime_spiral, a MATLAB code which computes a twisting spiral path along the Gaussian primes, and displays a plot of the total trajectory.
gaussian_prime_spiral, an Octave code which computes a twisting spiral path along the Gaussian primes, and displays a plot of the total trajectory.
gaussian_prime_spiral, a Python code which computes a twisting spiral path along the Gaussian primes, and displays a plot of the total trajectory.
gaussint, an R code which applies a Gauss quadrature rule to estimate an integral.
gcc_intrinsics_test, a C code which demonstrates or tests some of the intrinsic functions made available by the Gnu GCC compiler for C.
gcc_quadmath, a C code which illustrates the use of real 128 bit arithmetic provided on some systems by the Gnu GCC compiler for C.
gd, an R code which seeks a minimizer of a multivariate function using gradient descent.
gdb_test, a Fortran77 code which calls gdb(), which is the GNU debugger;
gdb_test, a Fortran90 code which calls gdb(), which is the GNU debugger;
gdls, an R code which uses gradient descent to solve a linear least squares (LLS) problem.
ge, a dataset directory which contains matrices stored in General (GE) format;
ge_to_crs, a MATLAB code which converts a matrix from General (GE) to Compressed Row Storage (CRS) format.
ge_to_crs, a Python code which converts a matrix from General (GE) to Compressed Row Storage (CRS) format.
gegenbauer_cc, a C code which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
gegenbauer_cc, a C++ code which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
gegenbauer_cc, a Fortran90 code which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
gegenbauer_cc, a MATLAB code which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
gegenbauer_cc, a Python code which estimates the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
gegenbauer_exactness, a C++ code which tests the exactness of Gauss-Gegenbauer quadrature rules.
gegenbauer_exactness, a Fortran90 code which tests the exactness of Gauss-Gegenbauer quadrature rules.
gegenbauer_exactness, a MATLAB code which tests the exactness of Gauss-Gegenbauer quadrature rules.
gegenbauer_exactness, an Octave code which tests the exactness of Gauss-Gegenbauer quadrature rules.
gegenbauer_exactness, a Python code which tests the exactness of Gauss-Gegenbauer quadrature rules.
gegenbauer_polynomial, a C code which evaluates the Gegenbauer polynomial and associated functions.
gegenbauer_polynomial, a C++ code which evaluates the Gegenbauer polynomial and associated functions.
gegenbauer_polynomial, a Fortran77 code which evaluates the Gegenbauer polynomial and associated functions.
gegenbauer_polynomial, a Fortran90 code which evaluates the Gegenbauer polynomial and associated functions.
gegenbauer_polynomial, a MATLAB code which evaluates the Gegenbauer polynomial and associated functions.
gegenbauer_polynomial, an Octave code which evaluates the Gegenbauer polynomial and associated functions.
gegenbauer_polynomial, a Python code which evaluates the Gegenbauer polynomial and associated functions.
gegenbauer_rule, a C++ code which computes a Gauss-Gegenbauer quadrature rule.
gegenbauer_rule, a Fortran90 code which computes a Gauss-Gegenbauer quadrature rule.
gegenbauer_rule, a MATLAB code which computes a Gauss-Gegenbauer quadrature rule.
gen_hermite_exactness, a C++ code which tests the exactness of generalized Gauss-Hermite quadrature rules.
gen_hermite_exactness, a Fortran90 code which tests the exactness of generalized Gauss-Hermite quadrature rules.
gen_hermite_exactness, a MATLAB code which tests the exactness of generalized Gauss-Hermite quadrature rules.
gen_hermite_exactness, an Octave code which tests the exactness of generalized Gauss-Hermite quadrature rules.
gen_hermite_exactness, a Python code which tests the exactness of generalized Gauss-Hermite quadrature rules.
gen_hermite_rule, a C++ code which returns a generalized Gauss-Hermite quadrature rule.
gen_hermite_rule, a Fortran90 code which returns a generalized Gauss-Hermite quadrature rule.
gen_hermite_rule, a MATLAB code which returns a generalized Gauss-Hermite quadrature rule.
gen_hermite_rule, an Octave code which returns a generalized Gauss-Hermite quadrature rule.
gen_laguerre_exactness, a C++ code which tests the exactness of generalized Gauss-Laguerre quadrature rules.
gen_laguerre_exactness, a Fortran90 code which tests the exactness of generalized Gauss-Laguerre quadrature rules.
gen_laguerre_exactness, a MATLAB code which tests the exactness of generalized Gauss-Laguerre quadrature rules.
gen_laguerre_exactness, an Octave code which tests the exactness of generalized Gauss-Laguerre quadrature rules.
gen_laguerre_exactness, a Python code which tests the exactness of generalized Gauss-Laguerre quadrature rules.
gen_laguerre_rule, a C++ code which returns a generalized Gauss-Laguerre quadrature rule.
gen_laguerre_rule, a Fortran90 code which returns a generalized Gauss-Laguerre quadrature rule.
gen_laguerre_rule, a MATLAB code which returns a generalized Gauss-Laguerre quadrature rule.
gen_laguerre_rule, an Octave code which returns a generalized Gauss-Laguerre quadrature rule.
gene_cluster, a Fortran90 code which clusters sets of genetic expression data;
generalized_assignment, a dataset directory which contains test data for the generalized assignment problem;
geometry, a C code 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++ code 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 code 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 code 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 code 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 code 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 code which carries out certain geometric computations, including the convex hull, the Delaunay triangulation and the Voronoi diagram of a set of points in the plane, by Barry Joe.
geompack, a C++ code which carries out certain geometric computations, including the convex hull, the Delaunay triangulation and the Voronoi diagram of a set of points in the plane, by Barry Joe.
geompack, a Fortran77 code which carries out certain geometric computations, including the convex hull, the Delaunay triangulation and the Voronoi diagram of a set of points in the plane, by Barry Joe.
geompack, a Fortran90 code which carries out certain geometric computations, including the convex hull, the Delaunay triangulation and the Voronoi diagram of a set of points in the plane, by Barry Joe.
geompack, a MATLAB code which carries out certain geometric computations, including the convex hull, the Delaunay triangulation and the Voronoi diagram of a set of points in the plane, by Barry Joe.
geompack, an Octave code which carries out certain geometric computations, including the convex hull, the Delaunay triangulation and the Voronoi diagram of a set of points in the plane, by Barry Joe.
geompack2, a Fortran90 code which computes the Delaunay triangulation of 2D data, by Barry Joe.
geompack3, a Fortran90 code which carries out certain geometric tasks, such as Delaunay triangulation and Voronoi diagrams, in 2D, 3D, and higher dimensions, by Barry Joe.
geompack3_test, a Fortran90 code which carries out certain geometric tasks, such as Delaunay triangulation and Voronoi diagrams, in 2D, 3D, and higher dimensions, by Barry Joe.
geqp3, a Fortran77 code which contains the portion of lapack() that carries out the QR factorization, with column pivoting, of an M by N rectangular matrix, with N <= M.
geqp3, a Fortran90 code which contains the portion of lapack() 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 code which estimates the parameters of a Dirichlet mixture.
gfortran_test, a Fortran77 code which calls gfortran(), which is the Gnu compiler for Fortran.
gfortran_test, a Fortran90 code which calls gfortran(), which is the Gnu compiler for Fortran.
gfortran_intrinsics_test, a Fortran77 code which uses intrinsic functions provided by the Gnu gfortran compiler for Fortran77.
gfortran_intrinsics_test, a Fortran90 code which uses intrinsic functions provided by the Gnu gfortran compiler for Fortran90.
gfortran_quadmath_test, a Fortran77 code which uses real 128 bit arithmetic provided on some systems by the Gnu gfortran compiler for Fortran77.
gfortran_quadmath_test, a Fortran90 code which uses real 128 bit 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;
giniquintile, an R code which computes the Gini quintile.
gcc, examples which use GCC, which is the Gnu Compiler Collection, whose main component is the Gnu C Compiler gcc.
gl_fast_rule, a C code which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.
gl_fast_rule, a C++ code which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.
gl_fast_rule, a Fortran90 code which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.
gl_fast_rule, a MATLAB code which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.
gl_fast_rule, an Octave code which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.
gl_fast_rule, a Python code which carries out the rapid computation of the K-th value and weight of an N-point Gauss-Legendre quadrature rule, by Ignace Bogaert.
glacier, a FENICS code which sets up the 2D steady Stokes equations to model the movement of a glacier, by William Mitchell.
glomin, a C code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin, a C++ code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin, a Fortran77 code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin, a Fortran90 code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin, a MATLAB code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin, an Octave code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin, a Python code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin, an R code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent.
glomin_nogoto, a C code which finds a global minimum of a scalar function of a scalar argument, without the use of derivative information, by Richard Brent. This version, rewritten by Hans Bieshaar, avoids the use of the goto statement.
glycolysis_ode, a MATLAB code which sets up a pair of ordinary differential equations (ODE) that model the biochemical process of glycolysis, for which a limit cycle exists.
glycolysis_ode, an Octave code which sets up a pair of ordinary differential equations (ODE) that model the biochemical process of glycolysis, for which a limit cycle exists.
glycolysis_ode, a Python code which sets up a pair of ordinary differential equations (ODE) that model the biochemical process of glycolysis, for which a limit cycle exists.
gmgsolve, a Python code which applies one step of the V-cycle of the geometric multigrid method, by Mike Sussman.
gmres, a MATLAB code which applies the Generalized Minimum Residual (GMRES) method to solve a nonsymmetric sparse linear system.
gmsh, examples which use gmsh(), a 1D, 2D or 3D mesh generator that creates meshes suitable for use by the finite element method (FEM).
gmsh_io, a C code which reads or writes some of the files created by gmsh() for 1D, 2D or 3D meshes used by the finite element method (FEM).
gmsh_io, a C++ code which reads or writes some of the files created by gmsh() for 1D, 2D or 3D meshes used by the finite element method (FEM).
gmsh_io, a Fortran77 code which reads or writes some of the files created by gmsh() for 1D, 2D or 3D meshes used by the finite element method (FEM).
gmsh_io, a Fortran90 code which reads or writes some of the files created by gmsh() for 1D, 2D or 3D meshes used by the finite element method (FEM).
gmsh_io, a MATLAB code which reads or writes some of the files created by gmsh() for 1D, 2D or 3D meshes used by the finite element method (FEM).
gmsh_to_fem, a C code which reads a mesh data file created by gmsh() and writes a pair of node and element files that correspond to the FEM format.
gmsh_to_fem, a C++ code which reads a mesh data file created by gmsh() and writes a pair of node and element files that correspond to the FEM format.
gmsh_to_fem, a Fortran77 code which reads a mesh data file created by gmsh() and writes a pair of node and element files that correspond to the FEM format.
gmsh_to_fem, a Fortran90 code which reads a mesh data file created by gmsh() and writes a pair of node and element files that correspond to the FEM format.
gmsh_to_fem, a MATLAB code which reads a mesh data file created by gmsh() and writes a pair of node and element files that correspond to the FEM format.
gmsh_to_fem, an Octave code which reads a mesh data file created by gmsh() and writes a pair of node and element files that correspond to the FEM format.
gnufor, a Fortran77 code which provides an interface to gnuplot() graphics.
gnufor, a Fortran90 code which provides an interface to gnuplot() graphics.
gnuplot, examples which illustrate the use of gnuplot() graphics.
gnuplot_contour, a FreeFem++ code which writes data to files that gnuplot() uses to make contour plots.
gnuplot_surface, a FreeFem++ code which solves the steady Laplace equation over a disk, and then writes the mesh and solution to a file so that gnuplot() creates a surface plot.
gnuplot_test, a C code which writes data and command files so that the gnuplot() program plots the results.
gnuplot_test, a C++ code which writes data and command files so that gnuplot() plots the results.
gnuplot, a Fortran77 code which writes data and command files so that gnuplot() plots the results.
gnuplot_test, a Fortran90 code which writes data and command files so that gnuplot() plots the results.
gnuplot_test, a MATLAB code which writes data and command files so that gnuplot() plots the results.
gnuplot_test, an Octave code which writes data and command files so that gnuplot() plots the results.
gnuplot_i, a C code which allows an executing C or C++ program to interact with gnuplot(), by Nicholas Devillard.
gnuplot_i_test, a C code which calls gnuplot_i() to enable interactive runtime gnuplot() graphics.
gnuplot_i_test, a C++ code which calls gnuplot_i() to enable interactive runtime gnuplot() graphics.
goldsectmax, an R code which seeks a maximizer of a function using golden section search.
gpl, a data directory which contains examples of GPL files, a graphics file format used by gnuplot();
gpl_display, a MATLAB code 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.
gpl_display, an Octave code 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, a C code which uses the gprof() performance monitor;
gprof_test, a C++ code which uses the gprof() performance monitor;
gprof_test, a Fortran77 code which uses the gprof() performance monitor;
gprof_test, a Fortran90 code which use the gprof() performance monitor;
gradasc, an R code which seeks a maximizer of a function using gradient ascent.
graddsc, an R code which seeks a minimizer of a function using gradient descent.
gradient_descent, a MATLAB code which uses gradient descent to solve a linear least squares (LLS) problem.
gradient_descent, a Python code which uses gradient descent to solve a linear least squares (LLS) problem.
graffiti, a dataset directory which contains 195 abstract graphs, with adjacency and embedding information, stored in the grf format.
graph_adj, a Fortran90 code which carries out operations on abstract graphs, with undirected edges, represented by an adjacency matrix. Operations include breadth-first search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure.
graph_adj, a MATLAB code which carries out operations on abstract graphs, with undirected edges, represented by an adjacency matrix. Operations include breadth-first search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure.
graph_adj, an Octave code which carries out operations on abstract graphs, with undirected edges, represented by an adjacency matrix. Operations include breadth-first search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure.
graph_adj, a Python code which carries out operations on abstract graphs, with undirected edges, represented by an adjacency matrix. Operations include breadth-first search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure.
graph_class, a Python code which creates classes related to abstract graphs, and uses them to define various algorithms include breadth-first search, depth-first search, and shortest path.
graph_theory, a Fortran90 code which carries out operations on abstract graphs.
gram_polynomial, a MATLAB code which evaluates the Gram polynomials, also known as the discrete Chebyshev polyomials, and associated functions.
gram_polynomial, an Octave code which evaluates the Gram polynomials, also known as the discrete Chebyshev polyomials, and associated functions.
gram_polynomial, a Python code which evaluates the Gram polynomials, also known as the discrete Chebyshev polyomials, and associated functions.
gram_schmidt, a MATLAB code which implements the Gram-Schmidt process to orthogonalize and normalize a set of vectors.
gram_schmidt, an Octave code which implements the Gram-Schmidt process to orthogonalize and normalize a set of vectors.
gram_schmidt, a Python code which implements the Gram-Schmidt process to orthogonalize and normalize a set of vectors.
graph_arc, a Fortran90 code which carries out operations on graphs. Information is stored in an arc list, pairs of nodes forming edges. Operations include the chromatic polynomial, computing degrees, computing the degree sequence, counting the edges, determining edge and node connectivity, Euler circuits, spanning trees, shortest path, printing the arc list, generating fixed and random examples.
graph_dist, a Fortran90 code which carries out operations on abstract graphs, defined by undirected edges with an associated distance matrix.
graph_paper, a Fortran90 code 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 code which expresses the representation of an abstract mathematical graph in several ways.
graph_representation, an Octave code which expresses the representation of an abstract mathematical graph in several ways.
graphics_test, a C code which demonstrates a variety of graphics displays, including bar plots, contour plots, filled polygons, histograms, line plots, scatter plots, surface plots, tree diagrams, vector plots.
graphics_test, a Fortran77 code which demonstrates a variety of graphics displays, including bar plots, contour plots, filled polygons, histograms, line plots, scatter plots, surface plots, tree diagrams, vector plots.
graphics_test, a dataset directory which contains examples of data used to illustrate or test various graphics procedures for presenting and analyzing data.
graphics_test, a Mathematica code which demonstrates techniques for creating a graphic display of a variety of scientific data.
graphics_test, a MATLAB code which demonstrates a variety of graphics displays, including bar plots, contour plots, filled polygons, histograms, line plots, scatter plots, surface plots, tree diagrams, vector plots.
graphics_test, an Octave code which demonstrates a variety of graphics displays, including bar plots, contour plots, filled polygons, histograms, line plots, scatter plots, surface plots, tree diagrams, vector plots.
graphics_test, a Python code which demonstrates a variety of graphics displays, including bar plots, contour plots, filled polygons, histograms, line plots, scatter plots, surface plots, tree diagrams, vector plots.
graphics_test, an R code which demonstrates techniques for creating a graphic display of a variety of scientific data.
graphics_dislin_test, a C code which graphically displays various kinds of data, using dislin().
graphics_dislin_test, a C++ code which graphically displays various kinds of data, using dislin().
graphics_dislin_test, a Fortran90 code which graphically displays various kinds of data, using dislin().
graphics_gnuplot_test, a C code which graphically displays various kinds of data, using the gnuplot() graphics program.
graphics_gnuplot_test, a C++ code which graphically displays various kinds of data, using the gnuplot() graphics program.
graphics_gnuplot_test, a Fortran90 code which graphically displays various kinds of data, using the gnuplot() graphics program.
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 dislin().
graphics_examples_gnuplot, examples which illustrate how various kinds of data can be displayed and analyzed graphically using gnuplot().
graphics_examples_grace, examples which illustrate how various kinds of data can be displayed and analyzed graphically using grace().
graphics_examples_plotly1, examples which illustrate how various kinds of data can be displayed and analyzed graphically, using plotly().
graphviz_test, a Python code which illustrates how the graphviz() code can be used to create plots of mathematical graphs and directed graphs.
gray_code_display, a MATLAB code which computes the Hamming distance tables for both the binary and Gray codes, and displays 3D plots that illustrate how the Gray code does a better job of providing nearby representations for nearby numbers.
gray_scott_movie, a MATLAB code which solves versions of the partial differential equation (PDE) known as the Gray-Scott reaction diffusion equation, converting the solutions to a sequence of graphics frames, which are then assembled into a movie.
gray_scott_pde, a MATLAB code which solves the partial differential equation (PDE) known as the Gray-Scott reaction diffusion equation, in two spatal dimension and time, displaying a sequence of solutions as time progresses.
grazing_ode, a MATLAB code which sets up a pair of ordinary differential equations (ODE) that model the populations of an edible plant, and the herbivore that grazes on it.
grazing_ode, an Octave code which sets up a pair of ordinary differential equations (ODE) that model the populations of an edible plant, and the herbivore that grazes on it.
grazing_ode, a Python code which sets up a pair of ordinary differential equations (ODE) that model the populations of an edible plant, and the herbivore that grazes on it.
grf, a data directory which contains examples of grf files, an abstract graph file format, 2D graphics;
grf_display, a MATLAB code which reads a grf file defining a mathematical graph and displays it.
grf_display_opengl, a C++ code which reads a grf file defining a mathematical graph and displays it in an OpenGL graphics window.
grf_io, a C++ code which reads or writes a grf file which represents a mathematical graph;
grf_io, a Fortran90 code which reads or writes a grf file which represents a mathematical graph;
grf_io, a MATLAB code which reads or writes a grf file which represents a mathematical graph;
grf_io, an Octave code which reads or writes a grf file which represents a mathematical graph;
grf_io, a Python code which reads or writes a grf file which represents a mathematical graph;
grf_to_eps, a Fortran90 code which converts a grf file to Encapsulated PostScript (EPS) format;
grf_to_xyl, a Fortran90 code 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 code which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.
grid, a C++ code which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.
grid, a Fortran90 code which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.
grid, a MATLAB code which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.
grid, a Python code which randomly selects N distinct points from a uniform grid in the unit hypercube in M-dimensional space.
grid_dataset, a MATLAB code which constructs a grid dataset from user instructions.
grid_display, a MATLAB code 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++ code 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 code which gives the user more control over drawing gridlines on a graph than the builtin grid command.
grids_display, a MATLAB code which reads two files of grids or sparse grids, displays the first with hollow blue dots, the second with red dots.
gsl_test, a C code which uses the GNU Scientific Library (GSL), which includes utilities to handle Basis splines, BLAS (Basic Linear Algebra Subprograms), Chebyshev Approximation, Complex numbers, Ordinary Differential Equations (ODE), Discrete Hankel Transforms, Discrete Wavelet Transforms, Eigenvalues and Eigenvectors, Fast Fourier Transforms (FFT), Histograms, IEEE Floating Point Calculations, Interpolation, Least Squares Fitting, Linear Algebra, Minimization, Monte Carlo Integration, N-Tuples, Numerical Differentiation, Permutations, Physical Constants, Quadrature (Numerical Integration), Quasi-Random sequences, Random Distributions, Random Numbers, Root finding of general nonlinear equations, Roots of Polynomials, Running Statistics, Series Acceleration, Simulated Annealing, Sorting, Sparse Matrices, Special Functions, Statistics, Vectors and matrices.
gsl_test, a C++ code which uses the GNU Scientific Library (GSL), which includes utilities to handle Basis splines, BLAS (Basic Linear Algebra Subprograms), Chebyshev Approximation, Complex numbers, Ordinary Differential Equations (ODE), Discrete Hankel Transforms, Discrete Wavelet Transforms, Eigenvalues and Eigenvectors, Fast Fourier Transforms (FFT), Histograms, IEEE Floating Point Calculations, Interpolation, Least Squares Fitting, Linear Algebra, Minimization, Monte Carlo Integration, N-Tuples, Numerical Differentiation, Permutations, Physical Constants, Quadrature (Numerical Integration), Quasi-Random sequences, Random Distributions, Random Numbers, Root finding of general nonlinear equations, Roots of Polynomials, Running Statistics, Series Acceleration, Simulated Annealing, Sorting, Sparse Matrices, Special Functions, Statistics, Vectors and matrices.
gurobi, examples which call gurobi(), which is an mathematical programming package for optimization, solving problems in linear programming, mixed integer programming, and mixed integer quadratic programming.
gurobi_solution_read, a MATLAB code which reads a file created by the optimization package gurobi(), representing the solution of a particular linear programming problem, and writes out a simple ASCII file.
gurobi_solution_read, an Octave code which reads a file created by the optimization package gurobi(), representing the solution of a particular linear programming problem, and writes out a simple ASCII file.
gurobi_solution_read, a Python code which reads a file created by the optimization package gurobi(), representing the solution of a particular linear programming problem, and writes out a simple ASCII file.
gyroscope_ode, a MATLAB code which sets up the ordinary differential equations (ODE) that simulate the angular attitude and rotational speed of a gyroscope.
gyroscope_ode, an Octave code which sets up the ordinary differential equations (ODE) that simulate the angular attitude and rotational speed of a gyroscope.
gyroscope_ode, a Python code which sets up the ordinary differential equations (ODE) that simulate the angular attitude and rotational speed of a gyroscope.
haar_transform, a C code which computes the Haar transform of 1d or 2d data.
haar_transform, a C++ code which computes the Haar transform of 1d or 2d data.
haar_transform, a Fortran77 code which computes the Haar transform of 1d or 2d data.
haar_transform, a Fortran90 code which computes the Haar transform of 1d or 2d data.
haar_transform, a MATLAB code which computes the Haar transform of 1d or 2d data.
haar_transform, an Octave code which computes the Haar transform of 1d or 2d data.
haar_transform, a Python code which computes the Haar transform of 1d or 2d data.
halton, a dataset directory which contains examples of the Halton Quasi Monte Carlo (QMC) sequence;
halton, a C code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
halton, a C++ code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
halton, a Fortran90 code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
halton, a MATLAB code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
halton, an Octave code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
halton, a Python code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
halton_advanced, a C++ code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using an advanced interface with many input options.
halton_advanced, a Fortran90 code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using an advanced interface with many input options.
halton_advanced, a MATLAB code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using an advanced interface with many input options.
halton_dataset, a C++ code which creates a Halton Quasi Monte Carlo (QMC) sequence and writes it to a file.
halton_dataset, a Fortran90 code which creates a Halton Quasi Monte Carlo (QMC) sequence and writes it to a file.
halton_dataset, a MATLAB code 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 code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
hammersley, a C++ code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
hammersley, a Fortran90 code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
hammersley, a MATLAB code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
hammersley, an Octave code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
hammersley, a Python code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
hammersley_advanced, a C++ code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence using an advanced interface with many input options.
hammersley_advanced, a Fortran90 code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence using an advanced interface with many input options.
hammersley_advanced, a MATLAB code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence using an advanced interface with many input options.
hammersley_dataset, a C++ code which creates a Hammersley sequence and writes it to a file.
hammersley_dataset, a Fortran90 code which creates a Hammersley sequence and writes it to a file.
hammersley_dataset, a MATLAB code which creates a Hammersley sequence and writes it to a file.
hamming, a MATLAB code which implements some simple versions of Hamming codes that detect and correct errors in data.
hamming, an Octave code which implements some simple versions of Hamming codes that detect and correct errors in data.
hamming, a Python code which implements some simple versions of Hamming codes that detect and correct errors in data.
hand_area, a MATLAB code which estimates the area of a curve that outlines a hand.
hand_data, a MATLAB code which carries out some numerical exercises based on data that came from tracing several points on a hand.
hand_data, an Octave code which carries out some numerical exercises based on data that came from tracing several points on a hand.
hand_mesh2d, a MATLAB code which reads in points which outline a human hand, and calls mesh2d(), which creates a fine triangular mesh of the region outlined by the points.
hand_mesh2d, an Octave code which reads in points which outline a human hand, and calls mesh2d(), which creates a fine triangular mesh of the region outlined by the points.
handcrafted_classify_svm_rbf, a scikit-learn code which uses the support vector algorithm with RBF kernel on the handcrafted dataset.
hankel_cholesky, a C code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix H so that H = R' * R.
hankel_cholesky, a C++ code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix H so that H = R' * R.
hankel_cholesky, a Fortran90 code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix H so that H = R' * R.
hankel_cholesky, a MATLAB code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix H so that H = R' * R.
hankel_cholesky, a Python code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix H so that H = R' * R.
hankel_inverse, a MATLAB code which computes the inverse of a Hankel matrix.
hankel_inverse, a Python code which computes the inverse of a Hankel matrix.
hankel_spd, a C code which computes a lower triangular matrix L that is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
hankel_spd, a C++ code which computes a lower triangular matrix L that is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
hankel_spd, a Fortran90 code which computes a lower triangular matrix L that is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
hankel_spd, a MATLAB code which computes a lower triangular matrix L that is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
hankel_spd, a Python code which computes a lower triangular matrix L that is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
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 code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
hb_io, a C++ code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
hb_io, a Fortran90 code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
hb_io, a MATLAB code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
hb_io, an Octave code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
hb_io_new, a C++ code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices. This is a version of hb_io that has been revised and improved by Reinhard Resch.
hb_read, a Fortran77 code which reads files in the Harwell Boeing (HB) sparse matrix format; This is a simplified interface intended to handle only the most common format, complex unsymmetric assembled (CUA) or real unsymmetric assembled (RUA).
hb_read, a Fortran90 code which reads files in the Harwell Boeing (HB) sparse matrix format; This is a simplified interface intended to handle only the most common format, complex unsymmetric assembled (CUA) or real unsymmetric assembled (RUA).
hb_to_mm, a MATLAB code which converts a sparse matrix from Harwell Boeing (HB) to Matrix Market (MM) format.
hb_to_mm, an Octave code which converts a sparse matrix from Harwell Boeing (HB) to Matrix Market (MM) format.
hb_to_msm, a MATLAB code which converts a sparse matrix stored in a Harwell Boeing (HB) format to MATLAB sparse matrix (MSM) format;
hb_to_msm, an Octave code which converts a sparse matrix stored in a Harwell Boeing (HB) format to MATLAB sparse matrix (MSM) format;
hb_to_st, a Fortran77 code which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.
hb_to_st, a Fortran90 code which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.
hb_to_st, a MATLAB code which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.
hb_to_st, an Octave code 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 code which solves the time-dependent 2D incompressible Navier Stokes equations (NSE) in an H-shaped region.
hcell_flow_display, a MATLAB code which plots the physical data, pressures or velocities, from a run of hcell();
hcell_steady, a Fortran77 code 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 use hdf5, which is a file format, library, and utility programs for efficiently managing large and complex datasets.
hdf5_test, a C code which uses the hdf5 library and file format.
hdf5_test, a C++ code which uses the hdf5 library and file format.
hdf5_test, a Fortran90 code which uses the hdf5 library and file format.
hdf5_test, a Python code which demonstrates the use of the hdf5 library and file format.
heartbeat_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) describing the beating of the heart, as suggested by Zeeman.
heartbeat_ode, a Python code which sets up and solves an ordinary differential equation (ODE) describing the beating of the heart, as suggested by Zeeman.
heat, a FreeFem++ code which sets up the time-dependent heat equation in 2D with a mixture of Dirichlet and Neumann flux boundary conditions.
heat, an R code which solves the 1D heat equation using the forward time centered space (FTCS) method.
heat_explicit, a FENICS code 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 code 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 code which solves the 1D time dependent heat equation in parallel, using the Message Passing Interface (MPI).
heat_mpi, a C++ code which solves the 1D time dependent heat equation in parallel, using the Message Passing Interface (MPI).
heat_mpi, a Fortran77 code which solves the 1D time dependent heat equation in parallel, using the Message Passing Interface (MPI).
heat_mpi, a Fortran90 code which solves the 1D time dependent heat equation in parallel, using the Message Passing Interface (MPI).
heat_oned, a MATLAB code which solves the time-dependent 1D heat equation, using the finite element method (FEM) in space, and the backward Euler method in time, by Jeff Borggaard.
heat_steady, a FENICS code which sets up the 2D steady heat equation in a rectangle.
heat_transfer, a FreeFem++ code which calculates the temperature distribution in a heated sheet metal disk employing heat transfer and one fixed border temperature, and writes the resulting data to files, using the ffmatlib() interface, for subsequent graphics processing by MATLAB or Octave.
heat_transfer_test, a MATLAB code which plots data from the computation of heat distribution on a metal disk, as computed by FreeFem++() and transferred using ffmatlib().
heat_transfer_test, an Octave code which plots data from the computation of heat distribution on a metal disk, as computed by FreeFem++() and transferred using ffmatlib().
heated_plate, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.
heated_plate_openmp, a C++ code which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.
heated_plate_openmp, a Fortran77 code which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.
heated_plate_openmp, a Fortran90 code which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.
heated_plate_parfor, a MATLAB code which solves the steady (time independent) heat equation in a 2D rectangular region, using the parfor() facility to run in parallel.
heated_plate_workshare, a Fortran90 code which solves the steady (time independent) heat equation in a 2D rectangular region, using the OpenMP 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 BASH code which prints 'Hello, world!'.
hello, a C code which prints 'Hello, world!'.
hello, a C++ code which prints 'Hello, world!'.
hello, a Fortran77 code which prints 'Hello, world!'.
hello, a Fortran90 code which prints 'Hello, world!'.
hello, a Julia code which prints 'Hello, world!'.
hello, a keras code which prints 'Hello, world!'.
hello, a MATLAB code which prints 'Hello, world!'.
hello, an Octave code which prints 'Hello, world!'.
hello, a Python code which prints 'Hello, world!'.
hello, an R code which prints 'Hello, world!'.
hello_mpi, a C code which prints 'Hello, world!' using the Message Passing Interface (MPI) for parallel execution.
hello_mpi, a C++ code which prints 'Hello, world!' using the Message Passing Interface (MPI) for parallel execution.
hello_mpi, a Fortran77 code which prints 'Hello, world!' using the Message Passing Interface (MPI) for parallel execution.
hello_mpi, a Fortran90 code which prints 'Hello, world!' using the Message Passing Interface (MPI) for parallel execution.
hello_mpi, a Python code which prints 'Hello, world!' using the Message Passing Interface (MPI) for parallel execution, under MPI4PY.
hello_openmp, a C code which prints 'Hello, world!', using OpenMP for parallel execution.
hello_openmp, a C++ code which prints 'Hello, world!', using OpenMP for parallel execution.
hello_openmp, a Fortran77 code which prints 'Hello, world!', using OpenMP for parallel execution.
hello_openmp, a Fortran90 code which prints 'Hello, world!', using OpenMP for parallel execution.
hello_parfor, a MATLAB code which prints 'Hello, world!' multiple times, using the parfor() command for parallel execution.
helmholtz_exact, a MATLAB code which evaluates an exact formula for the solution of the Helmholtz equation, a sort of eigenvalue equation that can arise after separation of variables is a applied to the wave equation. This example considers a problem in which Z(x,y) represents the vertical deflection of the surface of a vibrating circular membrane such as a drumhead.
helmholtz_exact, an Octave code which evaluates an exact formula for the solution of the Helmholtz equation, a sort of eigenvalue equation that can arise after separation of variables is a applied to the wave equation. This example considers a problem in which Z(x,y) represents the vertical deflection of the surface of a vibrating circular membrane such as a drumhead.
helmholtz_exact, a Python code which evaluates an exact formula for the solution of the Helmholtz equation, a sort of eigenvalue equation that can arise after separation of variables is a applied to the wave equation. This example considers a problem in which Z(x,y) represents the vertical deflection of the surface of a vibrating circular membrane such as a drumhead.
henon_heiles_ode, a MATLAB code which sets up the Henon-Heiles system of ordinary differential equations (ODE) which model the motion of a star around the galactic center.
henon_heiles_ode, an Octave code which sets up the Henon-Heiles system of ordinary differential equations (ODE) which model the motion of a star around the galactic center.
henon_heiles_ode, a Python code which sets up the Henon-Heiles system of ordinary differential equations (ODE) which model the motion of a star around the galactic center.
henon_orbit, a MATLAB code which computes the orbit of the Henon map for various sets of initial data.
henon_orbit, an Octave code which computes the orbit of the Henon map for various sets of initial data.
henon_orbit, a Python code which computes the orbit of the Henon map for various sets of initial data.
here_document, a bash code which creates and uses here documents, little helper text files created on the fly by a script.
hermite_cubic, a C code which computes the value, derivatives or integral of a hermite cubic polynomial, or manipulates an interpolating function made up of piecewise Hermite (PWH) cubic polynomials.
hermite_cubic, a C++ code which computes the value, derivatives or integral of a hermite cubic polynomial, or manipulates an interpolating function made up of piecewise Hermite (PWH) cubic polynomials.
hermite_cubic, a Fortran77 code which computes the value, derivatives or integral of a hermite cubic polynomial, or manipulates an interpolating function made up of piecewise Hermite (PWH) cubic polynomials.
hermite_cubic, a Fortran90 code which computes the value, derivatives or integral of a hermite cubic polynomial, or manipulates an interpolating function made up of piecewise Hermite (PWH) cubic polynomials.
hermite_cubic, a MATLAB code which computes the value, derivatives or integral of a hermite cubic polynomial, or manipulates an interpolating function made up of piecewise Hermite (PWH) cubic polynomials.
hermite_exactness, a C code which tests the 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++ code which tests the 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 code which tests the 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 code which tests the 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 code which tests the 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, an Octave code which tests the 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 Python code which tests the 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_integrands, a C code which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).
hermite_integrands, a C++ code which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).
hermite_integrands, a Fortran77 code which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).
hermite_integrands, a Fortran90 code which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).
hermite_integrands, a MATLAB code which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).
hermite_integrands, an Octave code which defines test integrands for Hermite integrals with interval (-oo,+oo) and density exp(-x^2).
hermite_interpolant, a C code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
hermite_interpolant, a C++ code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
hermite_interpolant, a Fortran77 code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
hermite_interpolant, a Fortran90 code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
hermite_interpolant, a MATLAB code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
hermite_polynomial, a C code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
hermite_polynomial, a C++ code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
hermite_polynomial, a Fortran77 code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
hermite_polynomial, a Fortran90 code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
hermite_polynomial, a MATLAB code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
hermite_polynomial, an Octave code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
hermite_polynomial, a Python code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
hermite_product_display, a MATLAB code 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 code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
hermite_product_polynomial_test
hermite_product_polynomial, a C++ code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
hermite_product_polynomial_test
hermite_product_polynomial, a Fortran77 code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
hermite_product_polynomial_test
hermite_product_polynomial, a Fortran90 code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
hermite_product_polynomial_test
hermite_product_polynomial, a MATLAB code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
hermite_product_polynomial_test
hermite_product_polynomial, an Octave code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
hermite_product_polynomial_test
hermite_rule, a C code which returns 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++ code which returns 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 code which returns 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 code which returns 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 code which returns a Gauss-Hermite quadrature rule for estimating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
hermite_rule, an Octave code which returns 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 Python code which returns a Gauss-Hermite quadrature rule for estimating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
hex_grid_angle a Fortran90 code 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 a Fortran90 code which allows the user to interactively create a dataset of points on a hexagonal grid.
hex_grid_triangulate a Fortran90 code which picks out those points on a hex grid which lie inside a given triangulation region.
hexagon_integrals, a MATLAB code which returns the exact value of the integral of a monomial over the interior of a hexagon in 2D.
hexagon_integrals, an Octave code which returns the exact value of the integral of a monomial over the interior of a hexagon in 2D.
hexagon_integrals, a Python code which returns the exact value of the integral of a monomial over the interior of a hexagon in 2D.
hexagon_lyness_rule, a MATLAB code which computes one of 13 Lyness quadrature rules over the interior of the unit hexagon.
hexagon_lyness_rule, an Octave code which computes one of 13 Lyness quadrature rules over the interior of the unit hexagon.
hexagon_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of a hexagon in 2D;
hexagon_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of a hexagon in 2D;
hexagon_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of a hexagon in 2D;
hexagon_stroud_rule, a MATLAB code which returns one of four Stroud quadrature rules over the interior of the unit hexagon.
hexagon_stroud_rule, an Octave code which returns one of four Stroud quadrature rules over the interior of the unit hexagon.
hexagon_stroud_rule, a Python code which returns one of four Stroud quadrature rules over the interior of the unit hexagon.
hexahedron_jaskowiec_rule, a C code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
hexahedron_jaskowiec_rule_test
hexahedron_jaskowiec_rule, a C++ code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
hexahedron_jaskowiec_rule_test
hexahedron_jaskowiec_rule, a Fortran90 code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
hexahedron_jaskowiec_rule_test
hexahedron_jaskowiec_rule, a MATLAB code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
hexahedron_jaskowiec_rule_test
hexahedron_jaskowiec_rule, an Octave code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
hexahedron_jaskowiec_rule_test
hexahedron_jaskowiec_rule, a Python code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
hexahedron_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
hexahedron_witherden_rule_test
hexahedron_witherden_rule, a C++ code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
hexahedron_witherden_rule_test
hexahedron_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
hexahedron_witherden_rule_test
hexahedron_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
hexahedron_witherden_rule_test
hexahedron_witherden_rule, an Octaved code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
hexahedron_witherden_rule_test
hexahedron_witherden_rule, a Python code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
hexdump, a C++ code which produces a hexadecimal dump of a file;
high_card_parfor, a MATLAB code 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 code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; using gnuplot() for graphics.
high_card_simulation, a C++ code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; using gnuplot() for graphics.
high_card_simulation, a Fortran77 code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; using gnuplot() for graphics.
high_card_simulation, a Fortran90 code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; using gnuplot() for graphics.
high_card_simulation, a MATLAB code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop.
high_card_simulation, an Octave code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop.
high_card_simulation, a Python code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop.
hilbert_curve, a C code which computes the sequence of discrete 2D Hilbert curves whose limit is a space-filling curve.
hilbert_curve, a C++ code which computes the sequence of discrete 2D Hilbert curves whose limit is a space-filling curve.
hilbert_curve, a Fortran90 code which computes the sequence of discrete 2D Hilbert curves whose limit is a space-filling curve.
hilbert_curve, a MATLAB code which computes the sequence of discrete 2D Hilbert curves whose limit is a space-filling curve.
hilbert_curve, an Octave code which computes the sequence of discrete 2D Hilbert curves whose limit is a space-filling curve.
hilbert_curve, a Python code which computes the sequence of discrete 2D Hilbert curves whose limit is a space-filling curve.
hilbert_curve_3d, a MATLAB code which converts 3D Hilbert curve data between spatial coordinates of a lattice point (x,y,z) and the linear coordinate H which describes the ordering of that point on the curve.
hilbert_curve_3d, an Octave code which converts 3D Hilbert curve data between spatial coordinates of a lattice point (x,y,z) and the linear coordinate H which describes the ordering of that point on the curve.
hilbert_curve_3d, a Python code which converts 3D Hilbert curve data between spatial coordinates of a lattice point (x,y,z) and the linear coordinate H which describes the ordering of that point on the curve.
hilbert_curve_display, a MATLAB code which displays a 2D Hilbert curve of given order.
hilbert_curve_display, an Octave code which displays a Hilbert curve of given order.
hillclimbing, an R code which seeks a miminizer of a function using the hill climbing method.
histogram_data_2d_sample, a C code 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++ code 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.
GGhistogram_data_2d_sample, a Fortran77 code 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 code 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 code 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, an Octave code 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 code which tries to make a histogram of data without using bins.
histogram_discrete, an Octave code which tries to make a histogram of data without using bins.
histogram_display, a MATLAB code which makes a bar plot 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, an Octave code which creates a histogram plot of a set of data, normalized to estimate the probability density function (PDF).
histogram_pdf_sample, a MATLAB code which demonstrates sampling 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 code 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 (PWC) function, constructing a histogram for the CDF, and then sampling.
histogram_pdf_2d_sample, an Octave code 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 (PWC) function, constructing a histogram for the CDF, and then sampling.
histogramize, a MATLAB code which takes a vector of data and organizes it into a histogram of a given number of bins with given width and range, which can be displayed as a bar chart.
histogramize, an Octave code 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.
hits, a MATLAB code which uses the HITS algorithm to assign authority and hub indices to nodes in a directed network.
hits, an Octave code which uses the HITS algorithm to assign authority and hub indices to nodes in a directed network.
hits, a Python code which uses the HITS algorithm to assign authority and hub indices to nodes in a directed network.
horner, an R code which evaluates a polynomial using the Horner method.
hot_pipe, a MATLAB code 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 code 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.
hourly_wages, a keras code which uses a neural network to create a multivariable regression model from hourly wage data.
house, a MATLAB code which includes a line segment outline of a house, and some programs to show how linear transformations affect the shape, by Cleve Moler.
house, an Octave code which includes a line segment outline of a house, and some programs to show how linear transformations affect the shape, by Cleve Moler.
housing_data_fetch, a scikit-learn code which fetches a housing dataset from GitHub and stores it locally.
hpl, examples which use HPL, which is the High Performance linpack benchmark.
html_mistake, an HTML code which illustrates some simple but devious programming mistakes in HTML.
htmlindex, a C++ code 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.
human_data, a MATLAB code which starts with an image of simple outline of a human body, tabulates a sequence of points on the outline, creating numerical data defining the boundary. It is then able to fill the region with mesh points and triangulate the region. This allows the region to be analyzed by the finite element method (FEM).
human_data, an Octave code which starts with an image of simple outline of a human body, tabulates a sequence of points on the outline, creating numerical data defining the boundary. It is then able to fill the region with mesh points and triangulate the region. This allows the region to be analyzed by the finite element method (FEM).
hump, a Python code which defines the data for a simple ice sheet experiment called hump, and writes that data to a netcdf() file, to be used as input by a solver.
humps, a C code which evaluates the humps() function, its first and second derivatives, and its antiderivative.
humps, a C++ code which evaluates the humps() function, its first and second derivatives, and its antiderivative.
humps, a Fortran90 code which evaluates the humps() function, its first and second derivatives, and its antiderivative.
humps, a MATLAB code which evaluates the humps() function, its first and second derivatives, and its antiderivative.
humps, an Octave code which evaluates the humps() function, its first and second derivatives, and its antiderivative.
humps, a Python code which evaluates the humps() function, its first and second derivatives, and its antiderivative.
humps_ode, a MATLAB code which sets up an ordinary differential equation (ODE) whose solution is the humps() function.
humps_ode, an Octave code which sets up an ordinary differential equation (ODE) whose solution is the humps() function.
humps_ode, a Python code which sets up an ordinary differential equation (ODE) whose solution is the humps() function.
hyper_2f1, a C code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real parameters a, b, c, and argument x, based on the Gnu Scientific Library function gsl_sf_hyperg_2F1().
hyper_2f1, a C++ code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real or complex parameters a, b, c, and argument x, by N. Michel and M. Stoitsov.
hyper_2f1, a Fortran77 code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real parameters a, b, c, and real or complex argument x, by Shanjie Zhang, Jianming Jin;
hyper_2f1, a Fortran90 code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real or complex parameters a, b, c, and argument x, by N. Michel and M. Stoitsov.
hyper_2f1, a MATLAB code which evaluates the hypergeometric function 2F1(a,b,c;x) for real parameters a, b, c, and real or complex argument x. For convenience, this function is simply a wrapper for the corresponding built-in generalized hypergeometric function hypergeom().
hyper_2f1, an Octave code which evaluates the hypergeometric function 2F1(a,b,c;x) for real parameters a, b, c and argument x. This function is simply a wrapper for the Gnu Scientific Library function gsl_sf_hyperg_2F1().
hyper_2f1, a Python code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real or complex argument x. For convenience, this function is simply a wrapper for the corresponding function in the scipy.special() library.
hyperball_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit hyperball in M dimensions.
hyperball_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit hyperball in M dimensions.
hyperball_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit hyperball in M dimensions.
hyperball_integrals, a C code 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++ code 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 code 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 code 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 code which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.
hyperball_integrals, an Octave code 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 code 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 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
hyperball_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
hyperball_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
hyperball_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
hyperball_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
hyperball_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
hyperball_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
hyperball_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit positive hyperball in M dimensions.
hyperball_positive_distance_test
hyperball_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit positive hyperball in M dimensions.
hyperball_positive_distance_test
hyperball_positive_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit positive hyperball in M dimensions.
hyperball_volume_monte_carlo, a C code which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;
hyperball_volume_monte_carlo_test
hyperball_volume_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;
hyperball_volume_monte_carlo_test
hyperball_volume_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;
hyperball_volume_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;
hyperball_volume_monte_carlo_test
hyperball_volume_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the volume of the unit hyperball in M dimensions;
hyperball_volume_quad, a Fortran90 code which applies a quadrature rule to estimate the volume of the unit hyperball in M dimensions;
hypercube_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected in the M-dimensional unit hypercube.
hypercube_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected in the M-dimensional unit hypercube.
hypercube_distance, a Python code which estimates the expected value of the distance between a pair of points randomly selected in the M-dimensional unit hypercube.
hypercube_exactness, a C code which measures the exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.
hypercube_exactness, a C++ code which measures the exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.
hypercube_exactness, a Fortran77 code which measures the exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.
hypercube_exactness, a Fortran90 code which measures the exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.
hypercube_exactness, a MATLAB code which measures the exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.
hypercube_exactness, an Octave code which measures the exactness of an M-dimensional quadrature rule over the interior of the unit hypercube in M dimensions.
hypercube_grid, a C code which computes a grid of points over the interior of a hypercube in M dimensions.
hypercube_grid, a C++ code which computes a grid of points over the interior of a hypercube in M dimensions.
hypercube_grid, a Fortran77 code which computes a grid of points over the interior of a hypercube in M dimensions.
hypercube_grid, a Fortran90 code which computes a grid of points over the interior of a hypercube in M dimensions.
hypercube_grid, a MATLAB code which computes a grid of points over the interior of a hypercube in M dimensions.
hypercube_grid, an Octave code which computes a grid of points over the interior of a hypercube in M dimensions.
hypercube_grid, a Python code which computes a grid of points over the interior of a hypercube in M dimensions.
hypercube_integrals, a C code 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++ code 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 code 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 code 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 code which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.
hypercube_integrals, an Octave code 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 code 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 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.
hypercube_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.
hypercube_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;
hypercube_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;
hypercube_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;
hypercube_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;
hypercube_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions;
hypercube_surface_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit hypercube in D dimensions.
hypercube_surface_distance_test
hypercube_surface_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit hypercube in D dimensions.
hypercube_surface_distance_test
hypercube_surface_distance, a Python code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit hypercube in D dimensions.
hypergeom_test, a MATLAB code which calls hypergeom(), which is a built-in function which evaluates the generalized hypergeometric functions pFq(z), for integer p and q.
hypergeometric, a Fortran90 code which evaluates the generalized hypergeometric functions pFq, for integer p and q, for complex arguments of large magnitude, by Warren Perger, Atul Bhalla, and Mark Nardin.
hypersphere, a C code which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
hypersphere, a C++ code which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
hypersphere, a Fortran77 code which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
hypersphere, a Fortran90 code which carries out various operations for an M-dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
hypersphere, a MATLAB code which carries out various operations for a D-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, an Octave code which carries out various operations for a D-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, a Python code which carries out various operations for a D-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_angle, a MATLAB code which considers the problem of describing the typical value of the angle between a pair of points randomly selected on the unit hypersphere in M dimensions. Since by symmetry, this will be zero, we instead look at the average of the absolute value of the dot product, and the corresponding angle. In dimension 1, we have average dot product of 1, and angle 0. As the dimension increases, the average dot product rapidly decreases to 0, while the average angle goes to 90 degrees.
hypersphere_angle, an Octave code which considers the problem of describing the typical value of the angle between a pair of points randomly selected on the unit hypersphere in M dimensions. Since by symmetry, this will be zero, we instead look at the average of the absolute value of the dot product, and the corresponding angle. In dimension 1, we have average dot product of 1, and angle 0. As the dimension increases, the average dot product rapidly decreases to 0, while the average angle goes to 90 degrees.
hypersphere_angle, a Python code which considers the problem of describing the typical value of the angle between a pair of points randomly selected on the unit hypersphere in M dimensions. Since by symmetry, this will be zero, we instead look at the average of the absolute value of the dot product, and the corresponding angle. In dimension 1, we have average dot product of 1, and angle 0. As the dimension increases, the average dot product rapidly decreases to 0, while the average angle goes to 90 degrees.
hypersphere_angle_distance, a Python code which considers the problem of describing the typical value of the angle between a pair of points randomly selected on the unit hypersphere in M dimensions. Since by symmetry, this will be zero, we instead look at the average of the absolute value of the dot product, and the corresponding angle. In dimension 1, we have average dot product of 1, and angle 0. As the dimension increases, the average dot product rapidly decreases to 0, while the average angle goes to 90 degrees.
hypersphere_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the unit hypersphere in M dimensions.
hypersphere_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the unit hypersphere in M dimensions.
hypersphere_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected on the unit hypersphere in M dimensions.
hypersphere_integrals, a C code 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++ code 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 code 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 code 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 code which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.
hypersphere_integrals, an Octave code 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 code 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 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
hypersphere_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
hypersphere_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
hypersphere_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
hypersphere_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
hypersphere_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
hypersphere_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
hypersphere_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the unit positive hypersphere in M dimensions.
hypersphere_positive_distance_test
hypersphere_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the unit positive hypersphere in M dimensions.
hypersphere_positive_distance_test
hypersphere_positive_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected on the unit positive hypersphere in M dimensions.
hypersphere_surface, a MATLAB code which estimates the location of a hypersurface defined by a characteristic function or a signed function.
i2_binary_to_ascii, a C++ code which converts a file of short int (I2) data from binary to ASCII format.
i4lib, a C code which contains many utility routines, using integer 32 bit arithmetic.
i4lib, a C++ code which contains many utility routines, using integer 32 bit arithmetic.
i4lib, a Fortran77 code which contains many utility routines, using integer 32 bit arithmetic.
i4lib, a Fortran90 code which contains many utility routines, using integer 32 bit arithmetic.
i4lib, a MATLAB code which contains many utility routines, using integer 32 bit arithmetic.
i4lib, an Octave code which contains many utility routines, using integer 32 bit arithmetic.
i4lib, a Python code which contains many utility routines, using integer 32 bit arithmetic.
i4mat_rref2, a MATLAB code which computes a version of the reduced row echelon form (RREF) of an integer matrix.
i4mat_rref2, an Octave code which computes a version of the reduced row echelon form (RREF) of an integer matrix.
i8lib, a C code which contains many utility routines, using integer 64 bit arithmetic.
i8lib, a C++ code which contains many utility routines, using integer 64 bit arithmetic.
i8lib, a Fortran77 code which contains many utility routines, using integer 64 bit arithmetic.
i8lib, a Fortran90 code which contains many utility routines, using integer 64 bit arithmetic.
ice, a data directory which contains examples of ICE files, which define a netcdf() file format for icesheet grids.
ice_io, a C code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
ice_io, a C++ code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
ice_io, a Fortran90 code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
ice_io, a MATLAB code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
ice_to_medit, a C code which reads a netcdf() file containing an ICE dataset and rewrites the information as a medit() MESH file.
ice_to_medit, a C++ code which reads a netcdf file containing an ICE dataset and rewrites the information as a medit() MESH file.
ice_to_medit, a Fortran90 code which reads a netcdf() file containing an ICE dataset and rewrites the information as a medit() MESH file.
ice_to_medit, a MATLAB code which reads a netcdf() file containing an ICE dataset and rewrites the information as a medit() MESH file.
ieee_uniform_sample, a Fortran90 code which tries to uniformly sample the discrete set of values that represent the legal IEEE real numbers;
ifiss, examples which use ifiss(), which models 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 code which embodies the ifiss() software that models 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++ code which computes an Improved Hypercube Sampling (ihs) Quasi Monte Carlo (QMC) sequence;
ihs, a Fortran90 code which computes an Improved Hypercube Sampling (ihs) Quasi Monte Carlo (QMC) sequence;
ihs, a MATLAB code which computes an Improved Hypercube Sampling (ihs) Quasi Monte Carlo (QMC) sequence;
ihs_dataset, a C++ code which creates an Improved Hypercube Sampling (ihs) dataset and writes it to a file.
ihs_dataset, a Fortran90 code which creates an Improved Hypercube Sampling (ihs) dataset and writes it to a file.
ihs_dataset, a MATLAB code which creates an Improved Hypercube Sampling (ihs) dataset and writes it to a file.
ill_bvp, a MATLAB code which defines an ill conditioned boundary value problem (BVP_, and calls on bvp4c() to solve it with various values of the conditioning parameter.
ill_bvp, a Python code which defines an ill conditioned boundary value problem (BVP), and calls on scipy.integrate.solve_bvp() to solve it with various values of the conditioning parameter.
image_boundary, a MATLAB code which reports the pixels which form the boundary between the black and white regions of a simple image.
image_boundary, an Octave code which reports the pixels which form the boundary between the black and white regions of a simple image.
image_contrast, a MATLAB code which applies image processing techniques to increase the contrast in an image.
image_contrast, an Octave code which applies image processing techniques to increase the contrast in an image.
image_decimate, a MATLAB code which compresses an image by dropping the even rows and columns of data.
image_decimate, an Octave code which compresses an image by dropping the even rows and columns of data.
image_denoise, a C code which applies simple filtering techniques to remove noise from an image.
image_denoise, a C++ code which applies simple filtering techniques to remove noise from an image.
image_denoise, a Fortran77 code which applies simple filtering techniques to remove noise from an image.
image_denoise, a Fortran90 code which applies simple filtering techniques to remove noise from an image.
image_denoise, a MATLAB code which applies simple filtering techniques to remove noise from an image.
image_denoise, an Octave code which applies simple filtering techniques to remove noise from an image.
image_denoise_openmp, a C code which applies simple filtering techniques to remove noise from an image, carrying out the operation in parallel using OpenMP.
image_denoise_spmd, a MATLAB code 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 code which uses diffusion to smooth out an image.
image_diffuse, an Octave code which uses diffusion to smooth out an image.
image_double, a MATLAB code which doubles the height and width of an image by repeating each row and column.
image_double, an Octave code which doubles the height and width of an image by repeating each row and column.
image_edge, a C code which detects edges in images.
image_edge, a C++ code which detects edges in images.
image_edge, a Fortran77 code which detects edges in images.
image_edge, a Fortran90 code which detects edges in images.
image_edge, a MATLAB code which detects edges in images.
image_edge, an Octave code which detects edges in images.
image_edge, a Python code which detects edges in images.
image_match_genetic, a MATLAB code 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_mesh, a MATLAB code which starts with a list of points that bound some region, and calls mesh2d() to create a mesh of the interior.
image_mesh, an Octave code which starts with a list of points that bound some region, and calls mesh2d() to create a mesh of the interior.
image_noise, a MATLAB code which adds noise to an image.
image_noise, an Octave code which adds noise to an image.
image_normalize, a MATLAB code which reads image data from a file, converts it (if necessary) to grayscale, resizes it to H pixels by W pixels.
image_normalize, an Octave code which reads image data from a file, converts it (if necessary) to grayscale, resizes it to H pixels by W pixels.
image_quantization, a MATLAB code which demonstrates how the kmeans() algorithm reduces the number of colors or shades of gray in an image.
image_quantization, an Octave code which demonstrates how the kmeans() algorithm reduces the number of colors or shades of gray in an image.
image_rgb_to_gray, a MATLAB code which makes a grayscale version of an RGB image.
image_rgb_to_gray, an Octave code which makes a grayscale version of an RGB image.
image_rgb_to_gray, a Python code which makes a grayscale version of an RGB image.
image_sample, a MATLAB code which allows the user to specify an image file to be displayed. The user may then use the mouse to select points on the image. The coordinates of each point are saved to a file. Selection ends with a double click. An example is supplied, which outlines the boundary of an aneurysm.
image_sample, an Octave code which allows the user to specify an image file to be displayed. The user may then use the mouse to select points on the image. The coordinates of each point are saved to a file. Selection ends with a RETURN. An example is supplied, which outlines the boundary of an aneurysm.
image_threshold, a MATLAB code which makes a black and white version of a grayscale image by setting all pixels below or above a threshold value to black or white.
image_threshold, an Octave code which makes 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 imagej().
imagemagick, examples which use IMAGEMAGICK, which creates, edits, composes or converts 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.
imdb, a keras code which sets up a neural network to classify movie reviews as positive or negative. This is similar to the movie_review script, but is designed to be run on a remote computing node which does not have internet access at run time.
imdb_dataset_load, a keras code which downloads a copy of the IMDB dataset and place it in the default location it that has not already been done.
imdb_decode, a keras code which shows how to decode an IMDB dataset movie review.
imshow_numeric, a MATLAB code which accepts a numeric 2D array and displays it as a grayscale image.
imshow_numeric, an Octave code which accepts a numeric 2D array and displays it as a grayscale image.
incidence, a dataset directory which contains incidence matrices associated with a directed graph.
include_files, a Fortran90 code which reads a Fortran file with INCLUDE statements, and makes a copy in which the indicated files have been included;
index, a C code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one based indexing schemes, as well as column major and row major conventions.
index, a C++ code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one based indexing schemes, as well as column major and row major conventions.
index, a Fortran77 code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one-based indexing schemes, as well as column major and row major conventions.
index, a Fortran90 code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one-based indexing schemes, as well as column major and row major conventions.
index, a MATLAB code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one based indexing schemes, as well as column major and row major conventions.
index, an Octave code which converts an M-dimensional vector index to a one-dimensional vector index; it handles zero and one based indexing schemes, as well as column major and row major conventions.
inout, a Fortran77 code which computes the pressure and velocity for a flow governed by the time-dependent Navier Stokes Equations (NSE) in a square 1D region with an inlet and an outlet, by Hyung-Chun Lee.
inout_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 code which displays a single velocity field solution for the inout flow;
inout_flow_movie, a MATLAB code 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;
insurance_simulation, a MATLAB code which simulates a highly simplified model of term life insurance, in which a customer agrees to pay an annual fee for a given number of years, so that if the customer dies within that term, the family receives a large payout.
insurance_simulation, an Octave code which simulates a highly simplified model of term life insurance, in which a customer agrees to pay an annual fee for a given number of years, so that if the customer dies within that term, the family receives a large payout.
insurance_simulation, a Python code which simulates a highly simplified model of term life insurance, in which a customer agrees to pay an annual fee for a given number of years, so that if the customer dies within that term, the family receives a large payout.
integral_test, a Fortran90 code which tests the suitability 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 code which parameterizes and interpolates data;
interp, a C++ code which parameterizes and interpolates data;
interp, a Fortran77 code which parameterizes and interpolates data;
interp, a Fortran90 code which parameterizes and interpolates data;
interp, a MATLAB code which parameterizes and interpolates data;
interp_chebyshev, a MATLAB code which interactively uses n Chebyshev spaced nodes in the interval [a,b] to interpolate a function f(x) with a polynomial.
interp_chebyshev, an Octave code which interactively uses n Chebyshev spaced nodes in the interval [a,b] to interpolate a function f(x) with a polynomial.
interp_equal, a MATLAB code which interactively uses n equally spaced nodes in the interval [a,b] to interpolate a function f(x) with a polynomial.
interp_equal, an Octave code which interactively uses n equally spaced nodes in the interval [a,b] to interpolate a function f(x) with a polynomial.
interp_ncs, a MATLAB code which interactively constructs a natural cubic spline (NCS) interpolant to a function f(x), using the 'zero second derivative' end condition.
interp_ncs, an Octave code which interactively constructs a natural cubic spline (NCS) interpolant to a function f(x), using the 'zero second derivative' end condition.
interp_spline, a MATLAB code which interactively constructs a cubic spline interpolant to a function f(x), using the 'not-a-knot' end condition.
interp_spline, an Octave code which interactively constructs a cubic spline interpolant to a function f(x), using the 'not-a-knot' end condition.
interp_spline_data, a MATLAB code which interactively constructs a cubic spline interpolant to (x,y) data, using the 'not-a-knot' end condition.
interp_spline_data, an Octave code which interactively constructs a cubic spline interpolant to (x,y) data, using the 'not-a-knot' end condition.
interp_trig, a MATLAB code which interactively uses n equally spaced nodes in the interval [a,b] to interpolate a function f(x) with a trigonometric polynomial.
interp_trig, an Octave code which interactively uses n equally spaced nodes in the interval [a,b] to interpolate a function f(x) with a trigonometric polynomial.
interpolant, a FENICS code which shows how to define a function by supplying a mesh and the function values at the nodes of that mesh, from which the finite element method (FEM) is used to construct an interpolant of the data.
interpolation, a dataset directory which contains datasets to be interpolated.
intlib, a Fortran90 code which estimates the integral of a function over a one-dimensional interval.
io_test, a FreeFem++ code which shows how a FreeFem++() code can move information from or to a file.
iplot, a MATLAB code which interactively plots a function f(x) over a domain a ≤ x ≤ b;
iplot, an Octave code which interactively plots a function f(x) over a domain a ≤ x ≤ b;
ipython examples which use IPYTHON, which is a command shell for interactive computing, originally created as an enhanced shell for Python;
iris_classify_gradboost, a scikit-learn code which uses the gradient boost algorithm to classify the iris dataset, and then determines the prediction uncertainties.
iris_classify_knn, a scikit-learn code which uses the k-nearest neighbor algorithm to classify the species of iris specimens based on sepal and petal measurements.
is, a C code which is 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.
is_gaussian_prime, a MATLAB code which is true if a given complex number c is a Gaussian prime.
is_gaussian_prime, an Octave code which is true if a given complex number c is a Gaussian prime.
is_gaussian_prime, a Python code which is true if a given complex number c is a Gaussian prime.
is_prime, a C code which is true if a given integer n is prime.
is_prime, a C++ code which is true if a given integer n is prime.
is_prime, a Fortran90 code which is true if a given integer n is prime.
is_prime, a MATLAB code which is true if a given integer n is prime.
is_prime, an Octave code which is true if a given integer n is prime.
is_prime, a Python code which is true if a given integer n is prime.
is_prime, an R code which is true if a given integer n is prime.
isbn, a C code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
isbn, a C++ code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
isbn, a Fortran90 code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
isbn, a MATLAB code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
isbn, an Octave code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
isbn, a Python code which determines the check digit for an International Standard Book Number (ISBN) or reports whether a given ISBN is valid.
ising_2d_simulation, a C code 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++ code 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 code 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 code 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 code 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_2d_simulation, an Octave code 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_2d_simulation, a Python code 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 code 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++ code which converts graphics information between various 3D formats.
ivread, a Fortran90 code which converts graphics information between various 3D formats.
jacobi, a C code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi, a C++ code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi, a Fortran77 code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi, a Fortran90 code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi, a MATLAB code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi, an Octave code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi, a Python code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi, an R code which uses the Jacobi iteration to solving a system of linear equations with a symmetric positive definite (SPD) matrix.
jacobi_eigenvalue, a C code which implements the Jacobi iteration for the eigenvalues and eigenvectors of a real symmetric matrix.
jacobi_eigenvalue, a C++ code which implements the Jacobi iteration for the eigenvalues and eigenvectors of a real symmetric matrix.
jacobi_eigenvalue, a Fortran77 code which implements the Jacobi iteration for the eigenvalues and eigenvectors of a real symmetric matrix.
jacobi_eigenvalue, a Fortran90 code which implements the Jacobi iteration for the eigenvalues and eigenvectors of a real symmetric matrix.
jacobi_eigenvalue, a MATLAB code which implements the Jacobi iteration for the eigenvalues and eigenvectors of a real symmetric matrix.
jacobi_eigenvalue, an Octave code which implements the Jacobi iteration for the eigenvalues and eigenvectors of a real symmetric matrix.
jacobi_eigenvalue, a Python code which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.
jacobi_exactness, a C++ code which tests the exactness of quadrature rules for integrals that include a Jacobi weight.
jacobi_exactness, a Fortran90 code which tests the exactness of quadrature rules for integrals that include a Jacobi weight.
jacobi_exactness, a MATLAB code which tests the exactness of quadrature rules for integrals that include a Jacobi weight.
jacobi_exactness, an Octave code which tests the exactness of quadrature rules for integrals that include a Jacobi weight.
jacobi_exactness, a Python code which tests the exactness of quadrature rules for integrals that include a Jacobi weight.
jacobi_openmp, a C code which uses OpenMP to parallelize a Jacobi iteration for solving A*x=b.
jacobi_openmp, a C++ code which uses OpenMP to parallelize a Jacobi iteration for solving A*x=b.
jacobi_openmp, a Fortran90 code which uses OpenMP to parallelize a Jacobi iteration for solving A*x=b.
jacobi_poisson_1d, a MATLAB code which uses Jacobi iteration to solve the linear system for a discretized version of the steady (time independent) 1D Poisson equation.
jacobi_poisson_1d, an Octave code which uses Jacobi iteration to solve the linear system for a discretized version of the steady (time independent) 1D Poisson equation.
jacobi_poisson_1d, a Python code which uses Jacobi iteration to solve the linear system for a discretized version of the steady (time independent) 1D Poisson equation.
jacobi_polynomial, a C code which evaluates the Jacobi polynomial and associated functions.
jacobi_polynomial, a C++ code which evaluates the Jacobi polynomial and associated functions.
jacobi_polynomial, a Fortran77 code which evaluates the Jacobi polynomial and associated functions.
jacobi_polynomial, a Fortran90 code which evaluates the Jacobi polynomial and associated functions.
jacobi_polynomial, a MATLAB code which evaluates the Jacobi polynomial and associated functions.
jacobi_polynomial, an Octave code which evaluates the Jacobi polynomial and associated functions.
jacobi_rule, a C++ code which returns a Gauss-Jacobi quadrature rule.
jacobi_rule, a Fortran90 code which returns a Gauss-Jacobi quadrature rule.
jacobi_rule, a MATLAB code which returns a Gauss-Jacobi quadrature rule.
jacobi_rule, an Octave code which returns a Gauss-Jacobi quadrature rule.
jacobi_rule, a Python code which returns a Gauss-Jacobi quadrature rule.
jai_alai_simulation, a MATLAB code which simulates a sequence of matches of the game of jai alai.
jai_alai_simulation, an Octave code which simulates a sequence of matches of the game of jai alai.
jai_alai_simulation, a Python code which simulates a sequence of matches of the game of jai alai.
jaccard_distance, a MATLAB code which computes the Jaccard distance between two sets.
jaccard_distance, an Octave code which computes the Jaccard distance between two sets.
jaccard_distance, a Python code which computes the Jaccard distance between two sets.
jbar, a Fortran90 code which reads a data file and creates a bar graph.
jordan_matrix, a MATLAB code which returns a random matrix in Jordan canonical form.
jordan_matrix, an Octave code which returns a random matrix in Jordan canonical form.
jordan_matrix, a Python code which returns a random matrix in Jordan canonical form.
joukowsky_transform, a MATLAB code which applies the Joukowsky transform to data, mapping between a circle in the complex plane and various airfoil shapes.
joukowsky_transform, an Octave code which applies the Joukowsky transform to data, mapping between a circle in the complex plane and various airfoil shapes.
joukowsky_transform, a Python code which applies the Joukowsky transform to data, mapping between a circle in the complex plane and various airfoil shapes.
jpg, a data directory which contains examples of JPG or JPEG files, a file format for high quality 2D graphics;
julia, examples which use JULIA, which is a language intended to achieve efficient performance on high performance computers, while offering the convenience of interactive languages like Python and MATLAB.
julia_set, a C code which generates a TGA or TARGA graphics file of a Julia set.
julia_set, a MATLAB code which computes and plots a Julia set, the set of points in the complex plane that remain bounded under a mapping of the form f(z) = z^2+c.
julia_set, an Octave code which computes and plots a Julia set, the set of points in the complex plane that remain bounded under a mapping of the form f(z) = z^2+c.
julia_set, a Python code which computes and plots a Julia set, the set of points in the complex plane that remain bounded under a mapping of the form f(z) = z^2+c.
julia_set_openmp, a C code which produces an image of a Julia set, using OpenMP to carry out the computation in parallel.
jumping_bean_simulation, a MATLAB code which simulates the motion of several jumping beans which prefer cooler locations.
karman_vortex, a FreeFem++ code which calculates the heat transfer occurring in a von Karman vortex street, and writes the resulting data to files, using the ffmatlib() interface, for subsequent graphics processing by MATLAB or Octave.
karman_vortex_test, a MATLAB code which plots data from a calculation of the heat transfer in a von Karman vortex street, as computed by FreeFem++ and transferred using ffmatlib(), creating an AVI movie of pressure, temperature, and vorticity.
kdv_etdrk4, a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
kdv_etdrk4, an Octave code which uses the exponential time differencing (ETD) RK4 method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
kdv_exact, a C code which evaluates exact solutions of the Korteweg-deVries (KdV) partial differential equation (PDE).
kdv_exact, a C++ code which evaluates exact solutions of the Korteweg-deVries (KdV) partial differential equation (PDE).
kdv_exact, a Fortran90 code which evaluates exact solutions of the Korteweg-deVries (KdV) partial differential equation (PDE).
kdv_exact, a MATLAB code which evaluates exact solutions of the Korteweg-deVries (KdV) partial differential equation (PDE).
kdv_exact, an Octave code which evaluates exact solutions of the Korteweg-deVries (KdV) partial differential equation (PDE).
kdv_exact, a Python code which evaluates exact solutions of the Korteweg-deVries (KdV) partial differential equation (PDE).
kdv_ift, a Fortran90 code which uses the Inverse Fourier Transform (IFT) method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
kdv_ift, a MATLAB code which uses the Inverse Fourier Transform (IFT) method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
kdv_ift, an Octave code which uses the Inverse Fourier Transform (IFT) method to solve the Korteweg-deVries (KdV) partial differential equation (PDE), by Aly-Khan Kassam, Lloyd Trefethen.
kelley, a MATLAB code which implements iterative methods for linear and nonlinear algebraic equations, by Tim Kelley;
kepler_ode, a MATLAB code which sets up the ordinary differential equations (ODE) for a Kepler two body gravitational problem.
kepler_ode, an Octave code which sets up the ordinary differential equations (ODE) for a Kepler two body gravitational problem.
kepler_ode, a Python code which sets up the ordinary differential equations (ODE) for a Kepler two body gravitational problem.
kepler_perturbed_ode, a MATLAB code which sets up the ordinary differential equations (ODE) for a perturbed Kepler two body gravitational problem.
kepler_perturbed_ode, an Octave code which sets up the ordinary differential equations (ODE) for a perturbed Kepler two body gravitational problem.
kepler_perturbed_ode, a Python code which sets up the ordinary differential equations (ODE) for a perturbed Kepler two body gravitational problem.
ketel_one, a Fortran90 code which finds all words formed from the letters in "ketel one vodka";
keyword_test, a MATLAB code which demonstrates how to write a function which accepts named keywords, using the Name/Value paired argument convention.
keyword_test, an Octave code which demonstrates how to write a function which accepts named keywords, using the Name/Value paired argument convention.
kmeans, a C code which solves the K-Means problem, which organizes N points in M dimensions into K clusters;
kmeans, a C++ code which solves the K-Means problem, which organizes N points in M dimensions into K clusters;
kmeans, a Fortran90 code which solves the K-Means problem, which organizes N points in M dimensions into K clusters;
kmeans, a MATLAB code which solves the K-Means problem, which organizes N points in M dimensions into K clusters;
kmeans, an Octave code which solves the K-Means problem, which organizes N points in M dimensions into K clusters;
kmeans_fast, a MATLAB code which contains several different algorithms for the K-Means problem, which organizes N points in M dimensions into K clusters, by Charles Elkan.
kmeans_fast, an Octave code which contains several different algorithms for the K-Means problem, which organizes N points in M dimensions into K clusters, by Charles Elkan.
kmedian, a Fortran77 code which handles the K-Median problem, by G Cornuejols, M L Fisher, G L Nemhauser.
kmedian, a Fortran90 code which handles the K-Median problem, by G Cornuejols, M L Fisher, G L Nemhauser.
knapsack, a Fortran77 code which implements algorithms for a variety of combinatorial problems, including bin packing, the subset sum problem, the generalized assignment problem, the change making problem, the 01 knapsack problem, and the multiple knapsack problem. by Silvano Martelo, Paolo Toth.
knapsack_01, a dataset directory which contains test data for the 0/1 knapsack problem;
knapsack_01_brute, a C code which uses brute force to solve small versions of the 0/1 knapsack problem;
knapsack_01_brute, a C++ code which uses brute force to solve small versions of the 0/1 knapsack problem;
knapsack_01_brute, a Fortran77 code which uses brute force to solve small versions of the 0/1 knapsack problem;
knapsack_01_brute, a Fortran90 code which uses brute force to solve small versions of the 0/1 knapsack problem;
knapsack_01_brute, a MATLAB code which uses brute force to solve small versions of the 0/1 knapsack problem;
knapsack_01_brute, an Octave code which uses brute force to solve small versions of the 0/1 knapsack problem;
knapsack_01_brute, a Python code which uses brute force to solve small versions of the 0/1 knapsack problem;
knapsack_dynamic, a MATLAB code which uses dynamic programming to solve a knapsack problem.
knapsack_dynamic, an Octave code which uses dynamic programming to solve a knapsack problem.
knapsack_dynamic, a Python code which uses dynamic programming to solve a knapsack problem.
knapsack_greedy, a MATLAB code which uses a greedy algorithm to estimate a solution of the knapsack problem;
knapsack_greedy, an Octave code which uses a greedy algorithm to estimate a solution of the knapsack problem;
knapsack_greedy, a Python code which uses a greedy algorithm to estimate a solution of the knapsack problem;
knapsack_multiple, a dataset directory which contains test data for the multiple knapsack problem;
kronrod_rule, a C code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
kronrod_rule, a C++ code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
kronrod_rule, a Fortran77 code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
kronrod_rule, a Fortran90 code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
kronrod_rule, a MATLAB code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
kronrod_rule, an Octave code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
kronrod_rule, a Python code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
kursiv_pde_etdrk4, a MATLAB code which uses the exponential time differencing (ETD) RK4 method to solve the Kuratomo-Sivashinsky PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
kursiv_pde_etdrk4, an Octave code which uses the exponential time differencing (ETD) RK4 method to solve the Kuratomo-Sivashinsky PDE as a system of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
l4lib, a C code which contains many utility routines, using one byte logical (L4) variables.
l4lib, a C++ code which contains many utility routines, using one byte logical (L4) variables.
l4lib, a Fortran90 code which contains many utility routines, using one byte logical (L4) variables.
l4lib, a MATLAB code which contains many utility routines, using one byte logical (L4) variables.
ladders, a C code which transforms one five letter word into another, by changing one letter at a time, using only legitimate English words. This puzzle was invented by Lewis Carroll, who called it "Doublets", but it is also known as Word Ladders or Word Golf, by Donald Knuth, as part of his "Stanford Graph Base".
lagrange_approx_1d, a C code which defines and evaluates the Lagrange polynomial p(x) of degree M which approximates N data points (x(i),y(i)).
lagrange_approx_1d, a C++ code which defines and evaluates the Lagrange polynomial p(x) of degree M which approximates N data points (x(i),y(i)).
lagrange_approx_1d, a Fortran77 code which defines and evaluates the Lagrange polynomial p(x) of degree M which approximates N data points (x(i),y(i)).
lagrange_approx_1d, a Fortran90 code which defines and evaluates the Lagrange polynomial p(x) of degree M which approximates N data points (x(i),y(i)).
lagrange_approx_1d, a MATLAB code which defines and evaluates the Lagrange polynomial p(x) of degree M which approximates N data points (x(i),y(i)).
lagrange_approx_1d, an Octave code which defines and evaluates the Lagrange polynomial p(x) of degree M which approximates N data points (x(i),y(i)).
lagrange_approx_1d, a Python code which defines and evaluates the Lagrange polynomial p(x) of degree M which approximates N data points (x(i),y(i)).
lagrange_basis_display, a MATLAB code which displays the basis functions associated with a given set of nodes used with the Lagrange interpolation scheme.
lagrange_basis_display, an Octave code which displays the basis functions associated with a given set of nodes used with the Lagrange interpolation scheme.
lagrange_basis_display, a Python code which displays the basis functions associated with a given set of nodes used with the Lagrange interpolation scheme.
lagrange_interp_1d, a C code which defines and evaluates the Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i).
lagrange_interp_1d, a C++ code which defines and evaluates the Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i).
lagrange_interp_1d, a Fortran77 code which defines and evaluates the Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i).
lagrange_interp_1d, a Fortran90 code which defines and evaluates the Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i).
lagrange_interp_1d, a MATLAB code which defines and evaluates the Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i).
lagrange_interp_1d, an Octave code which defines and evaluates the Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i).
lagrange_interp_1d, a Python code which defines and evaluates the Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i).
lagrange_interp_2d, a C code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates 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++ code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates 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 code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates 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 code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates 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 code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates 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, an Octave code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates 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 code which defines and evaluates the Lagrange polynomial p(x) which interpolates 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++ code which defines and evaluates the Lagrange polynomial p(x) which interpolates 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 code which defines and evaluates the Lagrange polynomial p(x) which interpolates 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 code which defines and evaluates the Lagrange polynomial p(x) which interpolates 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 code which defines and evaluates the Lagrange polynomial p(x) which interpolates 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++ code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
lagrange_nd, a Fortran90 code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
lagrange_nd, a MATLAB code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
lagrange_nd, an Octave code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
laguerre_exactness, a C code which tests the exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
laguerre_exactness, a C++ code which tests the exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
laguerre_exactness, a Fortran77 code which tests the exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
laguerre_exactness, a Fortran90 code which tests the exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
laguerre_exactness, a MATLAB code which tests the exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
laguerre_exactness, an Octave code which tests the exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
laguerre_exactness, a Python code which tests the exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
laguerre_integrands, a C code which defines test integrands for Gauss-Laguerre quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_integrands, a C++ code which defines test integrands for Gauss-Laguerre quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_integrands, a Fortran77 code which defines test integrands for Gauss-Laguerre quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_integrands, a Fortran90 code which defines test integrands for Gauss-Laguerre quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_integrands, a MATLAB code which defines test integrands for Gauss-Laguerre quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_integrands, an Octave code which defines test integrands for Gauss-Laguerre quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_polynomial, a C code which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.
laguerre_polynomial, a C++ code which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.
laguerre_polynomial, a Fortran77 code which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.
laguerre_polynomial, a Fortran90 code which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.
laguerre_polynomial, a MATLAB code which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.
laguerre_polynomial, an Octave code which evaluates the Laguerre polynomial, the generalized Laguerre polynomial, and the Laguerre function.
laguerre_polynomial, a Python code which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
laguerre_product, a MATLAB code which computes weighted integrals of products of Laguerre polynomials.
laguerre_rule, a C code which returns 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++ code which returns 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 code which returns 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 code which returns 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 code which returns a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_rule, an Octave code which returns a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
laguerre_rule, a Python code which returns a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
lambert_w, a C code which evaluates Lambert's W function.
lambert_w, a C++ code which evaluates Lambert's W function.
lambert_w, a Fortran90 code which evaluates Lambert's W function.
lambert_w, a MATLAB code which evaluates Lambert's W function.
lambert_w, an Octave code which evaluates Lambert's W function.
lambert_w, a Python code which evaluates Lambert's W function.
lamp, a Fortran77 code which implements algorithms for linear assignment and matching problems, including the linear sum assignment problem, the linear bottleneck assignment problem, the cardinality matching problem, the sum matching problem, the bottleneck matching problem, the Chinese postman problem, and the quadratic assignment problem, by Rainer Burkard, Ulrich Derigs.
langford_ode, a MATLAB code which sets up and solves the Langford system of ordinary differential equations (ODE).
langford_ode, an Octave code which sets up and solves the Langford system of ordinary differential equations (ODE).
langford_ode, a Python code which sets up and solves the Langford system of ordinary differential equations (ODE).
lapack_test, a C code which calls lapack(), which is a Fortran library, containing a standard linear algebra package for solving linear systems, computing matrix factorizations, and solving eigenvalue problems. A precompiled copy of the lapack() library is often available on most scientific computing systems. This code illustrates how a C calling program interacts with a Fortran library.
lapack_test, a C++ code which calls lapack(), which is a Fortran library, containing a standard linear algebra package for solving linear systems, computing matrix factorizations, and solving eigenvalue problems. A precompiled copy of the lapack() library is often available on most scientific computing systems. This code illustrates how a C++ calling program interacts with a Fortran library.
lapack_test, a Fortran77 code which calls lapack(), which is a standard linear algebra package for solving linear systems, computing matrix factorizations, and solving eigenvalue problems.
lapack_test, a Fortran90 code which calls lapack(), which is a standard linear algebra package for solving linear systems, computing matrix factorizations, and solving eigenvalue problems. A precompiled copy of the lapack() library is often available on most scientific computing systems.
lapack_test, a FreeFem++ code which uses an interface to the lapack() library to carry out certain linear algebra operations.
lapack_d, a Fortran90 code which is a linear algebra package using real double precision arithmetic, for solving linear systems, computing matrix factorizations, and solving eigenvalue problems.
lapack_eigen_test, a Fortran77 code which calls eigenvalue functions from lapack(), which is a linear algebra library.
lapack_osx, a Fortran90 code 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 code which is a Fortran90 version of the real 32 bit lapack() + blas() libraries.
laplace, a FreeFem++ code which sets up the steady Laplace equation in a circle.
laplace_mpi, a C code which solves the Laplace equation on a rectangle, using MPI for parallel execution.
laplace_periodic, a FreeFem++ code which solves the Laplace equation in the square with periodic boundary conditions, and writes the resulting data to files, using the ffmatlib() interface, for subsequent graphics processing by MATLAB or Octave.
laplace_periodic_test, a MATLAB code which plots data from the solution of the Laplace equation in a square with periodic boundary conditions, computed by FreeFem++() and transferred using ffmatlib().
laplace_periodic_test, an Octave code which plots data from the solution of the Laplace equation in a square with periodic boundary conditions, computed by FreeFem++() and transferred using ffmatlib().
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 code which carries out computations related to the discrete laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
laplacian, a C++ code which carries out computations related to the discrete laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
laplacian, a Fortran77 code which carries out computations related to the discrete laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
laplacian, a Fortran90 code which carries out computations related to the discrete laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
laplacian, a MATLAB code which carries out computations related to the discrete laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to 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++ code which computes elements of a Latin Hypercube dataset, choosing center points.
latin_center, a Fortran90 code which computes elements of a Latin Hypercube dataset, choosing center points.
latin_center, a MATLAB code which computes elements of a Latin Hypercube dataset, choosing center points.
latin_center, an Octave code which computes elements of a Latin Hypercube dataset, choosing center points.
latin_center, a Python code which computes elements of a Latin Hypercube dataset, choosing center points.
latin_center_dataset, a C++ code which creates a Latin Center Hypercube dataset;
latin_center_dataset, a Fortran90 code which creates a Latin Center Hypercube dataset;
latin_center_dataset, a MATLAB code which creates a Latin Center Hypercube dataset;
latin_cover, a C code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
latin_cover, a C++ code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
latin_cover, a Fortran77 code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
latin_cover, a Fortran90 code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
latin_cover, a MATLAB code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
latin_cover, an Octave code 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++ code which computes elements of a Latin Hypercube dataset, choosing edge points.
latin_edge, a Fortran90 code which computes elements of a Latin Hypercube dataset, choosing edge points.
latin_edge, a MATLAB code which computes elements of a Latin Hypercube dataset, choosing edge points.
latin_edge, an Octave code which computes elements of a Latin Hypercube dataset, choosing edge points.
latin_edge, a Python code which computes elements of a Latin Hypercube dataset, choosing edge points.
latin_edge_dataset, a C++ code which creates a Latin Edge Hypercube dataset;
latin_edge_dataset, a Fortran90 code which creates a Latin Edge Hypercube dataset;
latin_edge_dataset, a MATLAB code 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 code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random, a C++ code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random, a Fortran77 code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random, a Fortran90 code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random, a MATLAB code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random, an Octave code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random, a Python code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random_dataset, a C code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random_dataset, a C++ code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random_dataset, a Fortran77 code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random_dataset, a Fortran90 code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latin_random_dataset, a MATLAB code which computes a Latin Hypercube in M dimensions of N points, randomly placed within their subsquares.
latinize, a C code which adjusts N points in M dimensions to form a Latin hypercube.
latinize, a C++ code which adjusts N points in M dimensions to form a Latin hypercube.
latinize, a Fortran77 code which adjusts N points in M dimensions to form a Latin hypercube.
latinize, a Fortran90 code which adjusts N points in M dimensions to form a Latin hypercube.
latinize, a MATLAB code which adjusts N points in M dimensions to form a Latin hypercube.
latinize, an Octave code which adjusts N points in M dimensions to form a Latin hypercube.
lattice_rule, a C++ code which approximates M-dimensional integrals using lattice rules.
lattice_rule, a Fortran90 code which approximates M-dimensional integrals using lattice rules.
lattice_rule, a MATLAB code which approximates M-dimensional integrals using lattice rules.
lau_np, a Fortran90 code 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 code which computes properties of mathematical graphs, including Euler circuits, Hamiltonian circuits, cliques, strongly connected components, minimal spanning tree, chromatic number, shortest paths, maximal flow, and planarity.
lawson, a Fortran77 code which contains routines for solving linear least squares (LLS) problems and singular value decompositions (SVD), by Charles Lawson, Richard Hanson.
lawson, a Fortran90 code 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++ code which computes a Latinized Centroidal Voronoi Tessellation (CVT).
lcvt, a Fortran90 code which computes a Latinized Centroidal Voronoi Tessellation (CVT).
lcvt, a MATLAB code which computes a Latinized Centroidal Voronoi Tessellation (CVT).
lcvt_dataset, a C++ code which computes a Latinized Centroidal Voronoi Tessellation (CVT) and writes it to a file.
lcvt_dataset, a Fortran90 code which computes a Latinized Centroidal Voronoi Tessellation (CVT) and writes it to a file.
lcvt_dataset, a MATLAB code which computes a Latinized Centroidal Voronoi Tessellation (CVT) and writes it to a file.
lcvtp, a dataset directory which contains examples of an LCVTP, that is, a Latinized Centroidal Voronoi Tessellations (CVT) on a periodic region.
leapfrog, a MATLAB code which uses the leapfrog method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
leapfrog, a Python code which uses the leapfrog method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
least_squares_approximant, a MATLAB code which finds a polynomial approximant to data using linear least squares (LLS).
least_squares_approximant_test
least_squares_approximant, an Octave code which finds a polynomial approximant to data using linear least squares (LLS).
least_squares_approximant_test
leastsquares, an R code which solves an overdetermined linear system using the normal equations.
lebesgue, a C code which is given 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++ code which is given 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 code which is given 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 code which is given 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 code which is given nodes in 1D, plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation.
lebesgue, an Octave code which is given nodes in 1D, 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 code which is given 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 code which tests the 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++ code which tests the 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 code which tests the 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 code which tests the 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 code which tests the 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, an Octave code which tests the 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 Python code which tests the 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_fast_rule, a C code which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_fast_rule, a C++ code which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_fast_rule, a Fortran77 code which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_fast_rule, a Fortran90 code which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_fast_rule, a MATLAB code which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_polynomial, a C code which evaluates the Legendre polynomial and associated functions.
legendre_polynomial, a C++ code which evaluates the Legendre polynomial and associated functions.
legendre_polynomial, a Fortran77 code which evaluates the Legendre polynomial and associated functions.
legendre_polynomial, a Fortran90 code which evaluates the Legendre polynomial and associated functions.
legendre_polynomial, a MATLAB code which evaluates the Legendre polynomial and associated functions.
legendre_polynomial, an Octave code which evaluates the Legendre polynomial and associated functions.
legendre_polynomial, a Python code which evaluates the Legendre polynomial and associated functions.
legendre_product, a MATLAB code which computes weighted integrals of products of Legendre polynomials.
legendre_product, an Octave code which computes weighted integrals of products of Legendre polynomials.
legendre_product_display, a MATLAB code which displays the points in a 2D Gauss-Legendre product quadrature rule;
legendre_product_display, an Octave code which displays the points in a 2D Gauss-Legendre product quadrature rule;
legendre_product_polynomial, a C code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
legendre_product_polynomial_test
legendre_product_polynomial, a C++ code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
legendre_product_polynomial_test
legendre_product_polynomial, a Fortran77 code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
legendre_product_polynomial_test
legendre_product_polynomial, a Fortran90 code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
legendre_product_polynomial_test
legendre_product_polynomial, a MATLAB code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
legendre_product_polynomial_test
legendre_product_polynomial, an Octave code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
legendre_product_polynomial_test
legendre_product_polynomial, a Python code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
legendre_rule, a C code which returns a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_rule, a C++ code which returns a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_rule, a Fortran77 code which returns a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_rule, a Fortran90 code which returns a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_rule, a MATLAB code which returns a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_rule, an Octave code which returns a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_rule, a Python code which returns a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
legendre_shifted_polynomial, a C code which evaluates the shifted Legendre polynomial, with domain [0,1].
legendre_shifted_polynomial_test
legendre_shifted_polynomial, a C++ code which evaluates the shifted Legendre polynomial, with domain [0,1].
legendre_shifted_polynomial_test
legendre_shifted_polynomial, a Fortran90 code which evaluates the shifted Legendre polynomial, with domain [0,1].
legendre_shifted_polynomial_test
legendre_shifted_polynomial, a MATLAB code which evaluates the shifted Legendre polynomial, with domain [0,1].
legendre_shifted_polynomial_test
legendre_shifted_polynomial, an Octave code which evaluates the shifted Legendre polynomial, with domain [0,1].
legendre_shifted_polynomial_test
legendre_shifted_polynomial, a Python code which evaluates the shifted Legendre polynomial, with domain [0,1].
lemke, a MATLAB code which implements the Lemke algorithm for the linear complementarity problem, by Paul Fackler, Mario Miranda.
levels, a MATLAB code which makes a contour plot of a function Z=F(X,Y), choosing the contour levels using random sampling.
levenshtein_distance, a C code which returns the Levenshtein distance between two strings.
levenshtein_distance, a C++ code which returns the Levenshtein distance between two strings.
levenshtein_distance, a Fortran90 code which returns the Levenshtein distance between two strings.
levenshtein_distance, a MATLAB code which returns the Levenshtein distance between two strings.
levenshtein_distance, an Octave code which returns the Levenshtein distance between two strings.
levenshtein_distance, a Python code which returns the Levenshtein distance between two strings.
levenshtein_matrix, a C code which returns the Levenshtein distance matrix defined by two strings.
levenshtein_matrix, a C++ code which returns the Levenshtein distance matrix defined by two strings.
levenshtein_matrix, a Fortran90 code which returns the Levenshtein distance matrix defined by two strings.
levenshtein_matrix, a MATLAB code which returns the Levenshtein distance matrix defined by two strings.
levenshtein_matrix, an Octave code which returns the Levenshtein distance matrix defined by two strings.
levenshtein_matrix, a Python code which returns the Levenshtein distance matrix defined by two strings.
lf2cr, a C++ code which converts linefeeds to carriage returns in a file;
lf2crlf, a C++ code which converts linefeeds to carriage return + linefeeds in a file;
lfrm, a C++ code which removes all linefeed characters from a file;
lhs, a dataset directory which contains datasets related to Latin Hypercube Sampling (LHS);
libjpeg, examples which use LIBJPEG, which is a library for compression, storage, and decompression of graphics images using the JPEG format.
life_opengl, a C code which uses OpenGL to display the evolution of John Conway's Game of life, by Simon Green.
life_opengl, a C++ code which uses OpenGL to display the evolution of John Conway's Game of life.
life_serial, a C code which computes a few steps of the evolution of John Conway's Game of life, intended as a starting point for implementing a parallel version.
life_serial, a C++ code which computes a few steps of the evolution of John Conway's Game of life, intended as a starting point for implementing a parallel version.
life_serial, a Fortran77 code which computes a few steps of the evolution of John Conway's Game of life, intended as a starting point for implementing a parallel version.
life_serial, a Fortran90 code which computes a few steps of the evolution of John Conway's Game of life, intended as a starting point for implementing a parallel version.
life, a MATLAB code which computes a few steps of the evolution of John Conway's Game of life, intended as a starting point for implementing a parallel version.
lights_out_opengl, a C code which sets up the "Lights Out" puzzle, lighting up a few squares on a grid. An interactive user must then try to press squares in such a way that all the lights are turned off. The OpenGL graphics system is used.
lights_out_opengl, a C++ code which sets up the "Lights Out" puzzle, lighting up a few squares on a grid. An interactive user must then try to press squares in such a way that all the lights are turned off. The OpenGL graphics system is used.
lights_out, a MATLAB code which sets up the "Lights Out" game, lighting up a few squares on a grid. An interactive user must then try to press squares in such a way that all the lights are turned off.
lindberg_exact, a MATLAB code which evaluates the exact solution of the Lindberg ordinary differential equations (ODE), a system that is extremely difficult to solve accurately.
lindberg_exact, an Octave code which evaluates the exact solution of the Lindberg ordinary differential equations (ODE), a system that is extremely difficult to solve accurately.
lindberg_exact, a Python code which evaluates the exact solution of the Lindberg ordinary differential equations (ODE), a system that is extremely difficult to solve accurately.
lindberg_ode, a MATLAB code which sets up a system of 4 ordinary differential equations (ODE) which are very stiff.
lindberg_ode, an Octave code which sets up a system of 4 ordinary differential equations (ODE) which are very stiff.
lindberg_ode, a Python code which sets up a system of 4 ordinary differential equations (ODE) which are very stiff.
line_cvt_lloyd, a C code which applies the Lloyd iteration repeatedly to N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
line_cvt_lloyd, a C++ code which applies the Lloyd iteration repeatedly to N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
line_cvt_lloyd, a Fortran77 code which applies the Lloyd iteration repeatedly to N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
line_cvt_lloyd, a Fortran90 code which applies the Lloyd iteration repeatedly to N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
line_cvt_lloyd, a MATLAB code which applies the Lloyd iteration repeatedly to N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
line_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit line segment in 1D.
line_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit line segment in 1D.
line_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit line segment in 1D.
line_fekete_rule, a C code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
line_fekete_rule, a C++ code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
line_fekete_rule, a Fortran77 code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
line_fekete_rule, a Fortran90 code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
line_fekete_rule, a MATLAB code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
line_fekete_rule, an Octave code 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 code which returns a Felippa quadrature rule over the interior of a line segment in 1D.
line_felippa_rule, a C++ code which returns a Felippa quadrature rule over the interior of a line segment in 1D.
line_felippa_rule, a Fortran77 code which returns a Felippa quadrature rule over the interior of a line segment in 1D.
line_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule over the interior of a line segment in 1D.
line_felippa_rule, a MATLAB code which returns a Felippa quadrature rule over the interior of a line segment in 1D.
line_felippa_rule, an Octave code which returns a Felippa quadrature rule over the interior of a line segment in 1D.
line_grid, a C code which computes a grid of points over the interior of a line segment in 1D.
line_grid, a C++ code which computes a grid of points over the interior of a line segment in 1D.
line_grid, a Fortran77 code which computes a grid of points over the interior of a line segment in 1D.
line_grid, a Fortran90 code which computes a grid of points over the interior of a line segment in 1D.
line_grid, a MATLAB code which computes a grid of points over the interior of a line segment in 1D.
line_grid, an Octave code which computes a grid of points over the interior of a line segment in 1D.
line_grid, a Python code which computes a grid of points over the interior of a line segment in 1D.
line_integrals, a C code 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++ code 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 code 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 code 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 code which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.
line_integrals, an Octave code 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 code which returns the exact value of the integral of any monomial over the length of the unit line segment in 1D.
line_lines_packing, a MATLAB code which tries to randomly pack as many non-overlapping equal line segments as possible into a larger line segment, estimating Renyi's parking constant of 0.7475979202. This is an example of random sequential adsorption (RSA).
line_lines_packing, an Octave code which tries to randomly pack as many non-overlapping equal line segments as possible into a larger line segment, estimating Renyi's parking constant of 0.7475979202. This is an example of random sequential adsorption (RSA).
line_lines_packing, a Python code which tries to randomly pack as many non-overlapping equal line segments as possible into a larger line segment, estimating Renyi's parking constant of 0.7475979202. This is an example of random sequential adsorption (RSA).
line_monte_carlo, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code 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 code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_ncc_rule, a C++ code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_ncc_rule, a Fortran77 code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_ncc_rule, a Fortran90 code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_ncc_rule, a MATLAB code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_ncc_rule, an Octave code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_ncc_rule, a Python code 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 code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_nco_rule, a C++ code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_nco_rule, a Fortran77 code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_nco_rule, a Fortran90 code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_nco_rule, a MATLAB code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
line_nco_rule, an Octave code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
linear_algebra, a C code which carries out various linear algebra operations for matrices stored in a variety of formats.
linear_algebra, a C++ code which carries out various linear algebra operations for matrices stored in a variety of formats.
linear_algebra, a Fortran90 code which carries out various linear algebra operations for matrices stored in a variety of formats.
linear_algebra, a MATLAB code which carries out various linear algebra operations for matrices stored in a variety of formats.
linear_algebra, an Octave code which carries out various linear algebra operations for matrices stored in a variety of formats.
linear_algebra, a Python code which carries out various linear algebra operations for matrices stored in a variety of formats.
linear_solve_distributed, a MATLAB code which solves a linear system A*x=b using the spmd() facility, so that the matrix A is distributed across multiple workers.
linpack, a C code which solves linear systems for a variety of matrix storage schemes, real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic. It includes a routine for computing the singular value decomposition (SVD) of a rectangular matrix. The original version of this code is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack, a C++ code which solves linear systems for a variety of matrix storage schemes, real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic. It includes a routine for computing the singular value decomposition (SVD) of a rectangular matrix. The original version of this code is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack, a Fortran77 code which solves linear systems for a variety of matrix storage schemes, real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic. It includes a routine for computing the singular value decomposition (SVD) of a rectangular matrix. The original version of this code is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack, a Fortran90 code which solves linear systems for a variety of matrix storage schemes, real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic. It includes a routine for computing the singular value decomposition (SVD) of a rectangular matrix. The original version of this code is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack, a MATLAB code which solves linear systems for a variety of matrix storage schemes, real 32 bit, real 64 bit, complex 32 bit and complex 64 bit arithmetic. It includes a routine for computing the singular value decomposition (SVD) of a rectangular matrix. The original version of this code is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_bench, a C code which measures the time taken by linpack() to solve a particular linear system.
linpack_bench, a C++ code which measures the time taken by linpack() to solve a particular linear system.
linpack_bench, a Fortran77 code which measures the time taken by linpack() to solve a particular linear system.
linpack_bench, a Fortran90 code which measures the time taken by linpack() to solve a particular linear system.
linpack_bench, a MATLAB code which measures the time taken by linpack() to solve a particular linear system.
linpack_bench, an Octave code which measures the time taken by linpack() to solve a particular linear system.
linpack_bench_backslash, a MATLAB code which measures the time taken by linpack() to solve a particular linear system, and uses the built in backslash operator to do the solving.
linpack_bench_backslash, an Octave code which measures the time taken by linpack() to solve a particular linear system, and uses the built in backslash operator to do the solving.
linpack_c, a C++ code which factors and solves linear systems using complex 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_c, a Fortran77 code which factors and solves linear systems using complex 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_c, a Fortran90 code which factors and solves linear systems using complex 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_c, a MATLAB code which factors and solves linear systems using complex 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_d, a C code which factors and solves linear systems using real 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
linpack_d, a C++ code which factors and solves linear systems using real 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
linpack_d, a Fortran77 code which factors and solves linear systems using real 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
linpack_d, a Fortran90 code which factors and solves linear systems using double precision arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
linpack_d, a MATLAB code which factors and solves linear systems using real 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
linpack_d, an Octave code which factors and solves linear systems using real 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
linpack_d, a Python code which factors and solves linear systems using real 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be real.
linpack_q, a Fortran90 code which implements a few of the linpack() linear solvers, using real 128 bit arithmetic.
linpack_s, a C code which factors and solves linear systems using real 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_s, a C++ code which factors and solves linear systems using real 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_s, a Fortran77 code which factors and solves linear systems using real 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_s, a Fortran90 code which factors and solves linear systems using real 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_s, a MATLAB code which factors and solves linear systems using real 32 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
linpack_z, a C++ code which factors and solves linear systems using complex 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be complex.
linpack_z, a Fortran77 code which factors and solves linear systems using complex 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be complex.
linpack_z, a Fortran90 code which factors and solves linear systems using complex 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be complex.
linpack_z, a MATLAB code which factors and solves linear systems using complex 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be complex.
linpack_z, an Octave code which factors and solves linear systems using complex 64 bit arithmetic, by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart. The matrix and vector data is assumed to be complex.
linplus, a Fortran77 code which carries out operations such as matrix-vector products, matrix factorization, linear solvers including Gauss-elimination, Jacobi iteration, Gauss-Seidel iteration, Conjugate Gradient (CG), for matrices in a variety of formats, including banded, border-banded, circulant, lower triangular, pentadiagonal, sparse, symmetric, toeplitz, tridiagonal, upper triangular and Vandermonde formats.
linplus_c8, a Fortran90 code 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 code 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 code which carries out various linear algebra operations on complex matrices for matrices in a variety of formats, including tridiagonal, circulant, general, and toeplitz.
linterp, an R code which finds the line between two data points.
lissajous, a C++ code which displays a Lissajous figure, of the form x = sin ( a1 t + b1 ), y = sin ( a2 t + b2 ).
lissajous, a MATLAB code which displays a Lissajous figure, of the form x = sin ( a1 t + b1 ), y = sin ( a2 t + b2 ).
lissajous, an Octave code which displays a Lissajous figure, of the form x = sin ( a1 t + b1 ), y = sin ( a2 t + b2 ).
lissajous, a Python code which displays a Lissajous figure, of the form x = sin ( a1 t + b1 ), y = sin ( a2 t + b2 ).
llsq, a C code 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 N data points.
llsq, a C++ code 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 N data points.
llsq, a Fortran77 code 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 N data points.
llsq, a Fortran90 code 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 N data points.
llsq, a MATLAB code which solves the linear least squares (LLS) problem. It finds the "best" straight line to match data points. More precisely, it finds the quantities "a" and "b" defining the straight line y=a*x+b, which minimizes the root-mean-square (RMS) error to the data.
llsq, an Octave code which solves the linear least squares (LLS) problem. It finds the "best" straight line to match data points. More precisely, it finds the quantities "a" and "b" defining the straight line y=a*x+b, which minimizes the root-mean-square (RMS) error to the data.
llsq, a Python code 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 N data points.
load_test, a MATLAB code which calls the load() function, which reads data from a file into a variable.
load_test, an Octave code which calls the load() function, which reads data from a file into a variable.
loadtxt_test, a Python code which calls the function numpy.loadtxt() to extract numeric data from a text file.
lobatto_polynomial, a C code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
lobatto_polynomial, a C++ code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
lobatto_polynomial, a Fortran77 code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
lobatto_polynomial, a Fortran90 code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
lobatto_polynomial, a MATLAB code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
lobatto_polynomial, an Octave code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
lobatto_polynomial, a Python code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
local_min, a C code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min, a C++ code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min, a Fortran77 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min, a Fortran90 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min, a MATLAB code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min, an Octave code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min, a Python code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min, an R code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
local_min_rc, a C code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
local_min_rc, a C++ code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
local_min_rc, a Fortran90 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
local_min_rc, a Fortran77 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
local_min_rc, a MATLAB code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
local_min_rc, an Octave code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
local_min_rc, a Python code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
locker_simulation, a MATLAB code which simulates the locker problem, in which gym users have left their wallets in lockers; someone has scrambled all the lockers, and the gym users need a strategy that maximizes the chance that everyone will find their wallet by searching a limited number of lockers.
locker_simulation, an Octave code which simulates the locker problem, in which gym users have left their wallets in lockers; someone has scrambled all the lockers, and the gym users need a strategy that maximizes the chance that everyone will find their wallet by searching a limited number of lockers.
locker_simulation, a Python code which simulates the locker problem, in which gym users have left their wallets in lockers; someone has scrambled all the lockers, and the gym users need a strategy that maximizes the chance that everyone will find their wallet by searching a limited number of lockers.
log_norm, a MATLAB code which computes the logarithmic norm of a matrix, for norms 1, 2 and oo.
log_norm, an Octave code which computes the logarithmic norm of a matrix, for norms 1, 2 and oo.
log_norm, a Python code which computes the logarithmic norm of a matrix, for norms 1, 2 and oo.
log_normal, a C code which returns quantities associated with the log normal Probability Distribution Function (PDF).
log_normal, a C++ code which returns quantities associated with the log normal Probability Distribution Function (PDF).
log_normal, a Fortran90 code which returns quantities associated with the log normal Probability Distribution Function (PDF).
log_normal, a MATLAB code which returns quantities associated with the log normal Probability Distribution Function (PDF).
log_normal, a Python code which returns quantities associated with the log normal Probability Distribution Function (PDF).
log_normal_truncated_ab, a C code which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
log_normal_truncated_ab, a C++ code which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
log_normal_truncated_ab, a Fortran90 code which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
log_normal_truncated_ab, a MATLAB code which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
log_normal_truncated_ab, an Octave code which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
log_normal_truncated_ab, a Python code which returns quantities associated with the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
logistic_bifurcation, a MATLAB code which plots the bifurcation diagram for the logistic equation, by John D Cook.
logistic_bifurcation, an Octave code which plots the bifurcation diagram for the logistic equation, by John D Cook.
logistic_bifurcation, a Python code which plots the bifurcation diagram for the logistic equation, by John D Cook.
logistic_exact, a C code which evaluates an exact solution of the logistic equation, an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_exact, a C++ code which evaluates an exact solution of the logistic equation, an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_exact, a Fortran90 code which evaluates an exact solution of the logistic equation, an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_exact, a MATLAB code which evaluates an exact solution of the logistic equation, an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_exact, an Octave code which evaluates an exact solution of the logistic equation, an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_exact, a Python code which evaluates an exact solution of the logistic equation, an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_ode, a MATLAB code which sets up and solves an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_ode, a Python code which sets up and solves an ordinary differential equation (ODE) which models population growth in the face of a limited carrying capacity.
logistic_regression, a scikit-learn code which use logistic regression to classify data.
lorenz_equations, a Mathematica code which demonstrates how solutions to the Lorenz equations can be synchronized.
lorenz_ode, a C code which sets up the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
lorenz_ode, a C++ code which sets up the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
lorenz_ode, a Fortran77 code which sets up the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
lorenz_ode, a Fortran90 code which sets up the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
lorenz_ode, a MATLAB code which sets up the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
lorenz_ode, an Octave code which sets up the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
lorenz_ode, a Python code which sets up the Lorenz system of ordinary differential equations (ODE), which exhibit sensitive dependence on the initial conditions.
lorenz_ode_cluster_test, a MATLAB code which takes N points on a trajectory of solutions to the Lorenz system of ordinary differential equations (ODE), and applies the K-Means algorithm to organize the data into K clusters.
lorenz_ode_sensitivity_test, a MATLAB code which demonstrates sensitivity to initial conditions in the Lorenz system of ordinary differential equations (ODE), using an approach suggested by John D Cook.
lorenz_ode_sensitivity_test, a Python code which demonstrates sensitivity to initial conditions in the Lorenz system of ordinary differential equations (ODE), using an approach suggested by John D Cook.
lotka_volterra, a FreeFem++ code which models the time evolution of the distribution of predator and prey species over a 2D region.
lp, a dataset directory which contains datasets for linear programming, used for programs such as CPLEX, GUROBI and SCIP;
luhn, a C code which computes the Luhn check digit for a string, and validates a string.
luhn, a C++ code which computes the Luhn check digit for a string, and validates a string.
luhn, a Fortran90 code which computes the Luhn check digit for a string, and validates a string.
luhn, a MATLAB code which computes the Luhn check digit for a string, and validates a string.
luhn, an Octave code which computes the Luhn check digit for a string, and validates a string.
luhn, a Python code which computes the Luhn check digit for a string, and validates a string.
lumatrix, an R code which computes the Lower-Upper (LU) triangular factorization of a matrix.
lyrics_remote, a MATLAB code 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 the MATLAB batch facility, on a remote system.
machar, a C code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
machar, a C++ code which computes the appropriate values of arithmetice constants for a given machine, by William Cody.
machar, a Fortran77 code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
machar, a Fortran90 code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
machar, a MATLAB code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
machar, a Python code which computes the appropriate values of arithmetic constants for a given machine, by William Cody.
machine, a C code which returns values of arithmetic constants for a given machine.
machine, a C++ code which returns values of arithmetic constants for a given machine.
machine, a Fortran77 code which returns values of arithmetic constants for a given machine.
machine, a Fortran90 code which returns values of arithmetic constants for a given machine.
machine, a MATLAB code which returns values of arithmetic constants for a given machine.
machine, a Python code which returns values of arithmetic constants for a given machine.
machine, an R code which stores the appropriate values of arithmetic constants for a given machine.
mackey_glass_dde, a MATLAB code which sets up the Mackey-Glass Delay Differential Equation (DDE), which models dynamical diseases such as irregular breathing apnea and chronic myelogenous leukemia, and produces a strange chaotic attractor.
magic_matrix, a MATLAB code which computes a magic matrix, for any odd order n, such that all rows and columns have the same sum.
magic_matrix, an Octave code which computes a magic matrix, for any odd order n, such that all rows and columns have the same sum.
magic_matrix, a Python code which computes a magic matrix, for any odd order n, such that all rows and columns have the same sum.
makefile_test, a C++ code which uses a makefile, which maintains a software project (ugh);
makefile_test, a Fortran77 code which uses a makefile, which maintains a software project (ugh);
makefile_test, a Fortran90 code which uses a makefile, which maintains a software project (ugh);
mandelbrot, a C code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;
mandelbrot, a C++ code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;
mandelbrot, examples which compute the Mandelbrot set, which is defined as the set of points which remain bounded under a given iteration.
mandelbrot, a Fortran77 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;
mandelbrot, a Fortran90 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;
mandelbrot, a MATLAB code which generates an image of the Mandelbrot fractal set;
mandelbrot, an Octave code which generates an image of the Mandelbrot fractal set;
mandelbrot, a Python code which generates a Portable Network graphics (PNG) image of the Mandelbrot set;
mandelbrot_ascii, a C code which generates an ASCII text image of the Mandelbrot fractal set using just two lines of (very obscure) C.
mandelbrot_openmp, a C code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.
mandelbrot_openmp, a C++ code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.
mandelbrot_openmp, a Fortran77 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.
mandelbrot_openmp, a Fortran90 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.
mandelbrot_orbit, a MATLAB code which generates the sequence of Mandelbrot iterates arising from a single starting point.
mandelbrot_orbit, an Octave code which generates the sequence of Mandelbrot iterates arising from a single starting point.
mandelbrot_orbit, a Python code which generates the sequence of Mandelbrot iterates arising from a single starting point.
mandelbrot_ppm, a C code which generates a binary Portable Pixel Map (PPM) image of the Mandelbrot fractal set, by Eric Weeks.
mandelbrot_ppm, a C++ code which generates a binary Portable Pixel Map (PPM) image of the Mandelbrot fractal set, by Eric Weeks.
maple_area, a MATLAB code 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_area, an Octave code 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 code which reads an image of a maple leaf and extracts the list of pixels that form the boundary.
mario, a C code which creates a file of commands to gnuplot() that plot a sort of needlepoint image of Mario, as an array of colored squares.
mario, a C++ code which creates a file of commands to gnuplot() that plot a sort of needlepoint image of Mario, as an array of colored squares.
mario, a Fortran90 code which creates a file of commands to gnuplot() that plot a sort of needlepoint image of Mario, as an array of colored squares.
mario, a MATLAB code which creates a sort of needlepoint image of Mario, as an array of colored squares.
mario, an Octave code which creates a sort of needlepoint image of Mario, as an array of colored squares.
mario, a Python code which creates a sort of needlepoint image of Mario, as an array of colored squares.
markov_letters, a MATLAB code which counts the occurences of letter pairs in a text.
markov_letters, an Octave code which counts the occurences of letter pairs in a text.
markov_text, a Python code which uses a Markov Chain Monte Carlo (MCMC) process to sample an existing text file and create a new text that is randomized, but retains some of the structure of the original one.
martinez, a dataset directory which contains datasets for computational statistics, including cluster analysis;
mass, a Fortran90 code 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).
mass_matrix, a FreeFem++ code which computes a mass matrix for the finite element method (FEM), and discovers that FreeFem++ handles Dirichlet boundary conditions in a surprising way.
matalg, a Fortran90 code which carries out matrix calculations;
math_test, a FreeFem++ code which demonstrates each of the FreeFem++ built-in math functions;
mathematica, examples which use MATHEMATICA, which is an interactive program for symbolic calculation.
mathjax, examples which use MATHJAX, which is a system for displaying mathematical notation in a web page.
matlab_test, a MATLAB code which demonstrate some features of the MATLAB language;
matlab_calls_c, a MATLAB code which calls a C function using the MATLAB mex compiler;
matlab_calls_c++, a MATLAB code which calls a C++ function using the MATLAB mex compiler;
matlab_calls_f77, a MATLAB code which calls a Fortran77 function using the MATLAB mex compiler;
matlab_calls_f90, a MATLAB code which calls a Fortran90 function using the MATLAB mex compiler;
matlab_combinatorics, a MATLAB code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
matlab_commandline, a MATLAB code which runs MATLAB from the UNIX command line, that is, not with the usual MATLAB command window.
matlab_compiler, a MATLAB code which uses the Matlab compiler, which allows you to run a Matlab application outside the Matlab environment.
matlab_condor, a MATLAB code which runs MATLAB in batch mode using the condor queueing system.
matlab_distance, a MATLAB code which estimates the typical distance between a pair of points randomly selected from the surface or interior of a geometric object such as a circle, disk, sphere, cube, and between other nongeometric pairs of items.
matlab_distcomp, a MATLAB code which remotely runs 5 jobs on a remote cluster.
matlab_exact, a MATLAB code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
matlab_graphics, a MATLAB code which demonstrates a few issues that arise when producing graphic images.
matlab_grid, a MATLAB code which generates a regular grid of points inside a variety of regions in one, two, three or many dimensions.
matlab_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the surface or interior of some geometric object, including a line, quadrilateral, box, circle, disk, sphere, ball and others.
matlab_kmeans_test, a MATLAB code which uses the kmeans() function for clustering N sets of M-dimensional data into K clusters.
matlab_map, a MATLAB code which uses the MATLAB Mapping Toolbox.
matlab_mistake, a MATLAB code which illustrates some simple but devious programming mistakes.
matlab_monte_carlo, a MATLAB code which uses Monte Carlo sampling to estimate areas and integrals.
matlab_movie, a MATLAB code which creates a movie or animation by generating a sequence of graphics frames and then stringing them together.
matlab_ode, a MATLAB code which sets up various ordinary differential equations (ODE).
matlab_os, a MATLAB code which uses the system() command to allow MATLAB to issue commands to the computer operating system (UNIX or DOS);
matlab_parallel, a MATLAB code which illustrates local parallel execution on a single computer with the MATLAB Parallel Computing Toolbox.
matlab_plots, a MATLAB code which uses plotting to illustrate a mathematical structure, such as an iterative map, a fractal, a curve or surface.
matlab_polynomial, a MATLAB code which analyzes a variety of polynomial families, returning the polynomial values, coefficients, derivatives, integrals, roots, or other information.
matlab_random_test, a MATLAB code which uses the Matlab random number generator (RNG) functions.
matlab_random_parallel, a MATLAB code which uses the random number generator (RNG) functions when using parallel features such as parfor() or spmd().
matlab_remote, a MATLAB code which uses 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_test, a MATLAB code which illustrates that explicitly invoking the RETURN statment can be surprisingly costly;
matlab_rule, a MATLAB code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as, a circle, a disk, an ellipse, a triangle, a quadrilateral, a polygon, a sphere, a ball, a hypercube, and which might include an associated weight function w(x).
matlab_simulation, a MATLAB code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
matman, a Fortran77 code which allows a user to interactively define and manipulate matrices using integer, real, or rational arithmetic, and to perform various operations in linear algebra or linear programming modes.
matman, allows a user to interactively define and manipulate matrices using integer, real, or rational arithmetic, and to perform various operations in linear algebra or linear programming modes.
matmul, a C code which benchmarks matrix multiplication.
matmul, a Fortran77 code which benchmarks matrix multiplication.
matmul, a Fortran90 code which benchmarks matrix multiplication.
matplotlib, a Python code which uses matplotlib(), which is a graphics library for Python.
matrix_analyze, a MATLAB code which determines whether a matrix has certain features.
matrix_analyze, an Octave code which determines whether a matrix has certain features.
matrix_assemble_parfor, a MATLAB code which demonstrates the parfor() parallel programming feature by assembling the Hilbert matrix in a parallel loop.
matrix_assemble_spmd, a MATLAB code 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_chain_brute, a C code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using brute force.
matrix_chain_brute, a C++ code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using brute force.
matrix_chain_brute, a Fortran90 code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using brute force.
matrix_chain_brute, a MATLAB code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using brute force.
matrix_chain_brute, an Octave code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using brute force.
matrix_chain_brute, a Python code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using brute force.
matrix_chain_dynamic, a C code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
matrix_chain_dynamic, a C++ code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
matrix_chain_dynamic, a Fortran90 code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
matrix_chain_dynamic, a MATLAB code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
matrix_chain_dynamic, an Octave code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
matrix_chain_dynamic, a Python code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
matrix_exponential, a C code which computes the exponential function of a matrix.
matrix_exponential, a C++ code which computes the exponential function of a matrix.
matrix_exponential, a Fortran77 code which computes the exponential function of a matrix.
matrix_exponential, a Fortran90 code which computes the exponential function of a matrix.
matrix_exponential, a MATLAB code which computes the exponential function of a matrix.
matrix_exponential, an Octave code which computes the exponential function of a matrix.
matrix_exponential, a Python code which computes the exponential function of a matrix.
matt_message a C code 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.
maze, a Fortran90 code which carries out operations on a maze, including the diameter, a random example, or a path that solves the maze.
mcint, an R code which estimates an integral using the Monte Carlo quadrature rule.
mcint2, an R code which estimates an integral over a rectangle using the Monte Carlo quadrature rule.
mcnuggets, a MATLAB code which counts M(N), the number of ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
mcnuggets, an Octave code which counts M(N), the number of ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
mcnuggets, a Python code which counts M(N), the number of ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
mcnuggets_diophantine, a MATLAB code which uses Diophantine methods to find the ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
mcnuggets_diophantine, an Octave code which uses Diophantine methods to find the ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
mcnuggets_diophantine, a Python code which uses Diophantine methods to find the ways a given number N of Chicken McNuggets can be assembled, given that they are only available in packages of 6, 9, and 20.
md, a C code which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.
md, a C++ code which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.
md, a Fortran77 code which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.
md, a Fortran90 code which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.
md, a MATLAB code which carries out a molecular dynamics simulation.
md, an Octave code which carries out a molecular dynamics simulation.
md, a Python code which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.
md_fast, a MATLAB code which carries out a molecular dynamics simulation; it is a version of MD that has been revised to take advantage of vectorization.
md_fast, an Octave code which carries out a molecular dynamics simulation; it is a version of MD that has been revised to take advantage of vectorization.
md_openmp, a C code which carries out a molecular dynamics simulation, using OpenMP for parallel execution.
md_openmp, a C++ code which carries out a molecular dynamics simulation, using OpenMP for parallel execution.
md_openmp, a Fortran77 code which carries out a molecular dynamics simulation, using OpenMP for parallel execution.
md_openmp, a Fortran90 code which carries out a molecular dynamics simulation, using OpenMP for parallel execution.
md_parfor, a MATLAB code which runs the md() molecular dynamics program, running in parallel using parfor().
md1, a Fortran90 code which carries out a molecular dynamics simulation, and which writes graphics files for processing by gnuplot().
md2, a Fortran90 code which carries out a molecular dynamics simulation.
md3, a Fortran90 code which carries out a molecular dynamics simulation.
md3glue, a Fortran90 code which carries out a molecular dynamics simulation.
mds, a dataset directory which contains datasets for M-dimensional scaling;
medit, examples which use medit, an interactive graphics program developed to visualize numerical simulation results on unstructured meshes in two and three dimensions, using triangles, quadrilaterals, tetrahedrons or hexahedrons. Scalar, vector and tensor fields can be easily associated and displayed with meshes. The program is by Pascal Frey.
medit_io, a C code which reads or writes files used by the medit program, which 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++ code which reads or writes files used by the medit program, which 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 code which reads or writes files used by the medit program, which 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 code which reads or writes files used by the medit program, which 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 code which reads or writes files used by the medit program, which define the a mesh associated with the finite element method (FEM) in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.
medit_mesh, data which can be used by medit() to define a 2D or 3D mesh for use by the finite element method (FEM), using triangles, quadrilaterals, tetrahedrons or hexahedrons.
medit_mesh_io, a C code which reads or writes medit() MESH files defining a finite element mesh.
medit_mesh_io, a C++ code which reads or writes medit() MESH files defining a finite element mesh.
medit_mesh_io, a Fortran90 code which reads or writes medit() MESH files defining a finite element mesh.
medit_mesh_io, a MATLAB code which reads or writes medit() MESH files defining a finite element mesh.
medit_mesh_io, an Octave code which reads or writes medit() MESH files defining a finite element mesh.
medit_to_fem, a C code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
medit_to_fem, a C++ code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
medit_to_fem, a Fortran77 code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
medit_to_fem, a Fortran90 code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
medit_to_fem, a MATLAB code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
medit_to_fem, an Octave code which reads a medit() MESH file and writes a corresponding pair of node and element files that correspond to the FEM format.
medit_to_ice, a C code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
medit_to_ice, a C++ code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
medit_to_ice, a Fortran90 code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
medit_to_ice, a MATLAB code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
membrane, a FENICS code which models the deflection of a circular elastic membrane subject to a perpendicular pressure modeled as a Gaussian function.
membrane, a FreeFem++ code which models the deflection of an elastic membrane inside an ellipse.
membrane_error, a FreeFem++ code which solves the Laplace equation in an ellipse twice, and does a convergence analysis on the error.
memory, a C code 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, a C++ code 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, a Fortran90 code 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, a MATLAB code 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, an Octave code 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_adaptive, a FreeFem++ code which adapt a mesh according to some error indicator.
mesh_bandwidth, a C code which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.
mesh_bandwidth, a C++ code which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.
mesh_bandwidth, a Fortran77 code which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.
mesh_bandwidth, a Fortran90 code which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.
mesh_bandwidth, a MATLAB code which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.
mesh_bandwidth, an Octave code which returns the geometric bandwidth associated with a mesh of elements of any order O and spatial dimension M.
mesh_boundary, a MATLAB code which is given a mesh of a 2D region, formed by polygonal elements, and determines a sequence of pairs of polygonal vertices that define the boundary of the region.
mesh_boundary, an Octave code which is given a mesh of a 2D region, formed by polygonal elements, and determines a sequence of pairs of polygonal vertices that define the boundary of the region.
mesh_construction, a FreeFem++ code which shows how to construct a mesh as a sequence of straight lines, which then can automatically be meshed.
mesh_display, a MATLAB code which plots the nodes and elements of a polygonal mesh, with optional numbering.
mesh_display, an Octave code which plots the nodes and elements of a polygonal mesh, with optional numbering.
mesh_display_opengl, a C++ code 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 code which uses ETOV, the mesh element-to-vertex connectivity, to construct ETOE, the element-to-element connectivity.
mesh_etoe, an Octave code which uses ETOV, the mesh element-to-vertex connectivity, to construct ETOE, the element-to-element connectivity.
mesh_etoe, a Python code which uses ETOV, the mesh element-to-vertex connectivity, to construct ETOE, the element-to-element connectivity.
mesh_points, a FreeFem++ code which shows how an irregularly shaped region can be defined by reading from a file the coordinates of a sequence of boundary points that outline the region.
mesh_read, a FreeFem++ code which reads a file containing mesh information defined by another program.
mesh_test, a FENICS code which demonstrates some properties of the objects created by the various meshing functions.
mesh_vtoe, a MATLAB code which uses ETOV, the mesh element-to-vertex connectivity, to construct VTOE, the vertex-to-element connectivity.
mesh_vtoe, an Octave code which uses ETOV, the mesh element-to-vertex connectivity, to construct VTOE, the vertex-to-element connectivity.
mesh_write, a FreeFem++ code which generates a mesh on a circle, and saves the mesh to a file. This example is meant to illustrate the structure of the FreeFem++() mesh file and to create a mesh file that can be read by another example script.
mesh2d, a MATLAB code which creates a triangular mesh for a given polygonal region, by Darren Engwirda.
mesh2d, an Octave code which creates a triangular mesh for a given polygonal region, by Darren Engwirda.
mesh2d_to_medit, a MATLAB code which accepts the nodes and triangles of a mesh created by mesh2d() and creates a corresponding medit() MESH file.
mesh2d_to_medit, an Octave code which accepts the nodes and triangles of a mesh created by mesh2d() and creates a corresponding medit() MESH file.
mesh2d_write, a MATLAB code which writes mesh2d() node and element data to files.
mesh2d_write, an Octave code which writes mesh2d() node and element data to files.
meshes, a FENICS code which generates and plots the simple built-in mesh types.
meshfaces, a MATLAB code which creates 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 used by meshlab().
meshlab, examples which use meshlab, which is 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 code 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 dislin().
metis_test, a C code which uses metis(), which partition unstructured graphs or meshes, and compute fill-reducing reorderings of sparse matrices.
metis_test, a C++ code which uses metis(), which partition unstructured graphs or meshes, and compute fill-reducing reorderings of sparse matrices.
metis_test, a Fortran90 code which uses metis(), which partition unstructured graphs or meshes, and compute fill-reducing reorderings of sparse matrices.
metis, examples which use metis, which includes functions gpmetis, graphchk, m2gmetis, mpmetis, ndmetis, to partition the nodes of a graph or the elements of a mesh, for division among 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 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 partition the elements of such a mesh;
mex_test, a MATLAB code which calls lower-level functions written in traditional languages such as C, C++, Fortran77 or Fortran90, compiled with the MATLAB mex compiler.
mfem_mesh, data which is used by the MFEM finite element program to define a variety of 2D and 3D finite element meshes.
mg_serial, a Fortran77 code which is a serial version of the NAS MultiGrid (MG) Parallel Benchmark.
mgmres, a C code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
mgmres, a C++ code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
mgmres, a Fortran77 code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
mgmres, a Fortran90 code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
mgmres, a MATLAB code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
mgmres, an Octave code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
mgs, a C code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
mgs, a C++ code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
mgs, a Fortran77 code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
mgs, a Fortran90 code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
mgs, a MATLAB code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
mgs, an Octave code which is an obscure 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 code which controls the evolution of a magnetic hydrodynamic (MHD) system so that a particular state is achieved.
mhd_control_movie, a Mathematica code which displays and animates the output data from a magnetic hydrodynamic (MHD) control problem.
mhd_exact, a MATLAB code which evaluates Hartmann's exact formula for a solution of the magnetohydrodynamic (MHD) fluid flow equations in 2D.
mhd_exact, an Octave code which evaluates Hartmann's exact formula for a solution of the magnetohydrodynamic (MHD) fluid flow equations in 2D.
mhd_exact, a Python code which evaluates Hartmann's exact formula for a solution of the magnetohydrodynamic (MHD) fluid flow equations in 2D.
mhd_flow, a Fortran90 code which simulates the evolution of a system governed by the equations for 2D magnetohydrodynamics (MHD).
microwave, a FreeFem++ code which solves the complex Helmholtz equation governing the propagation of microwave radiation, followed by the determination of the material heating caused by the intensity of the radiation.
middle_square, a C code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
middle_square, a C++ code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
middle_square, a Fortran90 code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
middle_square, a MATLAB code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
middle_square, an Octave code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
middle_square, a Python code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
midpoint, a C code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with a version of fsolve() handling the associated nonlinear equations, and using a fixed time step.
midpoint, a C++ code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with a version of fsolve() handling the associated nonlinear equations, and using a fixed time step.
midpoint, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with a version of fsolve() handling the associated nonlinear equations, and using a fixed time step.
midpoint, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with a version of fsolve() handling the associated nonlinear equations, and using a fixed time step.
midpoint, a FreeFem++ code which uses the (implicit) midpoint method to solve a time-dependent boundary value problem (BVP).
midpoint, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using fsolve() to solve the implicit equation, and a fixed timestep.
midpoint, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using fsolve() to solve the implicit equation, and a fixed timestep.
midpoint, a Python code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using fsolve() to solve the implicit equation, and a fixed timestep.
midpoint, an R code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, solving the implicit equation using fsolve() from the pracma() library of Hans Borchers, and a fixed timestep.
midpoint_adaptive, a C code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, relying on fsolve() to solve the implicit equation, and using an adaptive timestep. Plots of the solution and timestep history are created using gnuplot().
midpoint_adaptive, a C++ code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, relying on fsolve() to solve the implicit equation, and using an adaptive timestep. Plots of the solution and timestep history are created using gnuplot().
midpoint_adaptive, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, relying on fsolve() to solve the implicit equation, and using an adaptive timestep. Plots of the solution and timestep history are created using gnuplot().
midpoint_adaptive, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, relying on fsolve() to solve the implicit equation, and using an adaptive timestep. Plots of the solution and timestep history are created.
midpoint_adaptive, an Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, relying on fsolve() to solve the implicit equation, and using an adaptive timestep. Plots of the solution and timestep history are created.
midpoint_adaptive, a Python code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, relying on fsolve() to solve the implicit equation, and using an adaptive timestep. Plots of the solution and timestep history are created.
midpoint_explicit, a C code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_explicit, a C++ code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_explicit, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_explicit, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_explicit, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_explicit, an Octave code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_explicit, a Python code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_explicit, an R code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
midpoint_fixed, a C code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, applying a fixed point iteration to solve the associated nonlinear equation.
midpoint_fixed, a C++ code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a fixed point iteration to solve the associated nonlinear equation.
midpoint_fixed, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using fixed point iteration for the nonlinear equation.
midpoint_fixed, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using fixed point iteration for the nonlinear equation.
midpoint_fixed, a MATLAB code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a simple fixed-point iteration to solve the nonlinear equation.
midpoint_fixed, a Octave code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a simple fixed-point iteration to solve the nonlinear equation.
midpoint_fixed, a Python code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a simple fixed-point iteration to solve the nonlinear equation.
midpoint_fixed, an R code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, applying a fixed point iteration to solve the associated nonlinear equation.
midpoint_gsl_test, a C code which calls the Gnu Scientific Library (GSL) implicit midpoint method solver for ordinary differential equations (ODE), and uses gnuplot() to plot the resulting solution.
midpoint_gsl_test, a C++ code which calls the Gnu Scientific Library (GSL) implicit midpoint method solver for ordinary differential equations (ODE), and uses gnuplot() to plot the resulting solution.
midpoint_quad, an R code which estimates an integral using the midpoint quadrature rule.
migration, a FreeFem++ code which models the migration and proliferation of biological cells. The region is a 3x2 rectangle with periodic boundary conditions on the left and right.
minesweeper_game, a C++ code which implements a text-based version of the Minesweeper game, by Detelina Stoyanova.
minpack, a C code which solves systems of nonlinear equations, or the least squares minimization of the residual of linear or nonlinear equations, by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
minpack, a C++ code which solves systems of nonlinear equations, or the least squares minimization of the residual of linear or nonlinear equations, by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
minpack, a Fortran77 code which solves systems of nonlinear equations, or the least squares minimization of the residual of linear or nonlinear equations, by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
minpack, a Fortran90 code which solves systems of nonlinear equations, or the least squares minimization of the residual of linear or nonlinear equations, by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
mitchell_dealii, examples which implement the Mitchell 2D elliptic partial differential equation (PDE) test problems using DEAL.II.
mitchell, a FENICS code which implements the Mitchell 2D elliptic partial differential equation (PDE) test problems.
mitchell_01, a dealii code which solves the Mitchell Analytic solution problem.
mitchell_01, a FreeFem++ code which sets up the Mitchell test problem #1, the analytic solution, a Poisson equation on the [0,+1]x[0,+1] square, with zero Dirichlet boundary conditions.
mitchell_02, a dealii code which solves the Mitchell Reentrant Corner problem;
mitchell_02, a FreeFem++ code which sets up the Mitchell test problem #2, the reentrant corner, testing five different angles for the corner.
mitchell_03, a dealii code which solves the Mitchell Linear Elasticity problem;
mitchell_03, a FreeFem++ code which sets up the Mitchell test problem #3, linear elasticity, two coupled equations with a mixed derivative in the coupling term, defined on the [-1,+1]x[-1,+1] square, with a slit from (0,0) to (1,0), using parameter values nu = 0.3, E = 1, lambda, and Q.
mitchell_04, a dealii code which solves the Mitchell Peak problem;
mitchell_04, a FreeFem++ code which sets up the Mitchell test problem #4, peak.
mitchell_05, a dealii code which solves the Mitchell Battery problem;
mitchell_05, a FreeFem++ code which sets up the Mitchell test problem #5, the battery.
mitchell_06, a dealii code which solves the Mitchell Boundary Layer problem;
mitchell_06, a FreeFem++ code which sets up the Mitchell Boundary Layer problem #6.
mitchell_07, a dealii code which solves the Mitchell Boundary Line Singularity problem;
mitchell_07, a FreeFem++ code which sets up the Mitchell Boundary Line Singularity test problem #7.
mitchell_08, a dealii code which solves the Mitchell Oscillatory problem;
mitchell_08, a FreeFem++ code which sets up the Mitchell test problem #8, oscillatory.
mitchell_09, a dealii code which solves the Mitchell Wave Front problem;
mitchell_09, a FreeFem++ code which sets up the Mitchell test problem #9, the wave front.
mitchell_10, a dealii code which solves the Mitchell Interior Line Singularity problem;
mitchell_10, a FreeFem++ code which sets up the Mitchell test problem #10, the interior line singularity.
mitchell_11, a dealii code which solves the Mitchell Intersecting Interfaces problem;
mitchell_11, a FreeFem++ code which sets up the Mitchell test problem #11, the intersecting interfaces.
mitchell_12, a FreeFem++ code which sets up the Mitchell test problem #12, multiple difficulties.
mittag_leffler_garappa, a MATLAB code 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 code which evaluates the two-parameter Mittag-Leffler function of real arguments, by Igor Podlubny and Martin Kacenak.
mittag_leffler_zongze, a MATLAB code which evaluates the Mittag-Leffler function of one or two parameters, with the Z argument allowed to be complex, by Yang Zongze.
mixed_test, a C code which calls a function written in another programming language.
mixed_test, a C++ code which calls a function written in another programming language.
mixed, a Fortran77 code which calls a function written in another programming language.
mixed_test, a Fortran90 code which calls a function written in another programming language.
mixture, a Fortran90 code which simulates a process governed by a Dirichlet mixture distribution.
mm, a data directory which contains examples of the Matrix Market (MM) Sparse Matrix File Format;
mm_io, a C code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
mm_io, a Fortran77 code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
mm_io, a Fortran90 code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
mm_io, a MATLAB code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
mm_io, an Octave code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
mm_to_hb, a MATLAB code which reads the sparse matrix information from an Matrix Market (MM) file and writes a corresponding Harwell Boeing (HB) file.
mm_to_hb, an Octave code 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 code which reads a Matrix Market (MM) file defining a sparse matrix, and creates a corresponding matrix in MATLAB sparse matrix (MSM) format.
mm_to_msm, an Octave code which reads a Matrix Market (MM) file defining a sparse matrix, and creates a corresponding matrix in MATLAB sparse matrix (MSM) format.
mm_to_st, a MATLAB code which reads the sparse matrix information from a Matrix Market (MM) file and writes a corresponding Sparse Triplet (ST) file.
mm_to_st, an Octave code which reads the sparse matrix information from a Matrix Market (MM) file and writes a corresponding Sparse Triplet (ST) file.
mnist, a keras code which sets up a neural network to classify the MNIST digit image data.
mnist_convnet, a keras code which sets up a convolutional neural network to classify the MNIST digit image data.
mnist_neural, a MATLAB code which constructs a neural network in order to classify images of digits.
moab, examples which use MOAB, which is a job scheduler for batch execution of jobs on a computer cluster.
moc_display, a MATLAB code 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 code which replaces bare 'END' statements by 'END (module name)' statements in a Fortran90 file.
molding a FreeFem++ code which models the process of filling a hollow mold with a liquid that obeys the Navier-Stokes equations (NSE).
molecule_xyz, a dataset directory which contains the Cartesian (x,y,z) coordinates of the atoms forming a molecule.
monoalphabetic, a MATLAB code which applies a monoalphabetic substitution cipher to a string of text.
monoalphabetic, an Octave code which applies a monoalphabetic substitution cipher to a string of text.
monomial, a C code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
monomial, a C++ code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
monomial, a Fortran77 code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
monomial, a Fortran90 code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
monomial, a MATLAB code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
monomial, an Octave code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
monomial, a Python code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
monomial_symmetrize, a MATLAB code which symmetrizes the coefficients of equivalent monomials in a polynomial.
monomial_symmetrize, an Octave code which symmetrizes the coefficients of equivalent monomials in a polynomial.
monomial_value, a C code which evaluates a monomial in M dimensions.
monomial_value, a C++ code which evaluates a monomial in M dimensions.
monomial_value, a Fortran77 code which evaluates a monomial in M dimensions.
monomial_value, a Fortran90 code which evaluates a monomial in M dimensions.
monomial_value, a MATLAB code which evaluates a monomial in M dimensions.
monomial_value, an Octave code which evaluates a monomial in M dimensions.
monomial_value, a Python code which evaluates a monomial in M dimensions.
monopoly_matrix, a MATLAB code which computes the adjacency and transition matrices for the game of Monopoly.
monopoly_matrix, an Octave code which computes the adjacency and transition matrices for the game of Monopoly.
monopoly_matrix, a Python code which computes the adjacency and transition matrices for the game of Monopoly.
montana, a keras code which seeks a regression formula y = b + w * x, using data supplied in an internal function.
monte_carlo_rule, a C code 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++ code 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 code 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 code 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 code 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.
monty_hall_simulation, a MATLAB code which simulates the "Let's Make a Deal" game in which Monty Hall has hidden a prize behind one of several doors, and the user wins the prize if the correct door is selected.
monty_hall_simulation, an Octave code which simulates the "Let's Make a Deal" game in which Monty Hall has hidden a prize behind one of several doors, and the user wins the prize if the correct door is selected.
monty_hall_simulation, a Python code which simulates the "Let's Make a Deal" game in which Monty Hall has hidden a prize behind one of several doors, and the user wins the prize if the correct door is selected.
moon_classify_forest, a scikit-learn code which uses the random forest algorithm to classify samples of the artificial moon dataset.
moon_classify_mlp, a scikit-learn code which uses a multilayer perceptron method to classify samples of the artificial moon dataset.
mortality, a MATLAB code which processes some sample mortality data.
mortality, an Octave code which processes some sample mortality data.
mortality, a Python code which processes some sample mortality data.
movie_data_reformat, a Fortran90 code which reformats movie data, copied from THE NUMBERS movie data web page, into a Comma Separated Value (CSV) format suitable for input to Excel or a statistical analysis package such as R.
movie_review, a keras code which sets up a neural network to classify movie reviews as positive or negative.
movie_test, a Python code which creates a movie file from a sequence of solutions to a partial differential equation (PDE), using matplotlib().
mpas_draw, a C++ code 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, a C++ code which reads information from an MPAS grid file, stored in netcdf() format, and displays the main (mainly hexagonal) mesh or the dual triangulation, using OpenGL.
mpas_grid_display, a MATLAB code which reads information from an MPAS grid file, stored in netcdf() format, and displays the main (mainly hexagonal) mesh or the dual triangulation.
mpi_test, a C code which uses the message passing interface (MPI) for parallel computations in a distributed memory environment.
mpi_test, a C++ code which uses the message passing interface (MPI) for parallel computations in a distributed memory environment.
mpi, a Fortran77 code which uses the message passing interface (MPI) for parallel computations in a distributed memory environment.
mpi_test, a Fortran90 code which use the message passing interface (MPI) for parallel computations in a distributed memory environment.
mpi_stubs, a C code 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++ code 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 code 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 code which contains stub MPI routines, allowing a user to compile, load, and possibly run an MPI program on a serial machine.
mpi4py, examples which use MPI4PY, which allows a Python code to run in parallel under MPI.
mpich, examples which use MPICH, which is one of several implementations of the MPI interface for parallel programming with distributed memory.
mps, a dataset directory which contains linear programming datasets;
mpsc, a dataset directory which contains linear programming datasets in compressed format;
mrbayes, examples which use 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 code which converts the binary data in a magnetic resonance imaging (MRI) file to ASCII text.
mri_to_pgm, a C code 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().
mshmet a FreeFem++ code which uses the Morice mshmet() plugin to create an isotropic adaptive mesh in a 3D region, displayed using medit().
msm_to_hb, a MATLAB code which writes a matrix in MATLAB sparse matrix (MSM) format to a Harwell Boeing (HB) file, by Xiaoye Li.
msm_to_hb, an Octave code which writes a matrix in MATLAB sparse matrix (MSM) format to a Harwell Boeing (HB) file, by Xiaoye Li.
msm_to_mm, a MATLAB code which writes a matrix in MATLAB sparse matrix (MSM) format to a Matrix Market (MM) file;
msm_to_mm, an Octave code which writes a matrix in MATLAB sparse matrix (MSM) format to a Matrix Market (MM) file;
msm_to_st, a MATLAB code which converts a matrix from MATLAB sparse matrix (MSM) format to Sparse Triplet (ST) format;
msm_to_st, an Octave code which converts a matrix from MATLAB sparse matrix (MSM) format to Sparse Triplet (ST) format;
multitask_mpi, a C code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using the message passing interface (MPI) for parallel execution.
multitask_mpi, a C++ code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using the message passing interface (MPI) for parallel execution.
multitask_mpi, a Fortran77 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using the message passing interface (MPI) for parallel execution.
multitask_mpi, a Fortran90 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using the message passing interface (MPI) for parallel execution.
multitask_openmp, a C code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.
multitask_openmp, a C++ code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.
multitask_openmp, a Fortran77 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.
multitask_openmp, a Fortran90 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.
mumps_test, a Fortran90 code which calls mumps() for the solution of large linear systems.
mus, a Fortran77 code which implements the multiple shooting method for two point boundary value problems (BVP), for linear or nonlinear cases, by Robert Mattheij and G Staarink.
mxm, a C code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
mxm, a C++ code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
mxm, a Fortran77 code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
mxm, a Fortran90 code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
mxm, a MATLAB code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
mxm, an Octave code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
mxm, a Python code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
mxm_openmp, a C code which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
mxm_openmp, a C++ code which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
mxm_openmp, a Fortran77 code which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
mxm_openmp, a Fortran90 code which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
mxm_serial, a C code which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.
mxm_serial, a C++ code which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.
mxm_serial, a Fortran77 code which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.
mxm_serial, a Fortran90 code which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.
my_calendar, a C++ code which checks a calendar file and prints any line containing the current date;
naca, a C code which takes the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data is displayed with the gnuplot() graphics program.
naca, a C++ code which takes the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data is displayed with the gnuplot() graphics program.
naca, a Fortran77 code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The data is displayed with the gnuplot() graphics program.
naca, a Fortran90 code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The data is displayed with the gnuplot() graphics program.
naca, a MATLAB code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The data is displayed graphically.
naca, an Octave code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The data is displayed graphically.
naca, a Python code which takes the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The data is displayed graphically.
nan_bug, a FENICS code which investigates a bug involving a NaN result.
napack, a Fortran77 code which includes many routines for applied numerical linear algebra tasks, including the matrix condition number, by William Hager.
nas, a C code which runs the NASA kernel benchmark.
nas, a C++ code which runs the NASA kernel benchmark.
nas, a Fortran77 code which runs the NASA kernel benchmark.
nas, a Fortran90 code which runs the NASA kernel benchmark.
nas, a MATLAB code which runs the NASA kernel benchmark.
nas, an Octave code which runs the NASA kernel benchmark.
nas, a Python code which runs the nasA kernel benchmark.
nastran, examples which use NASTRAN, which is a structural analysis program based on the finite element method.
navier_stokes_2d_exact, a C code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
navier_stokes_2d_exact, a C++ code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
navier_stokes_2d_exact, a Fortran77 code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
navier_stokes_2d_exact, a Fortran90 code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
navier_stokes_2d_exact, a MATLAB code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
navier_stokes_2d_exact, an Octave code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
navier_stokes_2d_exact, a Python code 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 code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
navier_stokes_3d_exact, a C++ code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
navier_stokes_3d_exact, a Fortran77 code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
navier_stokes_3d_exact, a Fortran90 code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
navier_stokes_3d_exact, a MATLAB code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
navier_stokes_3d_exact, a Python code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
navier_stokes_mesh2d, a MATLAB code which handles triangular meshes for several 2D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
navier_stokes_mesh2d, an Octave code which handles triangular meshes for several 2D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
navier_stokes_mesh3d, a MATLAB code which handles tetrahedral meshes for several 3D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
navier_stokes_mesh3d, an Octave code which handles tetrahedral meshes for several 3D test problems involving the Navier Stokes equations (NSE) for fluid flow, provided by Leo Rebholz.
navier_stokes_demo, a FENICS code which solves the Navier Stokes Equations (NSE) in the L-shaped domain.
ncarg, a Fortran77 code which uses NCAR graphics;
ncl, examples which use NCL, which is the NCAR Command Language, a simple scripting language that reads data, defines graphics attributes, and creates maps, contour plots, line drawings, and other graphical output, to be displayed on the terminal or saved in a graphics file.
ncm, a MATLAB code which accompanies the textbook "Numerical Computing with MATLAB", by Cleve Moler, and illustrates algorithms for the 3n+1 problem, blackjack, eigenvalue computations, fast Fourier transforms, Fibonacci numbers, file encryption, the flame differential equation, the fractal fern, the Lorenz differential equation, a membrane partial differential equation, minimization of a scalar function, ordinary differential equations, the pendulum differential equation, piecewise cubic Hermite (PWH) interpolation, polynomial interpolation, quadrature for approximate integration, random number generation, tridiagonal linear system solution, the singular value decomposition, solution of a nonlinear equation.
ncm, an Octave code which accompanies the textbook "Numerical Computing with MATLAB", by Cleve Moler, and illustrates algorithms for the 3n+1 problem, blackjack, eigenvalue computations, fast Fourier transforms, Fibonacci numbers, file encryption, the flame differential equation, the fractal fern, the Lorenz differential equation, a membrane partial differential equation, minimization of a scalar function, ordinary differential equations, the pendulum differential equation, piecewise Hermite cubic (PWH) interpolation, polynomial interpolation, quadrature for approximate integration, random number generation, tridiagonal linear system solution, the singular value decomposition, solution of a nonlinear equation.
nco, examples which use nco(), which works with data stored in netcdf() files.
ncview, examples which use ncview(), which reads the data in a netcdf() file, and allows 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 code which interpolates data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().
nearest_interp_1d, a C++ code which interpolates data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().
nearest_interp_1d, a Fortran77 code which interpolates data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().
nearest_interp_1d, a Fortran90 code which interpolates data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().
nearest_interp_1d, a MATLAB code which interpolates data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion.
nearest_interp_1d, an Octave code which interpolates data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion.
nearest_interp_1d, a Python code which interpolates data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion.
nearest_neighbor, a MATLAB code 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.
nearest_neighbor, an Octave code 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.
neighbor_risk, a MATLAB code which records information about neighboring pairs of territories in the game of RISK.
neighbor_risk, an Octave code which records information about neighboring pairs of territories in the game of RISK.
neighbor_states, a MATLAB code which creates a map of the US based only on information about neighboring pairs of states.
neighbor_states, an Octave code which creates a map of the US based only on information about neighboring pairs of states.
neighbor_states, a Python code which creates a map of the US based only on information about neighboring pairs of states.
neighbors_to_metis_graph, a C++ code which reads a file describing the neighbor structure of a mesh of triangles or tetrahedrons, 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 code which reads a file describing the neighbor structure of a mesh of triangles or tetrahedrons, 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 code which reads a file describing the neighbor structure of a mesh of triangles or tetrahedrons, and writes a metis graph file suitable for input to one of the family of programs based on metis.
nelder_mead, a MATLAB code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by Jeff Borggaard.
nested_sequence_display, a MATLAB code which displays nested sequences.
netcdf, a data directory which contains examples of netcdf() files, a format for the interchange of scientific data.
netcdf_test, a C code which reads and writes netcdf() files.
netcdf_test, a C++ code which reads and writes netcdf() files.
netcdf, examples which use netcdf(), which creates portable data files.
netcdf, a Fortran77 code which reads and writes netcdf() files.
netcdf_test, a Fortran90 code which reads and writes netcdf() files.
netcdf_test, a MATLAB code which reads and writes netcdf() files.
netcdf-c, a C code which uses netcdf-c, which is a C interface to netcdf().
netcdf-c-par, a C code which uses netcdf-c-par, which is a C interface to the parallel version of netcdf().
netcdf-cxx, a C++ code which uses netcdf-cxx, which is the C++ interface to netcdf().
netcdf-f90, a Fortran90 code which uses netcdf().
netcdf_mpas a C++ code which reads MPAS grid files, stored using the netcdf() format.
netcdf_mpas a MATLAB code 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 use netcdf-par(), which is the interface to the parallel netcdf().
netode, a Fortran77 code which models the time-dependent behavior of a two-phase fluid in an abstract network of nodes and links.
neumann, a FENICS code which solves a boundary value problem (BVP) in the unit square, for which homogeneous Neumann conditions are imposed, adapted from a code by Doug Arnold.
neural_network, a MATLAB code which illustrates the use of neural networks for deep learning, using back propagation and stochastic gradient descent, by Catherine Higham and Desmond Higham.
neural_network, an Octave code which illustrates the use of neural networks for deep learning, using back propagation and stochastic gradient descent, by Catherine Higham and Desmond Higham.
neural_network, a Python code which illustrates the use of neural networks for deep learning, using back propagation and stochastic gradient descent, by Catherine Higham and Desmond Higham.
newswire, a keras code which sets up a neural network to classify Reuters newswires as one of 46 categories.
newton, a Python code which uses the Newton method to solve a single nonlinear equation f(x)=0.
newton, an R code which seeks a root of a single nonlinear function using the Newton method.
newton_cotes, a Mathematica code which computes a Newton-Cotes quadrature rule.
newton_interp_1d, a C code which finds a polynomial interpolant to data using Newton divided differences.
newton_interp_1d, a C++ code which finds a polynomial interpolant to data using Newton divided differences.
newton_interp_1d, a Fortran90 code which finds a polynomial interpolant to data using Newton divided differences.
newton_interp_1d, a MATLAB code which finds a polynomial interpolant to data using Newton divided differences.
newton_interp_1d, an Octave code which finds a polynomial interpolant to data using Newton divided differences.
newton_interp_1d, a Python code which finds a polynomial interpolant to data using Newton divided differences.
newton_rc, a Fortran77 code which demonstrates the use of the Newton method to solve a system of nonlinear equations, using reverse communication (RC).
newton_rc, a Fortran90 code which solves a system of nonlinear equations by Newton's method, using reverse communication (RC).
newton_rc, a MATLAB code which solves a system of nonlinear equations by Newton's method, using reverse communication (RC).
ngrams, a Python code which analyzes 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++ code which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence, for an arbitrary base.
niederreiter, a Fortran90 code 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++ code which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.
niederreiter2, a Fortran90 code which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.
niederreiter2, a MATLAB code which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.
niederreiter2, an Octave code which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.
niederreiter2_dataset, a C++ code which creates a Miederreiter Quasi Monte Carlo (QMC) dataset with base 2;
niederreiter2_dataset, a Fortran90 code which creates a Niederreiter Quasi Monte Carlo (QMC) dataset with base 2;
niederreiter2_dataset, a MATLAB code which creates a Niederreiter Quasi Monte Carlo (QMC) dataset with base 2;
nint_exactness_mixed, a C++ code which measures the exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.
nint_exactness_mixed, a Fortran90 code which measures the exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.
nint_exactness_mixed, a MATLAB code which measures the exactness of an M-dimensional quadrature rule based on a mixture of 1D quadrature rule factors.
nintlib, a C code which estimates integrals over M-dimensional regions.
nintlib, a C++ code which estimates integrals over M-dimensional regions.
nintlib, a Fortran77 code which estimates integrals over M-dimensional regions.
nintlib, a Fortran90 code which estimates integrals over M-dimensional regions.
nintlib, a MATLAB code which estimates integrals over M-dimensional regions.
nintlib, an Octave code which estimates integrals over M-dimensional regions.
nl2sol, a Fortran77 code which implements an adaptive nonlinear least squares (NLS) algorithm, by John Dennis, David Gay, and Roy welsch.
nl2sol, a Fortran90 code which implements an adaptive nonlinear least squares (NLS) algorithm, by John Dennis, David Gay, and Roy welsch.
nms, a Fortran77 code which includes a wide variety of numerical software, including solvers for linear systems of equations, a piecewise Hermie cubic (PWH) interpolation package (PCHIP), numerical quadrature, linear least squares (LLS) data fitting, the solution of nonlinear equations, ordinary differential equations (ODE), optimization and nonlinear least squares (NLS), simulation and random numbers, trigonometric approximation and Fast Fourier Transforms (FFT).
nms, a Fortran90 code which includes a wide variety of numerical software, including solvers for linear systems of equations, a Piecewise Hermite Cubic (PWH) Interpolation Package (PCHIP), numerical quadrature, linear least squares (LLS) data fitting, the solution of nonlinear equations, ordinary differential equations (ODE), optimization and nonlinear least squares (NLS), simulation and random numbers, trigonometric approximation and Fast Fourier Transforms (FFT).
nn, an R code which does nearest neighbor interpolation.
nonlin_bisect, a MATLAB code which interactively uses bisection to seek a zero of a function f(x) within a domain a ≤ x ≤ b;
nonlin_bisect, an Octave code which interactively uses bisection to seek a zero of a function f(x) within a domain a ≤ x ≤ b;
nonlin_fixed_point, a MATLAB code which interactively uses fixed point iteration x=g(x) to seek a zero of a function f(x) given a starting point x0 and iterations it;
nonlin_fixed_point, an Octave code which interactively uses fixed point iteration x=g(x) to seek a zero of a function f(x) given a starting point x0 and iterations it;
nonlin_newton, a MATLAB code which interactively uses the Newton method to find the zero of a function, given formulas for f(x), f'(x), and a starting point.
nonlin_newton, an Octave code which interactively uses the Newton method to find the zero of a function, given formulas for f(x), f'(x), and a starting point.
nonlin_regula, a MATLAB code which interactively uses the regula falsi method to seek a zero of a function f(x) within a change of sign interval [a,b];
nonlin_regula, an Octave code which interactively uses the regula falsi method to seek a zero of a function f(x) within a change of sign interval [a,b];
nonlin_secant, a MATLAB code which interactively uses the secant method to seek a zero of a function f(x) given two starting estimates a and b.
nonlin_secant, an Octave code which interactively uses the secant method to seek a zero of a function f(x) given two starting estimates a and b.
nonlin_snyder, a MATLAB code which interactively uses Snyder's variation of the regula falsi method to seek a zero of a function f(x) within a change of sign interval [a,b];
nonlin_snyder, an Octave code which interactively uses Snyder's variation of the regula falsi method to seek a zero of a function f(x) within a change of sign interval [a,b];
norm_l1, a MATLAB code which interactively estimates the L1 norm of a function over an interval [A,B], with the function entered as a string.
norm_l1, an Octave code which interactively estimates the L1 norm of a function over an interval [A,B], with the function entered as a string.
norm_l2, a MATLAB code which interactively estimates the L2 norm of a function over an interval [A,B], with the function entered as a string.
norm_l2, an Octave code which interactively estimates the L2 norm of a function over an interval [A,B], with the function entered as a string.
norm_loo, a MATLAB code which interactively estimates the L-infinity norm of a function over an interval [A,B], with the function entered as a string.
norm_loo, an Octave code which interactively estimates the L-infinity norm of a function over an interval [A,B], with the function entered as a string.
norm_rms, a MATLAB code which interactively estimates the root mean square (RMS) norm of a function over an interval [A,B], with the function entered as a string.
norm_rms, an Octave code which interactively estimates the root mean square (RMS) norm of a function over an interval [A,B], with the function entered as a string.
normal, a C code which contains random number generators (RNG) for normally distributed values.
normal, a C++ code which contains random number generators (RNG) for normally distributed values.
normal, a Fortran77 code which contains random number generators (RNG) for normally distributed values.
normal, a Fortran90 code which contains random number generators (RNG) for normally distributed values.
normal, a MATLAB code which contains random number generators (RNG) for normally distributed values.
normal, an Octave code which contains random number generators (RNG) for normally distributed values.
normal, a Python code which contains random number generators (RNG) for normally distributed values.
normal_dataset, a C++ code 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 code 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 code which uses a normal random number generator (RNG) to create a dataset of M-dimensional values and writes them to a file.
normal_dataset, an Octave code 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 Python code which uses a normal random number generator (RNG) to create a dataset of M-dimensional values and writes them to a file.
normal_ode, a MATLAB code which sets up an ordinary differential equation (ODE) for the normal probability density function (PDF).
normal_ode, an Octave code which sets up an ordinary differential equation (ODE) for the normal probability density function (PDF).
normal_ode, a Python code which sets up an ordinary differential equation (ODE) for the normal probability density function (PDF).
normal01_multivariate_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from an isotropic standard normal distribution in M dimensions.
normal01_multivariate_distance_test
normal01_multivariate_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from an isotropic standard normal distribution in M dimensions.
normal01_multivariate_distance_test
normal01_multivariate_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected from an isotropic standard normal distribution in M dimensions.
ns3d_fem, a MATLAB code which sets up a finite element method (FEM) formulation of the steady (time independent) incompressible 3D Navier Stokes equations (NSE) on a user-defined geometry. The program outputs graphics files for tecplot(), VU or the VTK format used by the paraview interactive visualization program. The code is by Jeff Borggaard.
nsasm, a C code 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 the MATLAB mex compiler and called from a MATLAB main program. The code is by Per-Olof Persson.
nsasm, a Fortran90 code 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 code which carries out the iterative solution of large nonsymmetric systems of linear equations. The package includes a variety of matrix storage formats, preconditioners, and solvers.
nspcg, a Fortran90 code which carries out the iterative solution of large nonsymmetric systems of linear equations. The package includes a variety of matrix storage formats, preconditioners, and solvers.
nswc, a Fortran90 code which includes an extensive set of routines for a wide range of computational activities, compiled by Alfred Morris.
nth_root, an R code which uses the Newton method to find the n-th root of a number.
numgrid, a MATLAB code which defines and numbers a subset of the nodes in a regular nxn grid of the [-1,+1]x[-1,+1] unit square. MATLAB includes a built-in version of this function.
numgrid, an Octave code which defines and numbers a subset of the nodes in a regular nxn grid of the [-1,+1]x[-1,+1] unit square.
numgrid, a Python code which defines and numbers a subset of the nodes in a regular nxn grid of the [-1,+1]x[-1,+1] unit square.
numpy, a Python code which uses numpy(), which supplies numerous numerical algorithms.
obj, a data directory which contains examples of OBJ files, a Wavefront file format for 3D graphics;
obj_display, a MATLAB code which reads an OBJ 3D graphics file and displays it on the screen.
obj_display, an Octave code which reads an OBJ 3D graphics file and displays it on the screen.
obj_io, a C++ code which reads and writes the 3D graphics information in an Alias OBJ file;
obj_io, a Fortran90 code which reads and writes the 3D graphics information in an Alias OBJ file;
obj_io, a MATLAB code which reads and writes the 3D graphics information in an Alias OBJ file;
obj_io, an Octave code which reads and writes the 3D graphics information in an Alias OBJ file;
obj_to_tri_surface, a MATLAB code which reads an OBJ file and extracts the surface mesh data as a tri_surface dataset.
obj_to_tri_surface, an Octave code which reads an OBJ file and extracts the surface mesh data as a tri_surface dataset.
octave, an Octave code which illustrate the use of this interactive program for numerical and scientific calculation.
octave_combinatorics, an Octave code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
octave_distance, an Octave code which estimates the typical distance between a pair of points randomly selected from the surface or interior of a geometric object such as a circle, disk, sphere, cube, and between other nongeometric pairs of items..
octave_exact, an Octave code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
octave_grid, an Octave code which generates a regular grid of points inside a variety of regions in one, two, three or many dimensions.
octave_monte_carlo, an Octave code which uses Monte Carlo sampling to estimate areas and integrals.
octave_ode, an Octave code which sets up various ordinary differential equations (ODE).
octave_plots, an Octave code which uses plotting to illustrate a mathematical structure, such as an iterative map, a fractal, a curve or surface.
octave_polynomial, an Octave code which analyzes a variety of polynomial families, returning the polynomial values, coefficients, derivatives, integrals, roots, or other information.
octave_rule, an Octave code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as, a circle, a disk, an ellipse, a triangle, a quadrilateral, a polygon, a sphere, a ball, a hypercube, and which might include an associated weight function w(x).
octave_simulation, an Octave code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
octopus, a MATLAB code which contains some Octave-specific utilities.
octopus, an Octave code which contains some Octave-specific utilities.
ode, a C code which solves a system of ordinary differential equations (ODE), by Shampine and Gordon.
ode, a C++ code which solves a system of ordinary differential equations (ODE), by Shampine and Gordon.
ode, a Fortran77 code which solves a system of ordinary differential equations (ODE), by Shampine and Gordon.
ode, a Fortran90 code which solves a system of ordinary differential equations (ODE), by Shampine and Gordon.
ode_euler, a MATLAB code which interactively applies the Euler method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_euler, an Octave code which interactively applies the Euler method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_euler, a Python code which applies the Euler method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_euler_backward, a MATLAB code which interactively applies the backward Euler method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_euler_backward, an Octave code which interactively applies the backward Euler method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_euler_system, a MATLAB code which interactively applies the Euler method to estimate the solution of a system of ordinary differential equations (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_euler_system, an Octave code which interactively applies the Euler method to estimate the solution of a system of ordinary differential equations (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_midpoint, a MATLAB code which interactively applies the midpoint method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_midpoint, an Octave code which interactively applies the midpoint method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_midpoint_system, a MATLAB code which interactively applies the midpoint method to estimate the solution of a system of ordinary differential equations (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_midpoint_system, an Octave code which interactively applies the midpoint method to estimate the solution of a system of ordinary differential equations (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_moshier, a C code which implements the Adams-Bashforth-Moulton and Runge-Kutta (RK) methods of solving systems of ordinary differential equations (ODE), by Steven Moshier.
ode_rk4, a MATLAB code which interactively applies a fourth order Runge-Kutta method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_rk4, an Octave code which interactively applies a fourth order Runge-Kutta method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_sweep_parfor, a MATLAB code which demonstrates how the parfor() command parallelizes the computation of a grid of solutions to a parameterized system of ordinary differential equations (ODE).
ode_trapezoidal, a MATLAB code which interactively applies the trapezoidal method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode_trapezoidal, an Octave code which interactively applies the trapezoidal method to estimate the solution of an ordinary differential equation (ODE) y'=f(x,y), over the interval [a,b], with initial condition y(a)=ya, using n steps.
ode23_test, a MATLAB code which calls ode23(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 2 and 3.
ode23_test, an Octave code which calls ode23(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 2 and 3.
ode45_test, a MATLAB code which calls ode45(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 4 and 5.
ode45_test, an Octave code which calls ode45(), which is a built-in function for the adaptive solution of systems of ordinary differential equations (ODE) using a pair of Runge-Kutta solvers of orders 4 and 5.
odefun_test, a Python code which uses odefun() from the multiple precision package mpmath() to solve some simple ordinary differential equations (ODE).
odepack, a Fortran77 code which contains nine solvers for ordinary differential equations (ODE), including LSODE, LSODES, LSODA, LSODAR, LSODPK, LSODKR, LSODI, LSOIBT, and LSODIS, by Alan Hindmarsh.
oned, a MATLAB code which contains functions useful for 1D finite element method (FEM) calculations, by Jeff Borggaard.
openblas, examples which use openblas, which is a version of the Basic Linear Algebra Subprogram (BLAS) package based on the GotoBLAS2.
opencv, examples which use opencv(), which includes many features for image input, conversion, and output, various kinds of image manipulation and processing, structural analysis, calibration, motion tracking, and object recognition.
opengl_test, a C code which uses opengl() for graphics;
opengl_test, a C++ code which uses opengl() for graphics;
openmp_test, a C code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment.
openmp_test, a C++ code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment.
openmp_test, a Fortran77 code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment.
openmp_test, a Fortran90 code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment.
openmp_rcc, a C code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment, on the FSU High Performance Computing (HPC) cluster operated by the Research Computing Center (RCC).
openmp_rcc, a C++ code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment, on the FSU High Performance Computing (HPC) cluster operated by the Research Computing Center (RCC).
openmp_rcc, a Fortran90 code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment, on the FSU High Performance Computing (HPC) cluster operated by the Research Computing Center (RCC).
openmp_stubs, a C code which implements a stub version of OpenMP, so that an OpenMP program may be compiled, linked and executed on a system that does not have OpenMP installed.
openmp_stubs, a C++ code which implements a stub version of OpenMP, so that an OpenMP program may be compiled, linked and executed on a system that does not have OpenMP installed.
openmp_stubs, a Fortran77 code which implements a stub version of OpenMP, so that an OpenMP program may be compiled, linked and executed on a system that does not have OpenMP installed.
openmp_stubs, a Fortran90 code which implements a stub version of OpenMP, so that an OpenMP program may be compiled, linked and executed on a system that does not have OpenMP installed.
openmpi, examples which use OPENMPI, which is an implementation of the MPI interface for parallel programming.
openmpi-test: examples which use OPENMPI-test, which is one of several implementations of the MPI interface for parallel programming with distributed memory.
opt_golden, a MATLAB code which interactively estimates a minimizer of a function f(x) over the interval [a,b], assuming f(x) is unimodular (U-shaped) over the interval [a,b].
opt_golden, an Octave code which interactively estimates a minimizer of a function f(x) over the interval [a,b], assuming f(x) is unimodular (U-shaped) over the interval [a,b].
opt_gradient_descent, a MATLAB code which interactively seeks a local minimum of a function f(x), given a formula for the derivative f'(x), a starting point x0, and a stepsize factor gamma.
opt_gradient_descent, an Octave code which interactively seeks a local minimum of a function f(x), given a formula for the derivative f'(x), a starting point x0, and a stepsize factor gamma.
opt_quadratic, a MATLAB code which interactively uses quadratic interpolation to estimate a critical point of a function f(x) given three starting points, an iteration limit n, and tolerances for x and y.
opt_quadratic, an Octave code which interactively uses quadratic interpolation to estimate a critical point of a function f(x) given three starting points, an iteration limit n, and tolerances for x and y.
opt_sample, a MATLAB code which interactively estimates the minimum and maximum of a function f(x) over an interval [a,b], using n random sample values, with the function entered as a string.
opt_sample, an Octave code which interactively estimates the minimum and maximum of a function f(x) over an interval [a,b], using n random sample values, with the function entered as a string.
optimal_control_1d, a MATLAB code which seeks the optimal control function for a 1-dimensional system which is represented using the finite element method (FEM);
optimize_test, a C code which looks at the use of automatic optimization by the compiler to make the executable code run faster.
optimize_test, a C++ code which looks at the use of automatic optimization by the compiler to make the executable code run faster.
optimize_test, a Fortran77 code which looks at the use of automatic optimization by the compiler to make the executable code run faster.
optimize_test, a Fortran90 code which looks at the use of automatic optimization by the compiler to make the executable code run faster.
oregonator_ode, a MATLAB code which sets up the ordinary differential equations (ODE) for the Oregonator, a model of the Belousov-Zhabotinsky chemical reaction.
oregonator_ode, an Octave code which sets up the ordinary differential equations (ODE) that define the Oregonator, a model of the Belousov-Zhabotinsky chemical reaction.
oregonator_ode, a Python code which sets up the ordinary differential equations (ODE) for the Oregonator, a model of the Belousov-Zhabotinsky chemical reaction.
ornstein_uhlenbeck, a C code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().
ornstein_uhlenbeck, a C++ code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().
ornstein_uhlenbeck, a Fortran77 code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().
ornstein_uhlenbeck, a Fortran90 code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().
ornstein_uhlenbeck, a MATLAB code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method.
ornstein_uhlenbeck, an Octave code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method.
ornstein_uhlenbeck, a Python code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method.
oscillator_ode, a MATLAB code which sets up the highly oscillatory ordinary differential equation (ODE).
oscillator_ode, an Octave code which sets up the highly oscillatory ordinary differential equation (ODE).
oscillator_ode, a Python code which sets up the highly oscillatory ordinary differential equation (ODE).
outliers_test, a MATLAB code which uses the isoutlier() function, and other techniques, to identify outliers in data.
owen, a C code which evaluates the Owen T function.
owen, a C++ code which evaluates the Owen T function.
owen, a Fortran77 code which evaluates the Owen T function.
owen, a Fortran90 code which evaluates the Owen T function.
owen, a MATLAB code which evaluates the Owen T function.
owen, a Python code which evaluates the Owen T function.
ozone_ode, a MATLAB code which sets up a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration.
ozone_ode, an Octave code which sets up a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration.
ozone_ode, a MATLAB code which sets up a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration.
ozone2_ode, a MATLAB code which sets up a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration. This version of the ozone ODE includes a nitrogen oxide source term.
ozone2_ode, an Octave code which sets up a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration. This version of the ozone ODE includes a nitrogen oxide source term.
ozone2_ode, a Python code which sets up a stiff system of four ordinary differential equations (ODE) that simulate the daily variation in atmospheric ozone concentration. This version of the ozone ODE includes a nitrogen oxide source term.
p_laplacian, a FENICS code which sets up the nonlinear p-laplacian PDE in the unit square.
padua, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code 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 code which uses the eigenvalue (power method) and surfer (Markov Chain Monte Carlo MCMC) approaches to ranking web pages.
pagerank, an Octave code which uses the eigenvalue (power method) and surfer (Markov Chain Monte Carlo MCMC) approaches to ranking web pages.
pagerank, a Python code which uses the eigenvalue (power method) and surfer (Markov Chain Monte Carlo MCMC) approaches to ranking web pages.
pagerank2, a MATLAB code which applies the page rank algorithm to a problem.
pages, a C++ code which counts pages (sets of 60 lines) in a file;
paraheat_gaussian, a MATLAB code which sets up a parameterized steady heat equation in a 2D spatial domain, with a gaussian diffusivity.
paraheat_gaussian_parameter, a keras code which reads data for the heat equation with a parameterized gaussian diffusivity, and uses a neural network to estimate a single parameter from solution values at sensor locations.
paraheat_gaussian_parameters, a keras code which reads data for the heat equation with a parameterized gaussian diffusivity, and uses a neural network to estimate four parameters from solution values at sensor locations.
paraheat_gaussian_plot, a MATLAB code which uses radial basis functions (RBF) to reconstruct the finite element solution sampled by paraheat_gaussian().
paraheat_gaussian_sample, a MATLAB code which repeatedly calls paraheat_gaussian() to set up and solve a parameterized steady heat equation in a 2D spatial domain, with a gaussian diffusivity, saving values of the finite element solution at selected points, and writing the saved data to a file.
paraheat_pwc, a MATLAB code which sets up a parameterized steady heat equation in a 2D spatial domain, using diffusivity parameterized by vc, and reporting solution values vs at selected sensor locations. Options allow for this function to be sampled at many parameter values, or for the finite element function to be reconstructed from the sensor values.
paraheat_pwc_1d, a MATLAB code which sets up a parameterized steady heat equation in a 1D spatial domain, with a piecewise constant (PWC) diffusivity.
paraheat_pwc_plot, a MATLAB code which uses radial basis functions (RBF) to reconstruct the finite element solution sampled by paraheat_pwc().
paraheat_pwc_sample, a MATLAB code which repeatedly calls paraheat_pwc() to set up and solve a parameterized steady heat equation in a 2D spatial domain, with a piecewise constant (PWC) diffusivity, saving values of the finite element solution at selected points, and writing the saved data to a file.
parallel, examples which uses GNU PARALLEL, which is the GNU parallel command for executing shell shell scripts in parallel.
parallel_matlab, examples which use the MATLAB Parallel Computing Toolbox.
paranoia, a C code which checks the accuracy of floating point arithmetic on a given computer, by William Kahan.
paranoia, a Fortran77 code which checks the accuracy of floating point arithmetic on a given computer, by William Kahan.
paranoia, a Fortran90 code which checks the accuracy of floating point arithmetic on a given computer, by William Kahan.
paraview, examples which use paraview(), which is an interactive visualization program.
pariomino, a MATLAB code which considers pariominoes, which are polyominoes with a checkerboard parity, and the determination of tilings of a region using a specific set of pariominoes.
pariomino, an Octave code which considers pariominoes, which are polyominoes with a checkerboard parity, and the determination of tilings of a region using a specific set of pariominoes.
pariomino, a Python code which considers pariominoes, which are polyominoes with a checkerboard parity, and the determination of tilings of a region using a specific set of pariominoes.
parmetis, a C code which partitions the nodes of a graph in a balanced way, useful for parallel processing;
parmetis, examples which use parmetis(), which partitions the nodes of a graph or reorders the variables in a sparse matrix to minimize fillin, by George Karypis.
partial_digest, a C code which solves the partial digest problem.
partial_digest, a C++ code which solves the partial digest problem.
partial_digest, a Fortran90 code which solves the partial digest problem.
partial_digest, a MATLAB code which solves the partial digest problem.
partial_digest, an Octave code which solves the partial digest problem.
partial_digest, a Python code which solves the partial digest problem.
partition_brute, a C code which uses a brute force method to find solutions of the partition problem, in which a set of integers must be split into two subsets with equal sum.
partition_brute, a C++ code which uses a brute force method to find solutions of the partition problem, in which a set of integers must be split into two subsets with equal sum.
partition_brute, 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_brute, a Fortran77 code which uses a brute force method to find solutions of the partition problem, in which a set of integers must be split into two subsets with equal sum.
partition_brute, a Fortran90 code which uses a brute force method to find solutions of the partition problem, in which a set of integers must be split into two subsets with equal sum.
partition_brute, a MATLAB code which uses brute force to find solutions of the partition problem, in which a set of integers must be split into two subsets with equal sum.
partition_brute, an Octave code which uses a brute force method to find solutions of the partition problem, in which a set of integers must be split into two subsets with equal sum.
partition_brute, a Python code which uses a brute force method to find solutions of the partition problem, in which a set of integers must be split into two subsets with equal sum.
partition_greedy, a MATLAB code which uses a greedy algorithm to seek a solution of the partition problem, in which a given set of integers is to be split into two groups whose sums are as close as possible.
partition_greedy, an Octave code which uses a greedy algorithm to seek a solution of the partition problem, in which a given set of integers is to be split into two groups whose sums are as close as possible.
partition_greedy, a Python code which uses a greedy algorithm to seek a solution of the partition problem, in which a given set of integers is to be split into two groups whose sums are as close as possible.
patterson_rule, a C code which returns a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
patterson_rule, a C++ code which returns a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
patterson_rule, a Fortran77 code which returns a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
patterson_rule, a Fortran90 code which returns a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
patterson_rule, a MATLAB code which returns a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
patterson_rule, an Octave code which returns a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
patterson_rule, a Python code which returns a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
patterson_rule_compute, a Fortran90 code which computes a Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
pblas, a Fortran90 code 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 code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
pbma_io, a C++ code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
pbma_io, a Fortran77 code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
pbma_io, a Fortran90 code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
pbma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
pbma_io, an Octave code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
pbma_io, a Python code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
pbma_to_pbmb, a C++ code 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 code which handles the binary Portable Bit Map (PBM) format.
pbmb_io, a C++ code which handles the binary Portable Bit Map (PBM) format.
pbmb_io, a Python code which handles the binary Portable Bit Map (PBM) format.
pbmb_to_pbma, a C++ code which converts a binary Portable Bit Map (PBM) file to an ASCII PBM file;
pbmlib, a C code which reads or writes graphics files in the Portable Bit Map (PBM) format;
pbmlib, a Fortran90 code which reads or writes graphics files in the Portable Bit Map (PBM) format;
pbs, examples which use PBS, which is the Portable Batch Scheduler, as implemented at the Pittsburgh Supercomputing Center.
pce_burgers, a C code which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
pce_burgers, a C++ code which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
pce_burgers, a Fortran77 code which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
pce_burgers, a Fortran90 code which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
pce_burgers, a MATLAB code which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
pce_burgers, an Octave code which defines and solves the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
pce_legendre, a MATLAB code which assembles the system matrix of a 2D stochastic partial differential equation (PDE), using a polynomal chaos expansion (PCE) in terms of Legendre polynomials;
pce_legendre, an Octave code which assembles the system matrix of a 2D stochastic partial differential equation (PDE), using a polynomal chaos expansion (PCE) in terms of Legendre polynomials;
pce_ode_hermite, a C code which sets up a simple scalar stochastic ordinary differential equation (SDE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
pce_ode_hermite, a C++ code which sets up a simple scalar stochastic ordinary differential equation (SDE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
pce_ode_hermite, a Fortran77 code which sets up a simple scalar stochastic ordinary differential equation (SDE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
pce_ode_hermite, a Fortran90 code which sets up a simple scalar stochastic ordinary differential equation (SDE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
pce_ode_hermite, a MATLAB code which sets up a simple scalar stochastic ordinary differential equation (SDE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
pce_ode_hermite, an Octave code which sets up a simple scalar stochastic ordinary differential equation (SDE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
pcg_basic, a C code which returns a sequence of uniformly distributed pseudorandom numbers, by Melissa O'Neill.
pcg_minimal, a C code which is a minimal implementation of a permuted congruential generator (PCG) of random numbers, by Melissa O'Neill.
pchip, a Fortran77 code which constructs a piecewise Hermite (PWH) cubic interpolant to data, by Fred Fritsch.
pchip, a Fortran90 code which constructs a piecewise Hermite (PWH) cubic interpolant to data, by Fred Fritsch.
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 code which reads a PCL file and extracts the numeric data;
pcl_read, a C++ code 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 PC Paintbrush().
pdb, a data directory which contains examples of Protein Data Base (PDB) files;
pdb_extract, a Fortran90 code which selects records from a Protein Data Base (PDB) file, and extract columns from those records;
pdb_read, a Fortran90 code which reads a Protein Data Base (PDB) file;
pdb_to_xyz, a Fortran90 code which copies the coordinates from the ATOM records of a Protein Data Base (PDB) file into an XYZ file;
pdepe_test, a MATLAB code which uses pdepe(), which solves time dependent boundary value problems (BVP) 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 code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
pdflib, a C++ code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
pdflib, a Fortran77 code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
pdflib, a Fortran90 code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
pdflib, a MATLAB code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
pdflib, an Octave code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
pdflib, a Python code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
peak_movie, a MATLAB code which creates a sequence of frames, and then an animation or movie from the data displayed by the peaks() function.
pendulum_comparison_ode, a MATLAB code which compares the linear and nonlinear ordinary differential equations (ODE) that represent the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_comparison_ode, an Octave code which compares the linear and nonlinear ordinary differential equations (ODE) that represent the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_double_ode, a MATLAB code which sets up the double pendulum ordinary differential equation (ODE).
pendulum_double_ode, an Octave code which sets up the double pendulum ordinary differential equation (ODE).
pendulum_double_ode, a Python code which defines the double pendulum ordinary differential equation (ODE).
pendulum_double_ode_movie, a MATLAB code which sets up the double pendulum ordinary differential equation (ODE) for a given set of initial conditions and parameters, and makes a movie of the results.
pendulum_double_ode_movie_test
pendulum_elastic_ode a MATLAB code which sets up the ordinary differential equations (ODE) that represent the behavior of a nonlinear elastic pendulum, with gravitational force G, spring constant K, unstretched length L, and mass M.
pendulum_elastic_ode an Octave code which sets up the ordinary differential equations (ODE) that represent the behavior of a nonlinear elastic pendulum, with gravitational force G, spring constant K, unstretched length L, and mass M.
pendulum_elastic_ode a Python code which sets up the ordinary differential equations (ODE) that represent the behavior of a nonlinear elastic pendulum, with gravitational force G, spring constant K, unstretched length L, and mass M.
pendulum_nonlinear_exact, a MATLAB code which evaluates an exact formula for the solution of the the ordinary differential equations (ODE) that represent the behavior of a nonlinear pendulum of length L under a gravitational force of strength G.
pendulum_nonlinear_exact, an Octave code which evaluates an exact formula for the solution of the the ordinary differential equations (ODE) that represent the behavior of a nonlinear pendulum of length L under a gravitational force of strength G.
pendulum_nonlinear_ode, a MATLAB code which sets up the ordinary differential equations (ODE) that represent a nonlinear model of the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_nonlinear_ode, an Octave code which sets up the ordinary differential equations (ODE) that represent a nonlinear model of the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_nonlinear_ode, a Python code which sets up the ordinary differential equations (ODE) that represent a nonlinear model of the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_ode, a MATLAB code which sets up the ordinary differential equations (ODE) that represent a linear model of the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_ode, an Octave code which sets up the ordinary differential equations (ODE) that represent a linear model of the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_ode, a Python code which sets up the ordinary differential equations (ODE) that represent a linear model of the behavior of a pendulum of length L under a gravitational force of strength G.
pendulum_ode_period, a MATLAB code which sets up a system of ordinary differential equations (ODE) that represent the behavior of a linear pendulum of length L under a gravitational force of strength G, in order to estimate the period of oscillation.
pendulum_ode_period, an Octave code which sets up a system of ordinary differential equations (ODE) that represent the behavior of a linear pendulum of length L under a gravitational force of strength G, in order to estimate the period of oscillation.
pentominoes, a C code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
pentominoes, a Fortran90 code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
pentominoes, a MATLAB code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
pentominoes, an Octave code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
pentominoes, a Python code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
perceptron_test, a MATLAB code which demonstrates the calculation of a classifier of linearly separable data using the perceptron algorithm, an example of machine learning.
perceptron_test, an Octave code which demonstrates the calculation of a classifier of linearly separable data using the perceptron algorithm, an example of machine learning.
perceptron, a Python code which demonstrates the calculation of a classifier of linearly separable data using the perceptron algorithm, an example of machine learning.
percolation_simulation, a MATLAB code which simulates a percolation system. A rectangular region is decomposed into a grid of MxN squares. Each square may be porous or solid. We are interested in a path of porous squares connecting the top and bottom, or the left and right boundaries. The original code was written by Ian Cooper.
percolation_simulation, an Octave code which simulates a percolation system. A rectangular region is decomposed into a grid of MxN squares. Each square may be porous or solid. We are interested in a path of porous squares connecting the top and bottom, or the left and right boundaries. The original code was written by Ian Cooper.
percolation_simulation, a Python code which simulates a percolation system. A rectangular region is decomposed into a grid of MxN squares. Each square may be porous or solid. We are interested in a path of porous squares connecting the top and bottom, or the left and right boundaries. The original code was written by Ian Cooper.
peri1d, a C code which sets up a 1D time-dependent peridynamics problem, by Miroslav Stoyanov;
peri2d, a C code which sets up a 2D time-dependent peridynamics problem, by Miroslav Stoyanov;
peridynamics_1d_steady, a MATLAB code 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 use PERL, which is a high level dynamic scripting language.
permutation_distance, a MATLAB code which estimates the expected value of the Ulam distance between a pair of randomly selected permutations of the same order.
permutation_distance, an Octave code which estimates the expected value of the Ulam distance between a pair of randomly selected permutations of the same order.
permutation_distance, a Python code which estimates the expected value of the Ulam distance between a pair of randomly selected permutations of the same order.
persistence, a C code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
persistence, a C++ code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
persistence, a Fortran90 code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
persistence, a MATLAB code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
persistence, an Octave code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
persistence, a Python code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
persistence, an R code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
petsc, examples which use PETSC, which is a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations (PDE).
petsc_test, a C code which uses PETSC, which is a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations (PDE).
petsc_test, a C++ code which uses PETSC, which is a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations (PDE).
petsc_test, a Fortran90 code which uses PETSC, which is a suite of data structures and routines for the scalable parallel solution of scientific applications modeled by partial differential equations (PDE).
pfort, a Fortran77 code which checks 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 use PGI, which is a family of 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 code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
pgma_io a C++ code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
pgma_io a Fortran77 code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
pgma_io, a Fortran90 code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
pgma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
pgma_io, an Octave code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
pgma_io, a Python code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
pgma_to_pgmb, a C++ code 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 code which handles the binary Portable Gray Map (PGM) format.
pgmb_io, a C++ code which handles the binary Portable Gray Map (PGM) format.
pgmb_io, a Python code which handles the binary Portable Gray Map (PGM) format.
pgmb_to_pgma, a C++ code which converts a binary Portable Gray Map (PGM) file to an ASCII PGM file;
pi_spigot, a MATLAB code which produces any number of digits of the decimal expansion of pi.
pi_spigot, an Octave code which produces any number of digits of the decimal expansion of pi.
pi_spigot, a Python code which produces any number of digits of the decimal expansion of pi.
pic, a MATLAB code which uses the Particle In Cell (PIC) method to simulate the motion of electrically charged particles past a plate, and is intended as a starting point for implementing a parallel version.
pic, an Octave code 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.
pig_latin, a C code which converts its input to Pig Latin; this code is a winner of the International Obfuscated C Code Competition in the Most Humorous category, by Don Dodson.
pink_noise, a C code which computes a pink noise signal obeying a 1/f power law.
pink_noise, a C++ code which computes a pink noise signal obeying a 1/f power law.
pink_noise, a Fortran77 code which computes a pink noise signal obeying a 1/f power law.
pink_noise, a Fortran90 code which computes a pink noise signal obeying a 1/f power law.
pink_noise, a MATLAB code which computes a pink noise signal obeying a 1/f power law.
pink_noise, an Octave code which computes a pink noise signal obeying a 1/f power law.
pink_noise, a Python code which computes a pink noise signal obeying a 1/f power law.
pitcon66, a Fortran77 code which seeks to produce a sequence of points that satisfy nonlinear equations with one degree of freedom; this is version 6.6 of ACM TOMS algorithm 596.
pitcon7, a Fortran90 code which seeks to produce a sequence of points that satisfy nonlinear equations with one degree of freedom; this is version 7.0 of ACM TOMS algorithm 596.
plasma_matrix, a MATLAB code which sets up a matrix associated with a problem in plasma physics.
plasma_matrix, an Octave code which sets up a matrix associated with a problem in plasma physics.
plasma_matrix, a Python code which sets up a matrix associated with a problem in plasma physics.
plato_ply, a C code which writes a PLY graphics file for any Platonic solid, by Greg Turk.
plc, directory of PLC data, which describe a piecewise linear complex (PLC), a surface that bounds a 3D region that is to be meshed.
plinth, a MATLAB code which interpolates data or a function by a hierarchical set of piecewise linear (PWL) functions.
plot_points, a Fortran90 code which makes an Encapsulated PostScript (EPS) plot of points in 2D.
plot_spmd, a MATLAB code which demonstrates the Single Program Multiple Data (SPMD) parallel model, by having labs compute parts of a sine plot, which is then displayed by the client process.
plot_test, a FreeFem++ code which investigates the plot() command;
plot_to_ps, a Fortran90 code 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 plot3d();
plot3d_io, a Fortran90 code which reads or writes a plot3d() graphics file;
plot3d_to_avs, a Fortran90 code 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 code which solves elliptic partial differential equations (PDE) using the finite element method (FEM), triangular elements, piecewise linear (PWL) basis functions, and the multigrid approach, by Randy Bank.
ply, a directory of PLY data, which describes 3D objects as a collection of polygons.
ply_display, a MATLAB code which displays an image of a 3D graphics file in PLY format;
ply_io, a C code which reads or writes a 3D graphics file in PLY format, by Greg Turk;
ply_io, a MATLAB code which reads or writes a 3D graphics file in PLY format, by Greg Turk;
ply_to_iv, a C code which converts a 3D graphics file from PLY format to Inventor (IV) format, by Greg Turk.
ply_to_obj, a C code which reads a PLY 3D graphics file and writes an equivalent OBJ graphics file, by Greg Turk.
ply_to_tri_surface, a MATLAB code 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++ code 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 code which reads and writes files in the Portable Network graphics (PNG) format.
pod_basis_flow, a Fortran90 code which extracts dominant solution modes from solutions of fluid flow governed by the Navier Stokes equations (NSE) using Proper Orthogonal Decomposition (POD).
point_merge, a C code which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.
point_merge, a C++ code which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.
point_merge, a Fortran77 code which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.
point_merge, a Fortran90 code which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.
point_merge, a MATLAB code which considers N points in M-dimensional space, and counts or indexes the unique or tolerably unique items.
poisson_1d, a FreeFem++ code which solves the Poisson equation in 1D. FreeFem++ doesn't expect to deal with 1D problems, so we have to make a 2D problem that is 1 element wide;
poisson_1d, a Python code which applies the finite difference method (FDM) to solve a two point Poisson boundary value problem (BVP) in one spatial dimension.
poisson_1d_multigrid, a C code which applies the multigrid method to a discretized version of the 1D Poisson equation.
poisson_1d_multigrid, a C++ code which applies the multigrid method to a discretized version of the 1D Poisson equation.
poisson_1d_multigrid, a Fortran77 code which applies the multigrid method to a discretized version of the 1D Poisson equation.
poisson_1d_multigrid, a Fortran90 code which applies the multigrid method to a discretized version of the 1D Poisson equation.
poisson_1d_multigrid, a MATLAB code which applies the multigrid method to a discretized version of the 1D Poisson equation.
poisson_1d_multigrid, an Octave code which applies the multigrid method to a discretized version of the 1D Poisson equation.
poisson_1d_multigrid, a Python code which applies the multigrid method to a discretized version of the 1D Poisson equation.
poisson_2d, a C code which computes an approximate solution to the Poisson equation in the unit square, using the finite difference method (FDM) and Jacobi iteration.
poisson_2d, a FENICS code which solves the Poisson equation on the unit square, adapted from the tutorial by Langtangen and Logg.
poisson_2d, a MATLAB code which computes an approximate solution to the Poisson equation in a rectangle, using the finite difference method (FDM) and Jacobi iteration.
poisson_2d, an Octave code which computes an approximate solution to the Poisson equation in a rectangle, using the finite difference method (FDM) and Jacobi iteration.
poisson_adaptive, a FreeFem++ code which repeatedly solves the Poisson equation in the L-shaped region, adaptively refining the mesh based on an error estimator;
poisson_ell, a FreeFem++ code which solves the Poisson equation in the L-shaped region, and writes the resulting data to files, using the ffmatlib() interface, for subsequent graphics processing by MATLAB or Octave.
poisson_ell_test, a MATLAB code which plots data from a solution of the Poisson equation in the L-shaped region, as computed by FreeFem++ and transferred using ffmatlib().
poisson_ell_test, an Octave code which plots data from a solution of the Poisson equation in the L-shaped region, as computed by FreeFem++() and transferred using ffmatlib().
poisson_mixed, a FENICS code which solves the Poisson equation using a mixed formulation.
poisson_mpi, a C code 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 code which uses the finite element method (FEM) to solve a version of the nonlinear Poisson equation over the unit square.
poisson_openmp, a C code which computes an approximate solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
poisson_openmp, a C++ code which computes an approximate solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
poisson_openmp, a Fortran77 code which computes an approximate solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
poisson_openmp, a Fortran90 code which computes an approximate solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
poisson_quadrilateral_mesh, a FENICS code which solves the Poisson equation on the unit square, using a mesh of quadrilateral elements.
poisson_serial, a C++ code 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 code 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 code 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 code 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++ code 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 code 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 code 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 code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda.
poisson_simulation, an Octave code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda.
poisson_simulation, a Python code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda.
poisson_source_symbolic, a FENICS code which shows how to symbolically determine the right hand side f(x,y) of a Poisson equation, given the desired exact solution u(x,y).
poisson_square, a FreeFem++ code which solves the Poisson equation in a square region;
polar_ode, a MATLAB code which sets up an ordinary differential equation (ODE) whose variable is complex, and whose solution should be viewed in a polar coordinate plot.
polar_ode, an Octave code which sets up an ordinary differential equation (ODE) whose variable is complex, and whose solution should be viewed in a polar coordinate plot.
polar_ode, a Python code which sets up an ordinary differential equation (ODE) whose variable is complex, and whose solution should be viewed in a polar coordinate plot.
polpak, a C code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert W, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Numbers, Tau, Tribonacci, Zernike.
polpak, a C++ code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert W, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Numbers, Tau, Tribonacci, Zernike.
polpak, a Fortran77 code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert W, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Numbers, Tau, Tribonacci, Zernike.
polpak, a Fortran90 code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert W, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Numbers, Tau, Tribonacci, Zernike.
polpak, a MATLAB code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert W, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Numbers, Tau, Tribonacci, Zernike.
polpak, an Octave code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert W, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Numbers, Tau, Tribonacci, Zernike.
polpak, a Python code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Hypergeometric 2F1, Jacobi, Krawtchouk, Laguerre, Lambert W, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling Numbers, Tau, Tribonacci, Zernike.
poly, a data directory which contains examples of POLY files, a 2D format used by Jonathan Shewchuk's triangle() and showme() programs, for Planar Straight Line Graphs (PSLG).
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 code which contains routines to read or write a POLY file.
polygon, a C code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
polygon, a C++ code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
polygon, a Fortran77 code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
polygon, a Fortran90 code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
polygon, a MATLAB code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
polygon, an Octave code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
polygon, a Python code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
polygon, a dataset directory which contains examples of polygons.
polygon_average, a MATLAB code which demonstrates a process of repeatedly averaging and normalizing the vertices of a polygon, illustrating a property of the power method.
polygon_average, an Octave code which demonstrates a process of repeatedly averaging and normalizing the vertices of a polygon, illustrating a property of the power method.
polygon_average, a Python code which demonstrates a process of repeatedly averaging and normalizing the vertices of a polygon, illustrating a property of the power method.
polygon_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected from a polygon in 2D.
polygon_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected from a polygon in 2D.
polygon_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected from a polygon in 2D.
polygon_grid, a C code which generates a grid of points over the interior of a polygon in 2D.
polygon_grid, a C++ code which generates a grid of points over the interior of a polygon in 2D.
polygon_grid, a Fortran77 code which generates a grid of points over the interior of a polygon in 2D.
polygon_grid, a Fortran90 code which generates a grid of points over the interior of a polygon in 2D.
polygon_grid, a MATLAB code which generates a grid of points over the interior of a polygon in 2D.
polygon_grid, an Octave code which generates a grid of points over the interior of a polygon in 2D.
polygon_grid, a Python code which generates a grid of points over the interior of a polygon in 2D.
polygon_integrals, a C code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
polygon_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
polygon_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
polygon_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
polygon_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
polygon_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
polygon_integrals, a Python code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
polygon_monte_carlo, a C code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
polygon_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
polygon_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
polygon_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
polygon_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
polygon_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
polygon_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
polygon_triangulate, a C code which triangulates a possibly nonconvex polygon, and which uses gnuplot() to display the external edges and internal diagonals of the triangulation.
polygon_triangulate, a C++ code which triangulates a possibly nonconvex polygon, and which uses gnuplot() to display the external edges and internal diagonals of the triangulation.
polygon_triangulate, a Fortran77 code which triangulates a possibly nonconvex polygon, and which uses gnuplot() to display the external edges and internal diagonals of the triangulation.
polygon_triangulate, a Fortran90 code which triangulates a possibly nonconvex polygon, and which uses gnuplot() to display the external edges and internal diagonals of the triangulation.
polygon_triangulate, a MATLAB code which triangulates a (possibly nonconvex) polygon, based on a C function by Joseph Orourke.
polygon_triangulate, an Octave code which triangulates a (possibly nonconvex) polygon, based on a C function by Joseph Orourke.
polygon_triangulate, a Python code which triangulates a (possibly nonconvex) polygon, based on a C function by Joseph Orourke.
polygonal_mesh, a FreeFem++ code which demonstrates how to create a region by specifying polygonal borders and then mesh it by calling buildmesh().
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 polygons of a fixed order, 3D graphics;
polygonal_surface_display, a MATLAB code which displays a surface in 3D described as polygons;
polygonal_surface_display_test
polygonal_surface_display, an Octave code which displays a surface in 3D described as polygons;
polygonal_surface_display_test
polygonal_surface_display_opengl, a C++ code which displays a surface in 3D described as polygons, using OpenGL.
polygonal_surface_display_opengl_test
polyiamonds, a MATLAB code which works with polyiamonds, simple shapes constructed by edgewise connections of congruent equilateral triangles.
polyiamonds, an Octave code which works with polyiamonds, simple shapes constructed by edgewise connections of congruent equilateral triangles.
polyinterp, an R code which sets up Vandermonde polynomial interpolation.
polynomial, a C code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
polynomial, a C++ code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
polynomial, a Fortran77 code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
polynomial, a Fortran90 code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
polynomial, a MATLAB code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
polynomial, an Octave code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
polynomial, a Python code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
polynomial_conversion, a C code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
polynomial_conversion, a C++ code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
polynomial_conversion, a Fortran77 code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
polynomial_conversion, a Fortran90 code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
polynomial_conversion, a MATLAB code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
polynomial_conversion, an Octave code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
polynomial_conversion, a Python code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
polynomial_multiply, a MATLAB code which multiplies two polynomials p(x) and q(x).
polynomial_multiply, an Octave code which multiplies two polynomials p(x) and q(x).
polynomial_multiply, a Python code which multiplies two polynomials p(x) and q(x).
polynomial_resultant, a MATLAB code which computes the resultant R of univariate polynomials P and Q.
polynomial_resultant, an Octave code which computes the resultant R of univariate polynomials P and Q.
polynomial_resultant, a Python code which computes the resultant R of univariate polynomials P and Q.
polynomial_resultant_symbolic_test, a MATLAB code which calls the symbolic function resultant() to compute the resultant R of univariate polynomials P and Q.
polynomial_resultant_symbolic, a Python code which uses the symbolic package sympy() to compute the resultant R of univariate polynomials P and Q.
polynomial_root_bound, a C code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
polynomial_root_bound, a C++ code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
polynomial_root_bound, a Fortran90 code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
polynomial_root_bound, a MATLAB code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
polynomial_root_bound, an Octave code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
polynomial_root_bound, a Python code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
polynomials, a Fortran90 code 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 code which defines multivariate polynomials over rectangular domains, for which certain information is to be determined, such as the maximum and minimum values.
polynomials, an Octave code 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 code 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 code 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++ code 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 code 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 code 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 code 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++ code 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 code 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 code 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 code which enumerates chiral, fixed and free polyominoes up to a moderate order.
polyomino_enumerate, a C++ code which enumerates chiral, fixed and free polyominoes up to a moderate order.
polyomino_enumerate, a Fortran90 code which enumerates chiral, fixed and free polyominoes up to a moderate order.
polyomino_enumerate, a Python code which enumerates chiral, fixed and free polyominoes up to a moderate order.
polyomino_index, a C code 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++ code 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 code 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 code 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 code 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++ code 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 code 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 code 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_parity, a MATLAB code which uses parity to determine whether a given set of polyominoes tile a specified region.
polyomino_parity, an Octave code which uses parity to determine whether a given set of polyominoes tile a specified region.
polyomino_parity, a Python code which uses parity to determine whether a given set of polyominoes tile a specified region.
polyomino_transform, a C code which applies reflection and rotation transforms to the matrix that represents a polyomino.
polyomino_transform, a C++ code which applies reflection and rotation transforms to the matrix that represents a polyomino.
polyomino_transform, a Fortran90 code which applies reflection and rotation transforms to the matrix that represents a polyomino.
polyomino_transform, a Python code which applies reflection and rotation transforms to the matrix that represents a polyomino.
polyominoes, a C code which provides some utilities for manipulating polyominoes.
polyominoes, a C++ code which provides some utilities for manipulating polyominoes.
polyominoes, a Fortran90 code which provides some utilities for manipulating polyominoes.
polyominoes, a MATLAB code 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, an Octave code 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, a Python code 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.
population, a dataset directory which contains population counts for various regions.
porous_medium_exact, a C code which returns an exact solution of the porous medium equation (PME), dudt=Del^2(u^m), a partial differential equation (PDE) related to the diffusion equation, based on the Barenblatt solution.
porous_medium_exact, a C++ code which returns an exact solution of the porous medium equation (PME), dudt=Del^2(u^m), a partial differential equation (PDE) related to the diffusion equation, based on the Barenblatt solution.
porous_medium_exact, a Fortran90 code which returns an exact solution of the porous medium equation (PME), dudt=Del^2(u^m), a partial differential equation (PDE) related to the diffusion equation, based on the Barenblatt solution.
porous_medium_exact, a MATLAB code which returns an exact solution of the porous medium equation (PME), dudt=Del^2(u^m), a partial differential equation (PDE) related to the diffusion equation, based on the Barenblatt solution.
porous_medium_exact, an Octave code which returns an exact solution of the porous medium equation (PME), dudt=Del^2(u^m), a partial differential equation (PDE) related to the diffusion equation, based on the Barenblatt solution.
porous_medium_exact, a Python code which returns an exact solution of the porous medium equation (PME), dudt=Del^2(u^m), a partial differential equation (PDE) related to the diffusion equation, based on the Barenblatt solution.
pov, a data directory which contains examples of the Persistence of Vision (POV) 3D graphics file format;
power_method, a C code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
power_method, a C++ code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
power_method, a Fortran77 code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
power_method, a Fortran90 code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
power_method, a MATLAB code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
power_method, an Octave code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
power_method, a Python code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
power_rule, a C code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
power_rule, a C++ code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
power_rule, a Fortran77 code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
power_rule, a Fortran90 code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
power_rule, a MATLAB code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
ppc_array, a C code which allocates and frees memory for vectors and matrices, for a variety of types, from Rouben Rostamian's "Programming Projects in C";
ppc_array_mine, a C code which is an alternate version of ppc_array(), which manages the allocation of arrays, from Rouben Rostamian's "Programming Projects in C";
ppc_bvp, a C code which solves a 1 dimensional boundary value problem (BVP), using triangle() for the mesh, the finite element method (FEM) for discretization, umfpack() to solve the linear system, and geomview() for visualization, from Rouben Rostamian's "Programming Projects in C";
ppc_evolution, a C code which simulates the process of evolution on a model world of creatures, from Rouben Rostamian's "Programming Projects in C";
ppc_evolution_io, a C code which reads or writes world data files in WDF format, used by ppc_evolution(), which simulates the process of evolution on a model world of creatures, from Rouben Rostamian's "Programming Projects in C";
ppc_fd1, a C code which solves the 1 dimensional time-dependent heat equation, using the finite difference method (FDM) for discretization, and offering a variety of solvers, including explicit, implicit, Crank-Nicolson, and Seidman sweep, from Rouben Rostamian's "Programming Projects in C";
ppc_fetch_line, a C code which transfers lines of text from a file to a buffer, trimming initial and trailing whitespace, and comments, from Rouben Rostamian's "Programming Projects in C";
ppc_fgets_demo, a C code which demonstrates how the fgets() function transfers data from a file to an internal C buffer, from Rouben Rostamian's "Programming Projects in C";
ppc_gauss_quad, a C code which implements Gauss quadrature rules for approximate integration, from Rouben Rostamian's "Programming Projects in C";
ppc_haar, a C code which applies forward and backward Haar transforms to vectors and matrices, from Rouben Rostamian's "Programming Projects in C";
ppc_image_analysis, a C code which analyzes and manipulates an image stored in PGM or PBM format, from Rouben Rostamian's "Programming Projects in C";
ppc_image_reduce, a C code which reduces the size of an image stored in PGM or PBM format, by applying a Haar transform and removing modes of low importance, from Rouben Rostamian's "Programming Projects in C";
ppc_ll, a C code which demonstrates the use of linked lists, from Rouben Rostamian's "Programming Projects in C";
ppc_mesh, a C code which uses a version of Jonathan Shewchuk's triangle() code to create a triangular mesh of a region bounded by a polygonal arc, and possibly including holes, from Rouben Rostamian's "Programming Projects in C";
ppc_nelder_mead, a C code which implements the Nelder-Mead moving simplex function minimization algorithm, from Rouben Rostamian's "Programming Projects in C";
ppc_netpbm, a C code which demonstrates the use of netpbm() to read and write images, from Rouben Rostamian's "Programming Projects in C";
ppc_netpbm_io, a C code which reads and writes netpbm() files in pgm or ppm format, from Rouben Rostamian's "Programming Projects in C";
ppc_netpbm_random, a C code which creates a random MxN array of 0's and 1's, regarded as a portable bit map (PBM) image, from Rouben Rostamian's "Programming Projects in C";
ppc_neural_ode, a C code which uses a neural network to model an ordinary differential equation and to approximate its solution, from Rouben Rostamian's "Programming Projects in C";
ppc_neural_pde, a C code which uses a neural network to model a partial differential equation and to approximate its solution, from Rouben Rostamian's "Programming Projects in C";
ppc_neural_pde_ell, a C code which calls ppc_neural_pde(), which uses a neural network to model a partial differential equation (PDE) in the form of a boundary value problem (BVP) posed in an L-shaped region and to approximate its solution, from Rouben Rostamian's "Programming Projects in C";
ppc_neural_pde_square, a C code which calls ppc_neural_pde(), which uses a neural network to model a partial differential equation (PDE) in the form of a boundary value problem (BVP) posed in a square region and to approximate its solution, from Rouben Rostamian's "Programming Projects in C";
ppc_neural_pde_square_hole, a C code which calls ppc_neural_pde(), which uses a neural network to model a partial differential equation (PDE) in the form of a boundary value problem (BVP) posed in a square region with a circular hole, and to approximate its solution, from Rouben Rostamian's "Programming Projects in C";
ppc_poisson, a C code which solves the 1 dimensional Poisson equation as a boundary value problem (BVP), using triangle() for the mesh, the finite element method (FEM) for discretization, umfpack() to solve the linear system, and geomview() for visualization, from Rouben Rostamian's "Programming Projects in C";
ppc_porous_medium, a C code which solves the porous medium equation, dudt=Del^2(u^m), from Rouben Rostamian's "Programming Projects in C";
ppc_sparse_matrix, a C code which packs a sparse MxN matrix into compressed column storage (CCS), or unpacks a compressed column storage matrix to MxN format, from Rouben Rostamian's "Programming Projects in C";
ppc_triangle, a C code which is the library version of Jonathan Shewchuk's triangle() code, for computing a triangular mesh from a given set of points, from Rouben Rostamian's "Programming Projects in C";
ppc_truss, a C code which models a truss structure under a load, from Rouben Rostamian's "Programming Projects in C";
ppc_truss_io, a C code which reads or writes a file defining a truss structure under a load, from Rouben Rostamian's "Programming Projects in C";
ppc_truss_to_eps, a C code which creates an Encapsulated PostScript image of a truss structure under a load, from Rouben Rostamian's "Programming Projects in C";
ppc_twb_quad, a C code which defines Taylor, Wingate, Bos quadrature rules for triangles, from Rouben Rostamian's "Programming Projects in C";
ppc_twb_quad_minimal, a C code which is a minimal demostration of Taylor, Wingate, Bos quadrature rules for triangles, from Rouben Rostamian's "Programming Projects in C";
ppc_umfpack_test, a C code which defines a sparse linear system and then requests a solution using umfpack(), from Rouben Rostamian's "Programming Projects in C";
ppc_xmalloc, a C code which manages the allocation of memory, from Rouben Rostamian's "Programming Projects in C";
pplane9, a MATLAB code which allows a user to interactively explore the phase plane of a system of autonomous ordinary differential equations (ODE). On starting, the user is given an interface in which to enter the equations and the screen limits, as well as a graphics screen on which the direction field is shown. Clicking any point in the graphics screen results in a trace of the phase plane curve through that point. The code is by Hugh Harvey and George Williams. With every new release of MATLAB, this program breaks again!
ppma, a data directory which contains examples of ASCII Portable Pixel Map (PPM) 2D graphics files;
ppma_io, a C code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
ppma_io a C++ code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
ppma_io, a Fortran77 code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
ppma_io, a Fortran90 code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
ppma_io, a MATLAB code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
ppma_io, an Octave code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
ppma_io, a Python code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
ppma_to_bmp, a C++ code which converts an ASCII Portable Pixel Map (PPM) graphics file to a BMP graphics file;
ppma_to_ppmb, a C++ code which converts an ASCII Portable Pixel Map (PPM) graphics file to a binary PPM file;
ppma_to_ppmb, a Fortran90 code 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 code which reads and writes binary Portable Pixel Map (PPM) graphics files.
ppmb_io, a C++ code which reads and writes binary Portable Pixel Map (PPM) graphics files.
ppmb_io, a Python code which reads and writes binary Portable Pixel Map (PPM) graphics files.
ppmb_to_bmp, a C++ code which converts a binary Portable Pixel Map (PPM) file to a BMP graphics file;
ppmb_to_ppma, a C++ code which converts a binary Portable Pixel Map (PPM) to an ASCII PPM graphics file;
pppack, a Fortran77 code which computes piecewise polynomial functions, including cubic splines, by Carl deBoor.
pppack, a Fortran90 code which computes piecewise polynomial functions, including cubic splines, by Carl deBoor.
pram, a MATLAB code which considers the pram puzzle, a smaller version of the eternity puzzle. The pram puzzle specifies a region R composed of 2304 30-60-90 triangles, and a set of 64 "tiles", consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
pram_cplex_test a BASH code which calls cplex(), to read the LP file defining the pram tiling problem, solve the linear programming problem, and write the solution to a file.
pram_view, a MATLAB code which considers the pram puzzle, and applies a given set of rotations, reflections and translations to the 64 tiles in order to reconstruct the pram region, thus verifying a known solution to the problem, as well as the correctness of the tile definitions.
praxis, a C code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
praxis, a C++ code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
praxis, a Fortran77 code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
praxis, a Fortran90 code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
praxis, a MATLAB code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
praxis, an Octave code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
praxis, a Python code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
predator_prey_ode, a C code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model, for which a limit cycle exists.
predator_prey_ode, a C++ code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model, for which a limit cycle exists.
predator_prey_ode, a Fortran90 code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model, for which a limit cycle exists.
predator_prey_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model, for which a limit cycle exists.
predator_prey_ode, an Octave code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model, for which a limit cycle exists.
predator_prey_ode, a Python code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model, for which a limit cycle exists.
predator_prey_ode_period, a MATLAB code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model in order to estimate the period of the limit cycle. The computation involves the Lambert W function.
predator_prey_ode_period, an Octave code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model in order to estimate the period of the limit cycle. The computation involves the Lambert W function.
predator_prey_ode_period, a Python code which sets up a system of ordinary differential equations (ODE) for a Lotka-Volterra predator prey model in order to estimate the period of the limit cycle. The computation involves the Lambert W function.
presidents, a dataset directory which contains data related to US presidents.
prime, a C code which counts primes between 1 and N, intended as a starting point for the creation of a parallel version.
prime, a C++ code which counts primes between 1 and N, intended as a starting point for the creation of a parallel version.
prime, a Fortran77 code which counts primes between 1 and N, intended as a starting point for the creation of a parallel version.
prime, a Fortran90 code which counts primes between 1 and N, intended as a starting point for the creation of a parallel version.
prime, a MATLAB code which counts primes between 1 and N, intended as a starting point for the creation of a parallel version.
prime, a Python code which counts the primes between 1 and N, intended as a starting point for the creation of a parallel version.
prime_mpi, a C code which counts the primes between 1 and N, using Message Passing Interface (MPI) for parallel execution.
prime_mpi, a C++ code which counts primes between 1 and N, using the Message Passing Interface (MPI) for parallel execution.
prime_mpi, a Fortran77 code which counts primes between 1 and N, using Message Passing Interface (MPI) for parallel execution.
prime_mpi, a Fortran90 code which counts primes between 1 and N, using Message Passing Interface (MPI) for parallel execution.
prime_mpi, a Python code which counts primes between 1 and N, using Message Passing Interface (MPI) for parallel execution.
prime_openmp, a C code which counts primes between 1 and N, using OpenMP for parallel execution.
prime_openmp, a C++ code which counts primes between 1 and N, using OpenMP for parallel execution.
prime_openmp, a Fortran77 code which counts primes between 1 and N, using OpenMP for parallel execution.
prime_openmp, a Fortran90 code which counts primes between 1 and N, using OpenMP for parallel execution.
prime_parfor, a MATLAB code which counts primes between 1 and N, running in parallel using the parfor() feature.
prime_pi, a C code which evaluates Pi(n), the number of primes less than or equal to an integer n.
prime_pi, a C++ code which evaluates Pi(n), the number of primes less than or equal to an integer n.
prime_pi, a Fortran90 code which evaluates Pi(n), the number of primes less than or equal to an integer n.
prime_pi, a MATLAB code which evaluates Pi(n), the number of primes less than or equal to an integer n.
prime_pi, an Octave code which evaluates Pi(n), the number of primes less than or equal to an integer n.
prime_pi, a Python code which evaluates Pi(n), the number of primes less than or equal to an integer n.
prime_plot, a MATLAB code which displays a box plot of the prime and composite numbers.
prime_plot, an Octave code which displays a box plot of the prime and composite numbers.
prime_plot, a Python code which displays a box plot of the prime and composite numbers.
prime_spmd, a MATLAB code which counts primes between 1 and N; running in parallel using the Single Program Multiple Data (SPMD) feature.
prism_jaskowiec_rule, a C code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
prism_jaskowiec_rule, a C++ code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
prism_jaskowiec_rule, a Fortran90 code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
prism_jaskowiec_rule, a MATLAB code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
prism_jaskowiec_rule, an Octave code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
prism_jaskowiec_rule, a Python code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
prism_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
prism_witherden_rule, a C++ code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
prism_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
prism_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
prism_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
prism_witherden_rule, a Python code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
prob, a C code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
prob, a C++ code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
prob, a Fortran77 code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
prob, a Fortran90 code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
prob, a MATLAB code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
prob, an Octave code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
prob, a Python code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
product_rule, a C code which constructs a product quadrature rule from distinct 1D factor rules.
product_rule, a C++ code which constructs a product quadrature rule from distinct 1D factor rules.
product_rule, a Fortran77 code which constructs a product quadrature rule from distinct 1D factor rules.
product_rule, a Fortran90 code which constructs a product quadrature rule from distinct 1D factor rules.
product_rule, a MATLAB code which constructs a product quadrature rule from distinct 1D factor rules.
product_rule, an Octave code 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_test, a MATLAB code which uses profile(), which monitors the execution of a series of MATLAB commands, and then produces a performance profile report afterwards.
profile_data, a MATLAB code which carries out some numerical exercises based on data that came from tracing the profile of a face.
proj, examples which use PROJ, which converts 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_gg_align, a Fortran90 code which implements global string alignment algorithms which work in linear space, and compute both the optimal score and the optimal alignment. Gaps in the alignment are assigned an affine gap penalty. The algorithms are due to Chao.
ps_lg_align, a Fortran90 code which implements local string alignment algorithms which work in linear space, and compute both the optimal score and the optimal alignment. Gaps in the alignment are assigned an affine gap penalty. The algorithms are due to Chao.
ps_qg_align, a Fortran90 code which implements quasi-global string alignment algorithms which work in linear space, and compute both the optimal score and the optimal alignment. Gaps in the alignment are assigned an affine gap penalty. The algorithms are due to Chao.
ps_write, a Fortran90 code which creates PostScript (PS) graphics files.
pthreads_test, a C code which uses pthreads(), which is the posix thread library for parallel execution.
pthreads_test, a C++ code which uses pthreads(), which is the posix thread library for parallel execution.
puzzles, a Fortran90 code which was used to solve various puzzles.
puzzles, a MATLAB code which solves various puzzles.
pwc_plot_1d, a MATLAB code which converts the definition of a piecewise constant (PWC) function of a 1D argument into plottable data.
pwc_plot_1d, an Octave code which converts the definition of a piecewise constant (PWC) function of a 1D argument into plottable data.
pwc_plot_2d, a MATLAB code which converts the definition of a piecewise constant (PWC) function of a 2D argument into plottable data.
pwc_plot_2d, an Octave code which converts the definition of a piecewise constant (PWC) function of a 2D argument into plottable data.
pwiselinterp, an R code which finds the intercept and slope for a sequence of piecewise linear (PWL) interpolants.
pwl_approx_1d, a C code which approximates data using a piecewise linear (PWL) function.
pwl_approx_1d, a C++ code which approximates data using a piecewise linear (PWL) function.
pwl_approx_1d, a Fortran77 code which approximates data using a piecewise linear (PWL) function.
pwl_approx_1d, a Fortran90 code which approximates data using a piecewise linear (PWL) function.
pwl_approx_1d, a MATLAB code which approximates data using a piecewise linear (PWL) function.
pwl_approx_1d, an Octave code which approximates data using a piecewise linear (PWL) function.
pwl_interp_1d, a C code which interpolates data using a piecewise linear (PWL) function, creating graphics files for processing by gnuplot().
pwl_interp_1d, a C++ code which interpolates data using a piecewise linear (PWL) function, creating graphics files for processing by gnuplot().
pwl_interp_1d, a Fortran77 code which interpolates data using a piecewise linear (PWL) function, creating graphics files for processing by gnuplot().
pwl_interp_1d, a Fortran90 code which interpolates data using a piecewise linear (PWL) function, creating graphics files for processing by gnuplot().
pwl_interp_1d, a MATLAB code which interpolates data using a piecewise linear (PWL) function.
pwl_interp_1d, an Octave code which interpolates data using a piecewise linear (PWL) function.
pwl_interp_1d, a Python code which interpolates data using a piecewise linear (PWL) function.
pwl_interp_2d, a C code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
pwl_interp_2d, a C++ code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
pwl_interp_2d, a Fortran77 code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
pwl_interp_2d, a Fortran90 code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
pwl_interp_2d, a MATLAB code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
pwl_interp_2d, an Octave code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
pwl_interp_2d, a Python code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
pwl_interp_2d_scattered, a C code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
pwl_interp_2d_scattered, a C++ code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
pwl_interp_2d_scattered, a Fortran77 code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
pwl_interp_2d_scattered, a Fortran90 code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
pwl_interp_2d_scattered, a MATLAB code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
pwl_interp_2d_scattered, an Octave code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
pwl_product_integral, a C code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions F(X) and G(X).
pwl_product_integral, a C++ code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions F(X) and G(X).
pwl_product_integral, a Fortran77 code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions F(X) and G(X).
pwl_product_integral, a Fortran90 code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions F(X) and G(X).
pwl_product_integral, a MATLAB code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions F(X) and G(X).
pwl_product_integral, an Octave code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions F(X) and G(X).
py_test, a Python code which illustrates certain features of the language.
pyramid_exactness, a C code which computes the exactness of a quadrature rule over the interior of a pyramid in 3D.
pyramid_exactness, a C++ code which computes the exactness of a quadrature rule over the interior of a pyramid in 3D.
pyramid_exactness, a Fortran77 code which computes the exactness of a quadrature rule over the interior of a pyramid in 3D.
pyramid_exactness, a Fortran90 code which computes the exactness of a quadrature rule over the interior of a pyramid in 3D.
pyramid_exactness, a MATLAB code which computes the exactness of a quadrature rule over the interior of a pyramid in 3D.
pyramid_exactness, an Octave code which computes the exactness of a quadrature rule over the interior of a pyramid in 3D.
pyramid_exactness, a Python code which computes the exactness of a quadrature rule over the interior of a pyramid in 3D.
pyramid_felippa_rule, a C code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
pyramid_felippa_rule, a C++ code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
pyramid_felippa_rule, a Fortran77 code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
pyramid_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
pyramid_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
pyramid_felippa_rule, an Octave code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
pyramid_felippa_rule, a Python code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
pyramid_grid, a C code which computes a grid of points over the interior of the unit pyramid in 3D;
pyramid_grid, a C++ code which computes a grid of points over the interior of the unit pyramid in 3D;
pyramid_grid, a Fortran77 code which computes a grid of points over the interior of the unit pyramid in 3D;
pyramid_grid, a Fortran90 code which computes a grid of points over the interior of the unit pyramid in 3D;
pyramid_grid, a MATLAB code which computes a grid of points over the interior of the unit pyramid in 3D;
pyramid_grid, an Octave code which computes a grid of points over the interior of the unit pyramid in 3D;
pyramid_grid, a Python code which computes a grid of points over the interior of the unit pyramid in 3D;
pyramid_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
pyramid_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
pyramid_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
pyramid_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
pyramid_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
pyramid_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
pyramid_integrals, a Python code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
pyramid_jaskowiec_rule, a C code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
pyramid_jaskowiec_rule, a C++ code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
pyramid_jaskowiec_rule, a Fortran90 code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
pyramid_jaskowiec_rule, a MATLAB code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
pyramid_jaskowiec_rule, an Octave code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
pyramid_jaskowiec_rule, a Python code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
pyramid_monte_carlo, a C code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
pyramid_monte_carlo, a C++ code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
pyramid_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
pyramid_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
pyramid_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
pyramid_monte_carlo, an Octave code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
pyramid_monte_carlo, a Python code 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 code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D;
pyramid_rule, a C++ code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D;
pyramid_rule, a Fortran77 code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D;
pyramid_rule, a Fortran90 code which computes a conical product quadrature rule over the interior of the unit pyramid;
pyramid_rule, a MATLAB code which computes a conical product quadrature rule over the interior of the unit pyramid;
pyramid_rule, an Octave code which computes a conical product quadrature rule over the interior of the unit pyramid;
pyramid_rule, a Python code which computes a conical product quadrature rule over the interior of the unit pyramid;
pyramid_witherden_rule, a C code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
pyramid_witherden_rule, a C++ code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
pyramid_witherden_rule, a Fortran90 code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
pyramid_witherden_rule, a MATLAB code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
pyramid_witherden_rule, an Octave code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
pyramid_witherden_rule, a Python code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
python_combinatorics, a Python code which considers a variety of problems in combinatorics involving counting, combinations, permutations, and so on.
python_distance, a Python code which estimates the typical distance between a pair of points randomly selected from the surface or interior of a geometric object such as a circle, disk, sphere, cube.
python_exact, a Python code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
python_grid, a Python code which generates a regular grid of points inside a variety of regions in one, two, three or many dimensions.
python_import, a Python code which demonstrates how a Python function can use the import function to access functions from a library that is in a separate directory.
python_intrinsics_test, a Python code which demonstrates the use of intrinsic functions supplied by the Python language.
python_monte_carlo, a Python code which uses Monte Carlo sampling to estimate areas and integrals.
python_ode, a Python code which set up various ordinary differential equations (ODE).
python_plots, a Python code which uses plotting to illustrate a mathematical structure, such as an iterative map, a fractal, a curve or surface.
python_polynomial, a Python code which analyzes a variety of polynomial families, returning the polynomial values, coefficients, derivatives, integrals, roots, or other information.
python_random_test, a Python code which demonstrates random number generation.
python_rule, a Python code which computes a quadrature rule which estimates the integral of a function f(x), which might be defined over a one dimensional region (a line) or more complex shapes such as, a circle, a disk, an ellipse, a triangle, a quadrilateral, a polygon, a sphere, a ball, a hypercube, and which might include an associated weight function w(x).
python_simulation, a Python code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
pytorch_test, a Python code which tests certain features of pytorch(), a library used for deep learning research.
qbezier, an R code which evaluates a quadratic Bezier curve.
qr_solve, a C code which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b, using the QR factorization.
qr_solve, a C++ code which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b, using the QR factorization.
qr_solve, a Fortran77 code which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b, using the QR factorization.
qr_solve, a Fortran90 code which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b, using the QR factorization.
qr_solve, a MATLAB code which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b, using the QR factorization.
qr_solve, an Octave code which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b, using the QR factorization.
qr_solve, a Python code which computes the linear least squares (LLS) solution of a rectangular linear system A*x=b, using the QR factorization.
quad, a C code which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.
quad, a C++ code which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.
quad, a Fortran77 code which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.
quad, a Fortran90 code which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.
quad, a MATLAB code which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.
quad, a Python code which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.
quad_fast_rule, a MATLAB code which rapidly defines certain quadrature rules for 1D domains.
quad_fast_rule, an Octave code which rapidly defines certain quadrature rules for 1D domains.
quad_gauss, a MATLAB code which interactively uses an n-point Gauss quadrature rule to estimate the integral of a function f(x) in the interval [a,b].
quad_gauss, an Octave code which interactively uses an n-point Gauss quadrature rule to estimate the integral of a function f(x) in the interval [a,b].
quad_monte_carlo, a MATLAB code which interactively uses n random samples to estimate the integral of a function f(x) in the interval [a,b].
quad_monte_carlo, an Octave code which interactively uses n random samples to estimate the integral of a function f(x) in the interval [a,b].
quad_mpi, a C code which approximates an integral using a quadrature rule, and carries out the computation in parallel using the Message Passing Interface (MPI).
quad_mpi, a C++ code which approximates an integral using a quadrature rule, and carries out the computation in parallel using the Message Passing Interface (MPI).
quad_mpi, a Fortran77 code which approximates an integral using a quadrature rule, and carries out the computation in parallel using the Message Passing Interface (MPI).
quad_mpi, a Fortran90 code which approximates an integral using a quadrature rule, and carries out the computation in parallel using the Message Passing Interface (MPI).
quad_mpi, a Python code which approximates an integral using a quadrature rule, and carries out the computation in parallel using the Message Passing Interface (MPI).
quad_openmp, a C code which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.
quad_openmp, a C++ code which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.
quad_openmp, a Fortran77 code which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.
quad_openmp, a Fortran90 code which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.
quad_parfor, a MATLAB code which estimates an integral using quadrature; running in parallel using the parfor() feature.
quad_rule, a C code which defines quadrature rules for approximating an integral over a 1D domain.
quad_rule, a C++ code which defines quadrature rules for approximating an integral over a 1D domain.
quad_rule, a Fortran77 code which defines quadrature rules for approximating an integral over a 1D domain.
quad_rule, a Fortran90 code which defines quadrature rules for approximating an integral over a 1D domain.
quad_rule, a Mathematica code which evaluates quadrature rules needed for the C, C++, Fortran90 and MATLAB quad_rule libraries.
quad_rule, a MATLAB code which defines quadrature rules for approximating an integral over a 1D domain.
quad_rule, an Octave code which defines quadrature rules for approximating an integral over a 1D domain.
quad_rule, a Python code which defines quadrature rules for approximating an integral over a 1D domain.
quad_spmd, a MATLAB code which estimates an integral using quadrature; running in parallel using the Single Program Multiple Data (SPMD) feature.
quad_tasks, a MATLAB code which estimates an integral using quadrature; running in parallel using the MATLAB task feature.
quad_trapezoid, a MATLAB code which interactively applies a trapezoid rule using n intervals to estimate the integral of a function f(x) over an interval [a,b].
quad_trapezoid, an Octave code which interactively applies a trapezoid rule using n intervals to estimate the integral of a function f(x) over an interval [a,b].
quad2d, a C code which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.
quad2d, a C++ code which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.
quad2d, a Fortran77 code which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.
quad2d, a Fortran90 code which approximates an integral over a 2D region using a product quadrature rule, and is intended as a starting point for parallelization exercises.
quad2d, a MATLAB code which estimates an integral over a 2D rectangle using quadrature, intended as the starting point for program optimization or parallelization.
quad2d, an Octave code which estimates an integral over a 2D rectangle using quadrature, intended as the starting point for program optimization or parallelization.
quad2d, a Python code which estimates an integral over a 2D rectangle using quadrature, intended as the starting point for program optimization or parallelization.
quad2d_openmp, a C code which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.
quad2d_openmp, a C++ code which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.
quad2d_openmp, a Fortran77 code which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.
quad2d_openmp, a Fortran90 code which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution.
quadex_ode, a MATLAB code which sets up a stiff ordinary differential equation (ODE), whose exact solution is a parabola, but for which errors grow exponentially.
quadex_ode, an Octave code which sets up a stiff ordinary differential equation (ODE), whose exact solution is a parabola, but for which errors grow exponentially.
quadex_ode, a Python code which sets up a stiff ordinary differential equation (ODE), whose exact solution is a parabola, but for which errors grow exponentially.
quadmom, a C code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
quadmom, a C++ code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
quadmom, a Fortran77 code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
quadmom, a Fortran90 code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
quadmom, a MATLAB code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
quadmom, an Octave code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
quadpack, a Fortran77 code which estimates integrals using numerical quadrature, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.
quadpack, a Fortran90 code which estimates integrals using numerical quadrature, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.
quadpack_single, a Fortran90 code which estimates integrals using numerical quadrature, using real 32 bit arithmetic, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.
quadprog_test, a MATLAB code which calls quadprog() to solve problems in quadratic programming.
quadprog_test, a Python code which calls quadprog() to solve problems in quadratic programming.
quadratic, an R code which computes the roots of a quadratic equation ax^2+bx+c=0.
quadrature, a MATLAB code which reads files defining a M-dimensional quadrature rule, and applies them to all the test integrals defined by test_nint().
quadrature_golub_welsch, a C code which computes a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.
quadrature_golub_welsch, a C++ code which computes a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.
quadrature_golub_welsch, a Fortran77 code which computes a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.
quadrature_golub_welsch, a Fortran90 code which computes a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.
quadrature_golub_welsch, a MATLAB code which computes a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.
quadrature_golub_welsch, an Octave code which computes a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.
quadrature_least_squares, a C code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
quadrature_least_squares, a C++ code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
quadrature_least_squares, a Fortran77 code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
quadrature_least_squares, a Fortran90 code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
quadrature_least_squares, a MATLAB code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
quadrature_least_squares, an Octave code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
quadrature_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++ code 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 code 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++ code 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 code which reads files defining a 2D quadrature rule, and applies them to all the test integrals defined by test_int_2d.
quadrature_2d_test, a MATLAB code 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 code 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 code which computes the weights of a 1D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_test
quadrature_weights_vandermonde, a C++ code which computes the weights of a 1D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_test
quadrature_weights_vandermonde, a Fortran77 code which computes the weights of a 1D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_test
quadrature_weights_vandermonde, a Fortran90 code which computes the weights of a 1D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_test
quadrature_weights_vandermonde, a MATLAB code which computes the weights of a 1D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_test
quadrature_weights_vandermonde, an Octave code which computes the weights of a 1D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_test
quadrature_weights_vandermonde_2d, a C code which computes the weights of a 2D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_2d_test
quadrature_weights_vandermonde_2d, a C++ code which computes the weights of a 2D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_2d_test
quadrature_weights_vandermonde_2d, a Fortran77 code which computes the weights of a 2D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_2d_test
quadrature_weights_vandermonde_2d, a Fortran90 code which computes the weights of a 2D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_2d_test
quadrature_weights_vandermonde_2d, a MATLAB code which computes the weights of a 2D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_2d_test
quadrature_weights_vandermonde_2d, an Octave code which computes the weights of a 2D quadrature rule using the vandermonde matrix, assuming that the points have been specified.
quadrature_weights_vandermonde_2d_test
quadrilateral, a MATLAB code which carries out geometric calculations on quadrilaterals, including angles, area, distances, nearest point, point containment, perimeter, and random generation.
quadrilateral, an Octave code which carries out geometric calculations on quadrilaterals, including angles, area, distances, nearest point, point containment, perimeter, and random generation.
quadrilateral, a Python code which carries out geometric calculations on quadrilaterals, including angles, area, distances, nearest point, point containment, perimeter, and random generation.
quadrilateral_mesh, a data directory which defines a format for storing meshes of quadrilaterals over a 2D region.
quadrilateral_mesh, a C++ code which handles meshes of quadrilaterals over a 2D region;
quadrilateral_mesh, a Fortran90 code which handles meshes of quadrilaterals over a 2D region;
quadrilateral_mesh, a MATLAB code which handles meshes of quadrilaterals over a 2D region;
quadrilateral_mesh_order1, a data directory of quadrilateral_mesh files, a quadrilateral mesh in 2D, with an associated data value that is constant over each element of the mesh;
quadrilateral_mesh_order1_display, a MATLAB code which plots piecewise constant (PWC) data associated with a mesh of quadrilaterals;
quadrilateral_mesh_order1_display_test
quadrilateral_mesh_order1_display, an Octave code which plots piecewise constant (PWC) data associated with a mesh of quadrilaterals;
quadrilateral_mesh_order1_display_test
quadrilateral_mesh_rcm, a C++ code which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
quadrilateral_mesh_rcm, a Fortran90 code which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
quadrilateral_mesh_rcm, a MATLAB code which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
quadrilateral_mesh_rcm, an Octave code which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
quadrilateral_surface, a data directory which contains quadrilateral_surface files, a quadrilateral mesh in 3D, used to define a surface.
quadrilateral_surface_display, a MATLAB code which plots piecewise linear (PWL) 2D data associated with a quadrilateral_surface, that is, a 3D surface defined by a quadrilateral mesh;
quadrilateral_surface_display_test
quadrilateral_surface_display, an Octave code which plots piecewise linear (PWL) 2D data associated with a quadrilateral_surface, that is, a 3D surface defined by a quadrilateral mesh;
quadrilateral_surface_display_test
quadrilateral_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
quadrilateral_witherden_rule_test
quadrilateral_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
quadrilateral_witherden_rule_test
quadrilateral_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
quadrilateral_witherden_rule_test
quadrilateral_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
quadrilateral_witherden_rule_test
quadrilateral_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
quadrilateral_witherden_rule_test
quadrilateral_witherden_rule, a Python code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
quality, a C++ code which measures the dispersion of pointsets in M dimensions;
quality, a Fortran90 code which measures the dispersion of pointsets in M dimensions;
quality, a MATLAB code which measures the dispersion of pointsets in M dimensions;
quality, an Octave code which measures the dispersion of pointsets in M dimensions;
quasiperiodic_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) for a problem with a quasiperiodic solution.
quasiperiodic_ode, an Octave code which sets up a system of ordinary differential equations (ODE) for a problem with a quasiperiodic solution.
quasiperiodic_ode, a Python code which sets up a system of ordinary differential equations (ODE) for a problem with a quasiperiodic solution.
quaternions, a C code which carries out arithmetic operations for quaternions.
quaternions, a C++ code which carries out arithmetic operations for quaternions.
quaternions, a Fortran90 code which carries out some simple arithmetic operations for quaternions.
quaternions, a MATLAB code which carries out some simple arithmetic operations for quaternions.
quaternions, an Octave code which carries out some simple arithmetic operations for quaternions.
quaternions, a Python code which carries out some simple arithmetic operations for quaternions.
quiz, a MATLAB code which investigates a few simple questions, as practice for beginning matlab programmers.
quotes, a Fortran90 code which prints a random quote from a file;
qvoronoi, a C code which computes the Voronoi diagram of a pointset in M dimensions. This is part of the qhull package;
r, examples which use R, which is a language specifically focussed on statistical computing and the analysis of multiple large datasets.
r-parallel, examples which use R-PARALLEL, which is a set of libraries for parallel programming in R: rmpi, snow, and snowfall.
r4lib, a C code which contains many utility routines, using real 32 bit (R4) arithmetic.
r4lib, a C++ code which contains many utility routines using real 32 bit (R4) arithmetic.
r4lib, a Fortran77 code which contains many utility routines using real 32 bit (R4) arithmetic.
r4lib, a Fortran90 code which contains many utility routines using real 32 bit (R4) arithmetic.
r4lib, a MATLAB code which contains many utility routines using real 32 bit (R4) arithmetic.
r4lib, a Python code which contains many utility routines using real 32 bit (R4) arithmetic.
r8_scale, a MATLAB code which computes the next and previous real numbers.
r8_scale, an Octave code which computes the next and previous real numbers.
r83, a C code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
r83, a C++ code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
r83, a Fortran90 code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
r83, a MATLAB code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
r83, an Octave code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
r83, a Python code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
r83_np, a C code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
r83_np, a C++ code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
r83_np, a Fortran90 code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
r83_np, a MATLAB code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
r83_np, an Octave code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
r83_np, a Python code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
r83p, a C code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
r83p, a C++ code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
r83p, a Fortran90 code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
r83p, a MATLAB code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
r83p, an Octave code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
r83p, a Python code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
r83s, a C code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
r83s, a C++ code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
r83s, a Fortran90 code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
r83s, a MATLAB code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
r83s, an Octave code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
r83s, a Python code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
r83t, a C code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
r83t, a C++ code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
r83t, a Fortran90 code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
r83t, a MATLAB code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
r83t, an Octave code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
r83t, a Python code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
r83v, a C code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
r83v, a C++ code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
r83v, a Fortran90 code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
r83v, a MATLAB code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
r83v, an Octave code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
r83v, a Python code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
r85, a C code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
r85, a C++ code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
r85, a Fortran90 code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
r85, a MATLAB code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
r85, an Octave code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
r85, a Python code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
r8bb, a C code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
r8bb, a C++ code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
r8bb, a Fortran90 code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
r8bb, a MATLAB code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
r8bb, an Octave code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
r8bb, a Python code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
r8blt, a C code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
r8blt, a C++ code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
r8blt, a Fortran90 code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
r8blt, a MATLAB code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
r8blt, an Octave code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
r8blt, a Python code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
r8bto, a C code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
r8bto, a C++ code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
r8bto, a Fortran90 code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
r8bto, a MATLAB code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
r8bto, an Octave code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
r8bto, a Python code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
r8but, a C code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
r8but, a C++ code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
r8but, a Fortran90 code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
r8but, a MATLAB code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
r8but, an Octave code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
r8but, a Python code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
r8cb, a C code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
r8cb, a C++ code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
r8cb, a Fortran90 code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
r8cb, a MATLAB code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
r8cb, an Octave code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
r8cb, a Python code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
r8cbb, a C code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
r8cbb, a C++ code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
r8cbb, a Fortran90 code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
r8cbb, a MATLAB code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
r8cbb, an Octave code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
r8cbb, a Python code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
r8ccs, a C code which contains linear algebra routines for r8ccs matrices (real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format).
r8ccs, a C++ code which contains linear algebra routines for r8ccs matrices (real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format).
r8ccs, a Fortran90 code which contains linear algebra routines for r8ccs matrices (real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format).
r8ccs, a MATLAB code which contains linear algebra routines for r8ccs matrices: real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format.
r8ccs, an Octave code which contains linear algebra routines for r8ccs matrices (real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format).
r8ccs, a Python code which contains linear algebra routines for r8ccs matrices (real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format).
r8ci, a C code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
r8ci, a C++ code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
r8ci, a Fortran90 code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
r8ci, a MATLAB code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
r8ci, an Octave code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
r8ci, a Python code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
r8col, a C code which contains linear algebra routines for r8col matrices, that is, a real 64 bit MxN array, 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++ code which contains linear algebra routines for r8col matrices, that is, a real 64 bit MxN array, 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 code which contains linear algebra routines for r8col matrices, that is, a real 64 bit MxN array, 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 code which contains linear algebra routines for r8col matrices, that is, a real 64 bit MxN array, 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, an Octave code which contains linear algebra routines for r8col matrices, that is, a real 64 bit MxN array, 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 code which contains linear algebra routines for r8col matrices, that is, a real 64 bit MxN array, 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.
r8crs, a MATLAB code which contains linear algebra routines for r8crs matrices (real, 64 bit, Compressed Row Storage (CRS) format).
r8crs, an Octave code which contains linear algebra routines for r8crs matrices (real, 64 bit, Compressed Row Storage (CRS) format).
r8crs, a Python code which contains linear algebra routines for r8crs matrices (real, 64 bit, Compressed Row Storage (CRS) format).
r8gb, a C code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
r8gb, a C++ code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
r8gb, a Fortran90 code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
r8gb, a MATLAB code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
r8gb, an Octave code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
r8gb, a Python code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
r8gd, a C code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
r8gd, a C++ code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
r8gd, a Fortran90 code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
r8gd, a MATLAB code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
r8gd, an Octave code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
r8gd, a Python code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
r8ge, a C code which contains linear algebra routines for r8ge matrices (real, 64 bit, General format).
r8ge, a C++ code which contains linear algebra routines for r8ge matrices (real, 64 bit, General format).
r8ge, a Fortran90 code which contains linear algebra routines for r8ge matrices (real, 64 bit, General format).
r8ge, a MATLAB code which contains linear algebra routines for r8ge matrices (real, 64 bit, General format).
r8ge, an Octave code which contains linear algebra routines for r8ge matrices (real, 64 bit, General format).
r8ge, a Python code which contains linear algebra routines for r8ge matrices (real, 64 bit, General format).
r8ge_np, a C code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
r8ge_np, a C++ code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
r8ge_np, a Fortran90 code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
r8ge_np, a MATLAB code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
r8ge_np, an Octave code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
r8ge_np, a Python code which contains nonpivoting linear algebra routines for r8ge_np matrices (real, 64 bit, General Nonpivoting format).
r8lib, a C code which contains utility routines for real 64 bit (r8) arithmetic.
r8lib, a C++ code which contains utility routines for real 64 bit (r8) arithmetic.
r8lib, a Fortran77 code which contains utility routines for real 64 bit (r8) arithmetic.
r8lib, a Fortran90 code which contains utility routines for real 64 bit (r8) arithmetic.
r8lib, a MATLAB code which contains utility routines for real 64 bit (r8) arithmetic.
r8lib, an Octave code which contains utility routines for real 64 bit (r8) arithmetic.
r8lib, a Python code which contains utility routines for real 64 bit (r8) arithmetic.
r8lib, an R code which contains utility routines for real 64 bit (r8) arithmetic.
r8lt, a C code which contains linear algebra routines for r8lt matrices (real, 64 bit, lower triangular format).
r8lt, a C++ code which contains linear algebra routines for r8lt matrices (real, 64 bit, lower triangular format).
r8lt, a Fortran90 code which contains linear algebra routines for r8lt matrices (real, 64 bit, lower triangular format).
r8lt, a MATLAB code which contains linear algebra routines for r8lt matrices (real, 64 bit, lower triangular format).
r8lt, an Octave code which contains linear algebra routines for r8lt matrices (real, 64 bit, lower triangular format).
r8lt, a Python code which contains linear algebra routines for r8lt matrices (real, 64 bit, lower triangular format).
r8ltt, a C code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
r8ltt, a C++ code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
r8ltt, a Fortran90 code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
r8ltt, a MATLAB code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
r8ltt, an Octave code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
r8ltt, a Python code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
r8ncf, a C code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
r8ncf, a C++ code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
r8ncf, a Fortran90 code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
r8ncf, a MATLAB code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
r8ncf, an Octave code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
r8ncf, a Python code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
r8pbl, a C code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
r8pbl, a C++ code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
r8pbl, a Fortran90 code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
r8pbl, a MATLAB code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
r8pbl, an Octave code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
r8pbl, a Python code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
r8pbu, a C code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
r8pbu, a C++ code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
r8pbu, a Fortran90 code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
r8pbu, a MATLAB code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
r8pbu, an Octave code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
r8pbu, a Python code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
r8po, a C code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
r8po, a C++ code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
r8po, a Fortran90 code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
r8po, a MATLAB code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
r8po, an Octave code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
r8po, a Python code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
r8poly, a C code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
r8poly, a C++ code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
r8poly, a Fortran90 code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
r8poly, a MATLAB code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
r8poly, an Octave code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
r8poly, a Python code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
r8pp, a C code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
r8pp, a C++ code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
r8pp, a Fortran90 code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
r8pp, a MATLAB code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
r8pp, an Octave code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
r8pp, a Python code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
r8ri, a C code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
r8ri, a C++ code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
r8ri, a Fortran90 code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
r8ri, a MATLAB code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
r8ri, an Octave code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
r8ri, a Python code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
r8row, a C code which contains linear algebra routines for r8row matrices, that is, a real 64 bit MxN array, 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++ code which contains linear algebra routines for r8row matrices, that is, a real 64 bit MxN array, 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 code which contains linear algebra routines for r8row matrices, that is, a real 64 bit MxN array, 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 code which contains linear algebra routines for r8row matrices, that is, a real 64 bit MxN array, 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, an Octave code which contains linear algebra routines for r8row matrices, that is, a real 64 bit MxN array, 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 code which contains linear algebra routines for r8row matrices, that is, a real 64 bit MxN array, 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.
r8sd, a C code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
r8sd, a C++ code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
r8sd, a Fortran90 code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
r8sd, a MATLAB code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
r8sd, an Octave code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
r8sd, a Python code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
r8sm, a C code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
r8sm, a C++ code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
r8sm, a Fortran90 code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
r8sm, a MATLAB code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
r8sm, an Octave code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
r8sm, a Python code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
r8sr, a C code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
r8sr, a C++ code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
r8sr, a Fortran90 code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
r8sr, a MATLAB code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
r8sr, an Octave code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
r8sr, a Python code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
r8ss, a C code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
r8ss, a C++ code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
r8ss, a Fortran90 code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
r8ss, a MATLAB code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
r8ss, an Octave code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
r8ss, a Python code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
r8st, a C code which contains linear algebra routines for r8st matrices (real, 64 bit, Sparse Triplet (ST) (I,J,AIJ) format).
r8st, a C++ code which contains linear algebra routines for r8st matrices (real, 64 bit, Sparse Triplet (ST) (I,J,AIJ) format).
r8st, a Fortran90 code which contains linear algebra routines for r8st matrices (real, 64 bit, Sparse Triplet (ST) (I,J,AIJ) format).
r8st, a MATLAB code which contains linear algebra routines for r8st matrices (real, 64 bit, Sparse Triplet (ST) (I,J,AIJ) format).
r8st, an Octave code which contains linear algebra routines for r8st matrices (real, 64 bit, Sparse Triplet (ST) (I,J,AIJ) format).
r8st, a Python code which contains linear algebra routines for r8st matrices (real, 64 bit, Sparse Triplet (ST) (I,J,AIJ) format).
r8sto, a C code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
r8sto, a C++ code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
r8sto, a Fortran90 code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
r8sto, a MATLAB code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
r8sto, an Octave code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
r8sto, a Python code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
r8to, a C code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
r8to, a C++ code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
r8to, a Fortran90 code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
r8to, a MATLAB code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
r8to, an Octave code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
r8to, a Python code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
r8ut, a C code which contains linear algebra routines for r8ut matrices (real, 64 bit, upper triangular format).
r8ut, a C++ code which contains linear algebra routines for r8ut matrices (real, 64 bit, upper triangular format).
r8ut, a Fortran90 code which contains linear algebra routines for r8ut matrices (real, 64 bit, upper triangular format).
r8ut, a MATLAB code which contains linear algebra routines for r8ut matrices (real, 64 bit, upper triangular format).
r8ut, an Octave code which contains linear algebra routines for r8ut matrices (real, 64 bit, upper triangular format).
r8ut, a Python code which contains linear algebra routines for r8ut matrices (real, 64 bit, upper triangular format).
r8utp, a C code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
r8utp, a C++ code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
r8utp, a Fortran90 code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
r8utp, a MATLAB code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
r8utp, an Octave code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
r8utp, a Python code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
r8utt, a C code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
r8utt, a C++ code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
r8utt, a Fortran90 code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
r8utt, a MATLAB code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
r8utt, an Octave code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
r8utt, a Python code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
r8vm, a C code which contains linear algebra routines for r8vm matrices (real, 64 bit, Vandermonde format).
r8vm, a C++ code which contains linear algebra routines for r8vm matrices (real, 64 bit, Vandermonde format).
r8vm, a Fortran90 code which contains linear algebra routines for r8vm matrices (real, 64 bit, Vandermonde format).
r8vm, a MATLAB code which contains linear algebra routines for r8vm matrices (real, 64 bit, Vandermonde format).
r8vm, an Octave code which contains linear algebra routines for r8vm matrices (real, 64 bit, Vandermonde format).
r8vm, a Python code which contains linear algebra routines for r8vm matrices (real, 64 bit, Vandermonde format).
ram_regression_decision, a scikit-learn code which uses a decision tree algorithm to perform regression on the RAM price dataset.
ram_regression_linear, a scikit-learn code which uses linear regression to perform regression on the RAM price dataset.
rand48_test, a C code which demonstrates the rand48() family of random number generators (RNG) available in the C/C++ standard library.
rand48_test, a C++ code which demonstrates the rand48() family of random number generators (RNG) available in the C/C++ standard library.
randlc, a C code which implements a random number generator (RNG) used by the nas() benchmarks.
randlc, a C++ code which implements a random number generator (RNG) used by the nas() benchmarks.
randlc, a Fortran77 code which implements a random number generator (RNG) used by the nas() benchmarks.
randlc, a Fortran90 code which implements a random number generator (RNG) used by the nas() benchmarks.
randlc, a MATLAB code which implements a random number generator (RNG) used by the nas() benchmarks.
randlc, an Octave code which implements a random number generator (RNG) used by the nas() benchmarks.
randlc, a Python code which implements a random number generator (RNG) used by the nas() benchmarks.
random_data, a C code which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, circle, ellipse, ellipsoid, hypercube, hypersphere, simplex, tetrahedron and triangle.
random_data, a C++ code which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, circle, ellipse, ellipsoid, hypercube, hypersphere, simplex, tetrahedron and triangle.
random_data, a Fortran77 code which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, circle, ellipse, ellipsoid, hypercube, hypersphere, simplex, tetrahedron and triangle.
random_data, a Fortran90 code which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, circle, ellipse, ellipsoid, hypercube, hypersphere, simplex, tetrahedron and triangle.
random_data, a MATLAB code which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, circle, ellipse, ellipsoid, hypercube, hypersphere, simplex, tetrahedron and triangle.
random_data, an Octave code which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, circle, ellipse, ellipsoid, hypercube, hypersphere, simplex, tetrahedron and triangle.
random_data, a Python code which uses a random number generator (RNG) to sample points corresponding to various probability density functions (PDF), spatial dimensions, and geometries, including the annulus, circle, ellipse, ellipsoid, hypercube, hypersphere, simplex, tetrahedron and triangle.
random_matrix_eigenvalues, a Python code which demonstrates how, for certain probability density functions (PDF), a symmetric matrix with entries sampled from that PDF will have eigenvalues distributed according to the Wigner semicircle distribution.
random_mpi, a C code which generates the same sequence of values from a random number generator (RNG) for both sequential execution and parallel execution under the Message Passing Interface (MPI).
random_mpi, a C++ code which generates the same sequence of values from a random number generator (RNG) for both sequential execution and parallel execution under the Message Passing Interface (MPI).
random_mpi, a Fortran77 code which generates the same sequence of values from a random number generator (RNG) for both sequential execution and parallel execution under the Message Passing Interface (MPI).
random_mpi, a Fortran90 code which generates the same sequence of values from a random number generator (RNG) for both sequential execution and parallel execution under the Message Passing Interface (MPI).
random_openmp, a C code which generates multiple distinct streams of random numbers using OpenMP for parallel execution.
random_openmp, a C++ code which generates multiple distinct streams of random numbers using OpenMP for parallel execution.
random_openmp, a Fortran77 code which generates multiple distinct streams of random numbers using OpenMP for parallel execution.
random_openmp, a Fortran90 code which generates multiple distinct streams of random numbers using OpenMP for parallel execution.
random_sorted, a C code which uses a random number generator (RNG) to create a vector of random values which are already sorted.
random_sorted, a C++ code which uses a random number generator (RNG) to create a vector of random values which are already sorted.
random_sorted, a Fortran90 code which uses a random number generator (RNG) to create a vector of random values which are already sorted.
random_sorted, a MATLAB code which uses a random number generator (RNG) to create a vector of random values which are already sorted.
random_sorted, an Octave code which uses a random number generator (RNG) to create a vector of random values which are already sorted.
random_sorted, a Python code which uses a random number generator (RNG) to create a vector of random values which are already sorted.
random_test, a FreeFem++ code which demonstrates how to use various built-in random number generators (RNG).
random_walk_1d_simulation, a MATLAB code which simulates a random walk in a 1-dimensional region.
random_walk_1d_simulation_test
random_walk_1d_simulation, an Octave code which simulates a random walk in a 1-dimensional region.
random_walk_1d_simulation_test
random_walk_1d_simulation, a Python code which simulates a random walk in a 1-dimensional region.
random_walk_2d_avoid_simulation, a MATLAB code which simulates a self-avoiding random walk in a 2-dimensional region.
random_walk_2d_avoid_simulation_test
random_walk_2d_avoid_simulation, an Octave code which simulates a self-avoiding random walk in a 2-dimensional region.
random_walk_2d_avoid_simulation_test
random_walk_2d_avoid_simulation, a Python code which simulates a self-avoiding random walk in a 2-dimensional region.
random_walk_2d_avoid_tasks, a MATLAB code 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 the MATLAB Parallel Computing Toolbox task computing capability.
random_walk_2d_simulation, a MATLAB code which simulates a random walk in a 2-dimensional region.
random_walk_2d_simulation_test
random_walk_2d_simulation, an Octave code which simulates a random walk in a 2-dimensional region.
random_walk_2d_simulation_test
random_walk_2d_simulation, a Python code which simulates a random walk in a 2-dimensional region.
random_walk_3d_simulation, a MATLAB code which simulates a random walk in a 3-dimensional region.
random_walk_3d_simulation_test
random_walk_3d_simulation, an Octave code which simulates a random walk in a 3-dimensional region.
random_walk_3d_simulation_test
random_walk_3d_simulation, a Python code which simulates a random walk in a 3-dimensional region.
random_write, a Fortran90 code which creates a very large file of 32 bit integers, for input to diehard(), which applies statistical tests for randomness.
ranlib, a C code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
ranlib, a C++ code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
ranlib, a Fortran77 code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
ranlib, a Fortran90 code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
ranlib, a MATLAB code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
ranlib, an Octave code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
ranlib, a Python code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
ranmap, a Fortran90 code which creates PostScript (PS) images of iterated affine mappings, including the Barnsley fractal fern and the Levy dragon.
rbf_interp_1d, a C code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
rbf_interp_1d, a C++ code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
rbf_interp_1d, a Fortran77 code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
rbf_interp_1d, a Fortran90 code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
rbf_interp_1d, a MATLAB code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
rbf_interp_1d, an Octave code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
rbf_interp_1d, a Python code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
rbf_interp_2d, a C code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
rbf_interp_2d, a C++ code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
rbf_interp_2d, a Fortran77 code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
rbf_interp_2d, a Fortran90 code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
rbf_interp_2d, a MATLAB code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
rbf_interp_2d, an Octave code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
rbf_interp_2d, a Python code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
rbf_interp_nd, a C code which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.
rbf_interp_nd, a C++ code which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.
rbf_interp_nd, a Fortran77 code which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.
rbf_interp_nd, a Fortran90 code which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.
rbf_interp_nd, a MATLAB code which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.
rbf_interp_nd, an Octave code which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.
rbox, a C code which generates points in a region, selected at random according to a given distribution.
rcm, a C++ code 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 code 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 code which applies the Reverse Cuthill McKee (RCM) algorithm for reordering the nodes of a graph, and reducing the bandwidth of a corresponding sparse matrix;
reaction_ode, a MATLAB code which sets up the ordinary differential equations (ODE) which model a simple chemical reaction A+B --k--> C.
reaction_ode, an Octave code which sets up the ordinary differential equations (ODE) which model a simple chemical reaction A+B --k--> C.
reaction_ode, a Python code which sets up the ordinary differential equations (ODE) which model a simple chemical reaction A+B --k--> C.
reaction_twoway_ode, a MATLAB code which sets up the ordinary differential equations (ODE) which model a two-way chemical reaction between species W1 and W2.
reaction_twoway_ode, an Octave code which sets up the ordinary differential equations (ODE) which model a two-way chemical reaction between species W1 and W2.
reaction_twoway_ode, a Python code which sets up the ordinary differential equations (ODE) which model a two-way chemical reaction between species W1 and W2.
reaction_twoway_odefun, a Python code which uses the multiple-precision arithmetic package mpmath() to approximate the solution of the ordinary differential equations (ODE) which model a two-way chemical reaction between species W1 and W2.
reactor_simulation, a C code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
reactor_simulation, a C++ code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
reactor_simulation, a Fortran77 code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
reactor_simulation, a Fortran90 code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
reactor_simulation, a MATLAB code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
reactor_simulation, an Octave code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
reactor_simulation, a Python code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
read_mesh a FreeFem++ code which reads mesh information created by bamg(), gmsh(), medit(), mesh2d(), and savemesh().
readmatrix_test, a MATLAB code which calls readmatrix(), a built-in function which reads a data file containing numeric data in columns; it can also skip one or more initial rows, read only a specified set of columns, to avoid dealing with text input.
readtable_test, a MATLAB code which calls readtable(), a built-in MATLAB function which reads a data file containing data in columns, with some data being numeric and some text.
real_precision_test, a Fortran90 code which investigates 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++ code which converts C style comments to C++ style.
rectangle_distance, a MATLAB code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a rectangle.
rectangle_distance, an Octave code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a rectangle.
rectangle_distance, a Python code which estimates the distribution and expected value of the distance between two points picked uniformly at random within a rectangle.
refmatrix, an R code which computes the Row Echelon Form (REF) of a matrix.
reformat, a Fortran90 code which makes a copy of a file with a given number of words per line.
region, a Fortran90 code which reads 3D magnetic resonance imaging (MRI) voxel data, and groups the voxels into connected regions, called components or segments;
region, a FreeFem++ code which sets up a mesh in an "interesting" region, and writes the resulting data to files, using the ffmatlib() interface, for subsequent graphics processing by MATLAB or Octave.
region_test, a MATLAB code which plots data from an interesting region that was meshed by FreeFem++() and transferred using ffmatlib().
region_test, an Octave code which plots data from an interesting region that was meshed by FreeFem++() and transferred using ffmatlib().
regression, a dataset directory which contains datasets for testing linear regression;
regression_1d, a keras code which reads training and test files of data pairs (x,y), and seeks a regression formula y = b + w * x.
regression, a Fortran90 code which handles problems in linear regression.
regula_falsi, a Julia code which applies the regula_falsi method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
rejection_sample, a MATLAB code which demonstrates acceptance/rejection sampling.
rejection_sample, an Octave code which demonstrates acceptance/rejection sampling.
rejoin, a Fortran90 code which demonstrates a way to split or merge data files for parallel computations.
resizeImageBL, an R code which resizes an image using bilinear interpolation.
resizeImageNN, an R code which resizes an image using nearest neighbor interpolation.
reword, a C++ code which reads a text file and writes a copy which has a fixed number of words per line.
rigid_body_ode, a MATLAB code which sets up the ordinary differential equations (ODE) representing the Euler equations for a rigid body with three unequal moments of inertia, originally proposed by Fred Krogh.
rigid_body_ode, an Octave code which sets up the ordinary differential equations (ODE) representing the Euler equations for a rigid body with three unequal moments of inertia, originally proposed by Fred Krogh.
rigid_body_ode, a Python code which sets up the ordinary differential equations (ODE) representing the Euler equations for a rigid body with three unequal moments of inertia, originally proposed by Fred Krogh.
ring_data, a MATLAB code which creates, plots, or saves data generated by sampling concentric, possibly overlapping rings.
ring_data, an Octave code which creates, plots, or saves data generated by sampling concentric, possibly overlapping rings.
ring_mpi, a C code which uses the Message Passing Interface (MPI), and measures the time necessary to copy data around a ring of processes.
ring_mpi, a C++ code which uses the Message Passing Interface (MPI), and measures the time necessary to copy data around a ring of processes.
ring_mpi, a Fortran77 code which uses the Message Passing Interface (MPI), and measures the time necessary to copy data around a ring of processes.
ring_mpi, a Fortran90 code which uses the Message Passing Interface (MPI), and measures the time necessary to copy data around a ring of processes.
ripple_ode a MATLAB code which sets up an ordinary differential equation (ODE) whose solutions start as ripples and end as hyperbolas.
ripple_ode an Octave code which sets up an ordinary differential equation (ODE) whose solutions start as ripples and end as hyperbolas.
ripple_ode a Python code which sets up an ordinary differential equation (ODE) whose solutions start as ripples and end as hyperbolas.
risk_matrix, a MATLAB code which computes the transition and adjacency matrix for the game of RISK.
risk_matrix, an Octave code which computes the transition and adjacency matrix for the game of RISK.
risk_matrix, a Python code which computes the transition and adjacency matrix for the game of RISK.
rk12, a MATLAB code which solves an ordinary differential equation (ODE) using a Runge-Kutta (RK) method of order 2, estimating the local error with a Runge-Kutta method of order 1.
rk12, an Octave code which solves an ordinary differential equation (ODE) using a Runge-Kutta (RK) method of order 2, estimating the local error with a Runge-Kutta method of order 1.
rk12, a Python code which solves an ordinary differential equation (ODE) using a Runge-Kutta (RK) method of order 2, estimating the local error with a Runge-Kutta method of order 1.
rk12_adapt, a MATLAB code which implements an adaptive ODE solver using Runge-Kutta ODE solvers of orders 1 and 2.
rk12_adapt, an Octave code which implements an adaptive ODE solver using Runge-Kutta ODE solvers of orders 1 and 2.
rk23, a MATLAB code which implements Runge-Kutta solvers of orders 2 and 3 for a system of ordinary differential equations (ODE).
rk23, an Octave code which implements Runge-Kutta solvers of orders 2 and 3 for a system of ordinary differential equations (ODE).
rk23, a Python code which implements Runge-Kutta solvers of orders 2 and 3 for a system of ordinary differential equations (ODE).
rk34, a MATLAB code which implements Runge-Kutta solvers of orders 3 and 4 for a system of ordinary differential equations (ODE).
rk34, an Octave code which implements Runge-Kutta solvers of orders 3 and 4 for a system of ordinary differential equations (ODE).
rk34, a Python code which implements Runge-Kutta solvers of orders 3 and 4 for a system of ordinary differential equations (ODE).
rk4, a C code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
rk4, a C++ code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
rk4, a Fortran77 code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
rk4, a Fortran90 code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
rk4, a MATLAB code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
rk4, an Octave code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
rk4, a Python code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
rk4, an R code which uses a 4-th order Runge-Kutta method to solve an ordinary differential equation (ODE).
rk45, a MATLAB code which implements Runge-Kutta solvers of orders 4 and 5 for a system of ordinary differential equations (ODE).
rk45, an Octave code which implements Runge-Kutta solvers of orders 4 and 5 for a system of ordinary differential equations (ODE).
rk45, a Python code which implements Runge-Kutta solvers of orders 4 and 5 for a system of ordinary differential equations (ODE).
rkf45, a C code which implements the Runge-Kutta-Fehlberg (RKF) solvers of orders 4 and 5 for the adaptive solution of a system of ordinary differential equations (ODE).
rkf45, a C++ code which implements the Runge-Kutta-Fehlberg (RKF) solvers of orders 4 and 5 for the adaptive solution of a system of ordinary differential equations (ODE).
rkf45, a Fortran77 code which implements the Runge-Kutta-Fehlberg (RKF) solvers of orders 4 and 5 for the adaptive solution of a system of ordinary differential equations (ODE).
rkf45, a Fortran90 code which implements the Runge-Kutta-Fehlberg (RKF) solvers of orders 4 and 5 for the adaptive solution of a system of ordinary differential equations (ODE).
rkf45, a MATLAB code which implements the Runge-Kutta-Fehlberg (RKF) solvers of orders 4 and 5 for the adaptive solution of a system of ordinary differential equations (ODE).
rkf45, an Octave code which implements the Runge-Kutta-Fehlberg (RKF) solvers of orders 4 and 5 for the adaptive solution of a system of ordinary differential equations (ODE).
rkf45, a Python code which implements the Runge-Kutta-Fehlberg (RKF) solvers of orders 4 and 5 for the adaptive solution of a system of ordinary differential equations (ODE).
rng_cliff, a MATLAB code which computes values from the Cliff random number generator (RNG).
rng_cliff, an Octave code which computes values from the Cliff random number generator (RNG).
rng_cliff, a Python code which computes values from the Cliff random number generator (RNG).
rnglib, a C code 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++ code 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 code 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 code 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 code which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
rnglib, an Octave code 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 code which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
robertson_ode, a MATLAB code which sets up a system of three nonlinear stiff ordinary differential equations (ODE) characterizing an autocatalytic chemical reaction.
robertson_ode, an Octave code which sets up a system of three nonlinear stiff ordinary differential equations (ODE) characterizing an autocatalytic chemical reaction.
robertson_ode, a Python code which sets up a system of three nonlinear stiff ordinary differential equations (ODE) characterizing an autocatalytic chemical reaction.
roc, a Fortran90 code which computes the receiver operator characteristic (ROC);
roessler_ode, a MATLAB code which sets up the Roessler ordinary differential equations (ODE) which exhibit chaotic behavior.
roessler_ode, an Octave code which sets up the Roessler ordinary differential equations (ODE) which exhibit chaotic behavior.
roessler_ode, a Python code which sets up the Roessler ordinary differential equations (ODE) which exhibit chaotic behavior.
romberg, a Fortran90 code 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.
romberg, an R code which estimates an integral using 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 code 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++ code 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 code 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 code 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 code 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 code which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.
roots_rc, a C++ code which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.
roots_rc, a Fortran90 code which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.
roots_rc, a MATLAB code which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.
roots_rc, a Python code which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.
rot13, a C code which makes a copy of a file which has been encoded using the rot13 coding, and a ROT5 coding for digits.
rot13, a C++ code which makes a copy of a file which has been encoded using the rot13 coding, and a ROT5 coding for digits.
rot13, a Fortran90 code which enciphers a string using the rot13 cipher for letters, and the ROT5 cipher for digits.
rot13, a MATLAB code which enciphers a string using the rot13 cipher for letters, and the ROT5 cipher for digits.
rot13, an Octave code which enciphers a string using the rot13 cipher for letters, and the ROT5 cipher for digits.
rot13, a Python code which enciphers a string using the rot13 cipher for letters, and the ROT5 cipher for digits.
rotating_cube_display_opengl, a C++ code which displays a rotating color cube in 3D, using OpenGL;
rotating_cube_display_opengl_test
roulette_simulation, a MATLAB code which simulates the spinning of a roulette wheel and the evaluation of certain common roulette bets.
roulette_simulation, an Octave code which simulates the spinning of a roulette wheel and the evaluation of certain common roulette bets.
roulette_simulation, a Python code which simulates the spinning of a roulette wheel and the evaluation of certain common roulette bets.
row_echelon_integer, a C code 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++ code 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 code 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 code 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, an Octave code 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 code 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_test, a MATLAB code which calls rref() for the reduced row echelon form (RREF) of a matrix, which may be singular or rectangular.
rref_test, an Octave code which calls rref() for the reduced row echelon form (RREF) of a matrix, which may be singular or rectangular.
rrefmatrix, an R code which computes the Reduced Row Echelon Form (RREF) of a matrix.
rsites, a C++ code which generates random pointsets with integer coordinates for testing computational geometry algorithms, by Ken Clarkson.
rubber_band_ode, a MATLAB code which sets up ordinary differential equations (ODE) describing a mass suspended by a spring and rubber band, which exhibits chaotic behavior.
rubber_band_ode, an Octave code which sets up ordinary differential equations (ODE) describing a mass suspended by a spring and rubber band, which exhibits chaotic behavior.
rubber_band_ode, a Python code which sets up ordinary differential equations (ODE) describing a mass suspended by a spring and rubber band, which exhibits chaotic behavior.
rucklidge_ode, a MATLAB code which sets up and solves the Rucklidge ordinary differential equation (ODE), a model of double convection which embodies a transition to chaos.
rucklidge_ode, an Octave code which sets up and solves the Rucklidge ordinary differential equation (ODE), a model of double convection which embodies a transition to chaos.
rucklidge_ode, a Python code which sets up and solves the Rucklidge ordinary differential equation (ODE), a model of double convection which embodies a transition to chaos.
s2de_freefem++, examples which use FREEFEM++, which solves steady-state incompressible Stokes flow problems.
sa, an R code which seeks the minimizer of a function using simulated annealing.
sammon, a dataset directory which contains six sets of M-dimensional data for cluster analysis.
sammon_data, a MATLAB code which generates six sets of M-dimensional data for cluster analysis.
sammon_data, a Python code which generates six sets of M-dimensional data for cluster analysis.
sammon_data, a Python code 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;
sandia_cubature, a C++ code which computes M-dimensional quadrature rules for certain regions and weight functions.
sandia_cubature, a Fortran90 code which computes M-dimensional quadrature rules for certain regions and weight functions.
sandia_cubature, a MATLAB code which computes M-dimensional quadrature rules for certain regions and weight functions.
sandia_cubature, an Octave code which computes M-dimensional quadrature rules for certain regions and weight functions.
sandia_cvt, a Fortran90 code which positions a given number of points in an arbitrary region, using probabilistic Centroidal Voronoi Tessellation (CVT) techniques to achieve good coverage and separation; developed for Sandia National Laboratories;
sandia_rules, a C code 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++ code 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 code 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 code 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, an Octave code 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++ code 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++ code 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++ code 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++ code which explores a generalized construction method for sparse grids.
sandia_sgmgg, a Fortran90 code which explores a generalized construction method for sparse grids.
sandia_sgmgg, a MATLAB code which explores a generalized construction method for sparse grids.
sandia_sgmgg, an Octave code which explores a generalized construction method for sparse grids.
sandia_sparse, a C++ code which produces 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 code which produces 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 code which produces 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, an Octave code which produces 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_brute, a C code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
satisfy_brute, a C++ code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
satisfy_brute, a Fortran77 code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
satisfy_brute, a Fortran90 code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
satisfy_brute, a MATLAB code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
satisfy_brute, an Octave code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
satisfy_brute, a Python code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
satisfy_mpi, a C code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using the Message Passing Interface (MPI) to work in parallel.
satisfy_mpi, a C++ code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using the Message Passing Interface (MPI) to work in parallel.
satisfy_mpi, a Fortran77 code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using the Message Passing Interface (MPI) to work in parallel.
satisfy_mpi, a Fortran90 code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using the Message Passing Interface (MPI) to work in parallel.
satisfy_openmp, a C code 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++ code 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 code 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 code 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 code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, running in parallel using the parfor() feature.
sawtooth_ode, a MATLAB code which sets up an ordinary differential equation (ODE) driven by a right hand side which is a sawtooth function (periodic, discontinuous, piecewise linear (PWL)).
sawtooth_ode, an Octave code which sets up an ordinary differential equation (ODE) driven by a right hand side which is a sawtooth function (periodic, discontinuous, piecewise linear (PWL)).
sawtooth_ode, a Python code which sets up an ordinary differential equation (ODE) driven by a right hand side which is a sawtooth function (periodic, discontinuous, piecewise linear (PWL)).
scalapack, examples which use SCAlapack, which is a library for the configuration, distribution, and solution of linear algebra problems using distributed memory and parallel processing.
scalapack_test, a Fortran90 code which uses scalapack(), which is a linear algebra library for parallel computing.
schedule_openmp, a C code which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.
schedule_openmp, a C++ code which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.
schedule_openmp, a Fortran77 code which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.
schedule_openmp, a Fortran90 code which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.
schroedinger, a FreeFem++ code which sets up the Schroedinger equation.
schroedinger_linear_pde, a MATLAB code which solves the complex partial differential equation (PDE) known as Schroedinger's linear equation: dudt = i uxx, in one spatial dimension, in one space dimension and time, with Neumann boundary conditions.
schroedinger_linear_pde, an Octave code which solves the complex partial differential equation (PDE) known as Schroedinger's linear equation: dudt = i uxx, in one spatial dimension, in one space dimension and time, with Neumann boundary conditions.
schroedinger_nonlinear_pde, a MATLAB code which solves the complex partial differential equation (PDE) known as Schroedinger's nonlinear equation: dudt = i uxx + gamma * |u|^2 u, in one spatial dimension and time, with Neumann boundary conditions.
schroedinger_nonlinear_pde_test
schroedinger_nonlinear_pde, an Octave code which solves the complex partial differential equation (PDE) known as Schroedinger's nonlinear equation: dudt = i uxx + gamma * |u|^2 u, in one spatial dimension and time, with Neumann boundary conditions.
schroedinger_nonlinear_pde_test
schwarz_overlap, a FreeFem++ code which demonstrates how the Schwarz method is implemented. Here, a domain is replaced by two overlapping subdomains.
scip, examples which call scip(), which is a code which solves mixed integer programming and mixed integer nonlinear programming problems.
scip_solution_read, a MATLAB code 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 to be read by the load() function.
scip_solution_read, an Octave code 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 to be read by the load() function.
scipy, examples which use scipy(), which is a Python library of algorithms addressing common problems in scientific computing.
scotch_test, a Fortran77 code which tests the scotch sparse matrix package.
scpack, a Fortran77 code which performs the numerical computation of Schwarz-Christoffel conformal mappings, by Nick Trefethen.
screenshot_opengl, a C code which uses OpenGL() to save a screenshot of the graphics being displayed.
screenshot_opengl, a C++ code which uses OpenGL() to save a screenshot of the graphics being displayed.
scvt_mpi, a C++ code which determines a Centroidal Voronoi Tessellation (CVT) on a spherical surface, using Jonathan Shewchuk's triangle() program for triangulation, and the boost mpi and serialization libraries, by Doug Jacobsen;
sde, a C code which illustrates properties of stochastic ordinary differential equations (SDE), 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++ code which illustrates properties of stochastic ordinary differential equations (SDE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;
sde, a Fortran77 code which illustrates properties of stochastic ordinary differential equations (SDE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;
sde, a Fortran90 code which illustrates properties of stochastic ordinary differential equations (SDE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;
sde, a MATLAB code which illustrates properties of stochastic ordinary differential equations (SDE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;
sde, an Octave code which illustrates properties of stochastic ordinary differential equations (SDE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, by Desmond Higham;
search, a C code 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_test, a C code which searches integers between A and B for a value J such that F(J) = C.
search_test, a MATLAB code which searches integers between A and B for a value J such that F(J) = C.
search_test, an Octave code which searches integers between A and B for a value J such that F(J) = C.
search_mpi, a C code 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++ code 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 code 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 code 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 code 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++ code 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 code 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 code 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 code 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.
secant, an R code which seeks a root of a single nonlinear function using the secant method.
sed_test, a bash code which uses the stream editor sed to edit a file in batch mode.
select, a Fortran77 code which generates various combinatorial objects.
select, a Fortran90 code which generates various combinatorial objects.
semicircle_integrals, a Mathematica code which evaluates the integral of a function f(x,y) over the unit semicircle -1 <= x <= +1, 0 <= y <= sqrt (1-x^2).
sensitive_ode, a MATLAB code which sets up a second order ordinary differential equation (ODE) which exhibits sensitive dependence on the initial condition.
sensitive_ode, a Python code which sets up a second order ordinary differential equation (ODE) which exhibits sensitive dependence on the initial condition.
sequence, a Fortran90 code which reads a numeric sequence with missing values, and fills in the missing values.
sequence_streak_display, a MATLAB code which displays a streak plot of a numeric sequence;
serba, a Fortran77 code which applies the boundary element method (BEM) to solve the elasticity equation in a 2D region, by Federico Paris and Jose Canas.
serenity, a MATLAB code which considers the serenity puzzle, a smaller version of the eternity puzzle. The serenity puzzle specifies a dodecagonal region R composed of 288 30-60-90 triangles, and a set of 8 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
serenity, an Octave code which considers the serenity puzzle, a smaller version of the eternity puzzle. The serenity puzzle specifies a dodecagonal region R composed of 288 30-60-90 triangles, and a set of 8 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
serenity_cplex_test a BASH code which calls cplex(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
serenity_cplex_test a BASH code which calls cplex(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
serenity_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
serenity_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the serenity tiling problem, solve the linear programming problem, and write the solution to a file.
set_theory, a C code which demonstrates various set theoretic operations such as union, intersection, complement, symmetric difference.
set_theory, a C++ code which demonstrates various set theoretic operations such as union, intersection, complement, symmetric difference.
set_theory, a Fortran77 code which demonstrates various set theoretic operations such as union, intersection, complement, symmetric difference.
set_theory, a Fortran90 code which demonstrates various set theoretic operations such as union, intersection, complement, symmetric difference.
set_theory, a MATLAB code which demonstrates various set theoretic operations such as union, intersection, complement, symmetric difference.
set_theory, an Octave code which demonstrates various set theoretic operations such as union, intersection, complement, symmetric difference.
set_theory, a Python code which demonstrates various set theoretic operations such as union, intersection, complement, symmetric difference.
setmat, a Fortran77 code which sets and gets matrix entries using a variety of matrix storage formats.
sftpack, a C code which implements the slow Fourier transform (SFT), intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
sftpack, a C++ code which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
sftpack, a Fortran77 code which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
sftpack, a Fortran90 code which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
sftpack, a MATLAB code which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
sftpack, an Octave code which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
sftpack, a Python code 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 the Stanford Graph Base (SGB), by Donald Knuth.
sge, examples which use SGE, which is the Sun grid Engine, 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 code which reimplements the sgefa/sgesl linear algebra routines from linpack for use with OpenMP.
sgefa_openmp, a C++ code which reimplements the sgefa/sgesl linear algebra routines from linpack for use with OpenMP.
sgefa_openmp, a Fortran77 code which reimplements the sgefa/sgesl linear algebra routines from linpack for use with OpenMP.
sgefa_openmp, a Fortran90 code which reimplements the sgefa/sgesl linear algebra routines from linpack for use with OpenMP.
sgmg, a C++ code 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 code which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.
sgmga, a C++ code which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.
sgmga, a Fortran90 code which creates sparse grids based on a mixture of 1D quadrature rules, allowing anisotropic weights for each dimension.
sgmga, a MATLAB code 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 code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations (SWE).
shallow_water_1d, a C++ code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations (SWE).
shallow_water_1d, a Fortran90 code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations (SWE).
shallow_water_1d, a MATLAB code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations (SWE).
shallow_water_1d_display, a MATLAB code which displays the solution at a given timestep of the shallow water equations (SWE) in 1D, as computed by shallow_water_1d().
shallow_water_1d_movie, a MATLAB code which solves the partial differential equation (PDE) known as the shallow water equations (SWE), converting the solutions to a sequence of graphics frames, which are then assembled into a movie.
shallow_water_2d, a MATLAB code which simulates the evolution of a 2D fluid governed by the time-dependent shallow water equations (SWE), by Cleve Moler.
shallow_water_2d, a Python code which simulates the evolution of a 2D fluid governed by the time-dependent shallow water equations (SWE).
shellmethod, an R code which estimates the volume inside a surface of revolution using the shell method.
shepard_interp_1d, a C code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
shepard_interp_1d, a C++ code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
shepard_interp_1d, a Fortran77 code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
shepard_interp_1d, a Fortran90 code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
shepard_interp_1d, a MATLAB code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
shepard_interp_1d, an Octave code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
shepard_interp_1d, a Python code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
shepard_interp_2d, a C code which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.
shepard_interp_2d, a C++ code which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.
shepard_interp_2d, a Fortran77 code which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.
shepard_interp_2d, a Fortran90 code which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.
shepard_interp_2d, a MATLAB code which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.
shepard_interp_2d, an Octave code which defines and evaluates Shepard interpolants to scattered 2D data, based on inverse distance weighting.
shepard_interp_nd, a C code which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.
shepard_interp_nd, a C++ code which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.
shepard_interp_nd, a Fortran77 code which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.
shepard_interp_nd, a Fortran90 code which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.
shepard_interp_nd, a MATLAB code which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.
shepard_interp_nd, an Octave code which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.
shock a FreeFem++ code which solves the Euler equations to model supersonic perfect gas flow around an elliptical obstacle.
shoreline, a MATLAB code which tries to identify and triangulate the 2D domain over which some function f(x,y) is nonnegative.
shoreline2, a MATLAB code which tries to identify and triangulate the 2D domain over which some function f(x,y) is approximately zero.
showme, a C code which uses x_windows() to display triangulatons, by Jonathan Shewchuk.
side_by_side_display_test, a MATLAB code which displays curves side by side in a 3D plot; the curves might be yearly snowfall data over consecutive years, for instance.
sigmoid_derivative, a C code which evaluates derivatives of any order for the sigmoid function s(x)=1/(1+exp(-x)). The test code creates graphics images using gnuplot().
sigmoid_derivative, a C++ code which evaluates derivatives of any order for the sigmoid function s(x)=1/(1+exp(-x)). The test code creates graphics images using gnuplot().
sigmoid_derivative, a Fortran90 code which evaluates derivatives of any order for the sigmoid function s(x)=1/(1+exp(-x)). The test code creates graphics images using gnuplot().
sigmoid_derivative, a MATLAB code which evaluates derivatives of any order for the sigmoid function s(x)=1/(1+exp(-x)).
sigmoid_derivative, an Octave code which evaluates derivatives of any order for the sigmoid function s(x)=1/(1+exp(-x)).
sigmoid_derivative, a Python code which evaluates derivatives of any order for the sigmoid function s(x)=1/(1+exp(-x)).
signal_classify_nmf, a scikit-learn code which uses non-negative matrix factorization (NMF) to match new signals to items in the signal dataset.
simp, an R code which estimates an integral using the Simpson quadrature rule.
simp38, an R code which estimates an integral using the Simpson 3/8 quadrature rule.
simpack, a Fortran77 code which approximates the integral of a function over an M-dimensional simplex, by Alan Genz.
simple_ga, a C++ code which a simple example of a genetic algorithm, by Dennis Cormier and Sita Raghavan.
simplex_coordinates, a C code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions with barycenter at the origin.
simplex_coordinates, a C++ code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions with barycenter at the origin.
simplex_coordinates, a Fortran77 code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions with barycenter at the origin.
simplex_coordinates, a Fortran90 code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
simplex_coordinates, a MATLAB code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions with barycenter at the origin.
simplex_coordinates, an Octave code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions with barycenter at the origin.
simplex_coordinates, a Python code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions with barycenter at the origin.
simplex_gm_rule, a C code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
simplex_gm_rule, a C++ code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
simplex_gm_rule, a Fortran77 code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
simplex_gm_rule, a Fortran90 code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
simplex_gm_rule, a MATLAB code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
simplex_gm_rule, an Octave code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
simplex_gm_rule, a Python code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
simplex_grid, a C code which generates a grid of points over the interior of a simplex in M dimensions.
simplex_grid, a C++ code which generates a grid of points over the interior of a simplex in M dimensions.
simplex_grid, a Fortran77 code which generates a grid of points over the interior of a simplex in M dimensions.
simplex_grid, a Fortran90 code which generates a grid of points over the interior of a simplex in M dimensions.
simplex_grid, a MATLAB code which generates a grid of points over the interior of a simplex in M dimensions.
simplex_grid, an Octave code which generates a grid of points over the interior of a simplex in M dimensions.
simplex_grid, a Python code which generates a grid of points over the interior of a simplex in M dimensions.
simplex_integrals, a C code 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++ code 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 code 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 code 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 code which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.
simplex_integrals, an Octave code 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 code 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 code which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.
simplex_monte_carlo, a C++ code which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.
simplex_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.
simplex_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.
simplex_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.
simplex_monte_carlo, an Octave code which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.
simplex_monte_carlo, a Python code which uses the Monte Carlo method to estimate integrals over the interior of the unit simplex in M dimensions.
sine_gordon_exact, a C code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
sine_gordon_exact, a C++ code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
sine_gordon_exact, a Fortran90 code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
sine_gordon_exact, a MATLAB code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
sine_gordon_exact, an Octave code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
sine_gordon_exact, a Python code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
sine_transform, a C code which demonstrates some simple properties of the discrete sine transform.
sine_transform, a C++ code which demonstrates some simple properties of the discrete sine transform.
sine_transform, a Fortran77 code which demonstrates some simple properties of the discrete sine transform.
sine_transform, a Fortran90 code which demonstrates some simple properties of the discrete sine transform.
sine_transform, a MATLAB code which demonstrates some simple properties of the discrete sine transform.
sine_transform, an Octave code which demonstrates some simple properties of the discrete sine transform.
sine_transform, a Python code which demonstrates some simple properties of the discrete sine transform.
single_linkage_test, a MATLAB code which demonstrates the use of the MATLAB single linkage clustering functions.
sir_ode, a MATLAB code which sets up the ordinary differential equations (ODE) which simulate the spread of a disease using the Susceptible/Infected/Recovered (SIR) model.
sir_ode, an Octave code which sets up the ordinary differential equations (ODE) which simulate the spread of a disease using the Susceptible/Infected/Recovered (SIR) model.
sir_ode, a Python code which sets up the ordinary differential equations (ODE) which simulate the spread of a disease using the Susceptible/Infected/Recovered (SIR) model.
sir_simulation, a MATLAB code which simulates the spread of a disease through a hospital room of M by N beds, using the Susceptible/Infected/Recovered (SIR) model.
sir_simulation, an Octave code which simulates the spread of a disease through a hospital room of M by N beds, using the Susceptible/Infected/Recovered (SIR) model.
sir_simulation, a Python code which simulates the spread of a disease through a hospital room of M by N beds, using the Susceptible/Infected/Recovered (SIR) model.
slap, a data directory which contains examples of SLAP files, a sparse matrix file format used by the Sparse Linear Algebra Package (SLAP);
slap, a Fortran90 code which forms the Sparse Linear Algebra Package (SLAP), for the iterative solution of sparse linear systems, by Anne Greenbaum and Mark Seager.
slap_io, a Fortran77 code which reads and writes sparse matrix files in the SLAP format;
slap_io, a Fortran90 code which reads and writes sparse matrix files in the SLAP format;
slap_io, a MATLAB code which reads and writes sparse matrix files in the SLAP format;
slatec, a Fortran90 code which collects together standard numerical libraries, including blas(), bvsup(), dassl(), depac(), drive(), eispack(), fftpack(), fishpack(), fnlib(), linpack(), machine(), minpack(), mp(), pchip(), pppack(), quadpack(), slap(), sos(), splp(), and xerror().
sling_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) for which the exact circular solution can only be approximated for a short interval before it decays to zero.
sling_ode, an Octave code which sets up a system of ordinary differential equations (ODE) for which the exact circular solution can only be approximated for a short interval before it decays to zero.
sling_ode, a Python code which sets up a system of ordinary differential equations (ODE) for which the exact circular solution can only be approximated for a short interval before it decays to zero.
slurm, examples which use slurm, which is a job scheduler for batch execution of jobs on a computer cluster.
smdlib_fonts, a Fortran77 code which reads ASCII files defining fonts, and creates a single direct access binary font file for use by smdlib().
smdlib_fonts, a Fortran90 code which reads ASCII files defining fonts, and creates a single direct access binary font file for use by smdlib().
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 code which estimates the integral of a function over a M-dimensional hypercube using a sparse grid, by Knut Petras;
smolpack_interactive, a C code which interactively exercises smolpack() on particular test functions, by Knut Petras;
smolyak_display, a MATLAB code 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, a C code which provides tools for studying the game of Snakes and Ladders.
snakes_and_ladders, a C++ code which provides tools for studying the game of Snakes and Ladders.
snakes_and_ladders, a Fortran77 code which provides tools for studying the game of Snakes and Ladders.
snakes_and_ladders, a Fortran90 code which provides tools for studying the game of Snakes and Ladders.
snakes_and_ladders, a MATLAB code which provides tools for studying the game of Snakes and Ladders.
snakes_and_ladders, an Octave code which provides tools for studying the game of Snakes and Ladders.
snakes_and_ladders, a Python code which provides tools for studying the game of Snakes and Ladders.
snakes_and_ladders_simulation, a MATLAB code which simulates a one-player game of Snakes and Ladders, to produce histograms of the count, PDF and CDF estimates for the length of a one-player game.
snakes_and_ladders_simulation_test
snakes_and_ladders_simulation, an Octave code which simulates a one-player game of Snakes and Ladders, to produce histograms of the count, PDF and CDF estimates for the length of a one-player game.
snakes_and_ladders_simulation_test
snakes_and_ladders_simulation, a Python code which simulates a one-player game of Snakes and Ladders, to produce histograms of the count, PDF and CDF estimates for the length of a one-player game.
snakes_bar, a MATLAB code 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_game, a MATLAB code which simulates the game of Snakes and Ladders, by Mina Aymin.
snakes_matrix, a MATLAB code which computes the transition matrix for Snakes and Ladders.
snakes_matrix, an Octave code which computes the transition matrix for Snakes and Ladders.
snakes_matrix, a Python code which computes the transition matrix for Snakes and Ladders.
snakes_probability, a MATLAB code which computes the game length probabilities for Snakes and Ladders, by Desmond Higham and Nicholas Higham.
snakes_probability, an Octave code which computes the game length probabilities for Snakes and Ladders, by Desmond Higham and Nicholas Higham.
sncndn, a Fortran90 code which evaluates the Jacobi elliptic functions sn(u,m), cn(u,m), and dn(u,m).
sncndn, a MATLAB code which evaluates the Jacobi elliptic functions sn(u,m), cn(u,m), and dn(u,m).
sncndn, an Octave code which evaluates the Jacobi elliptic functions sn(u,m), cn(u,m), and dn(u,m).
sncndn, a Python code which evaluates the Jacobi elliptic functions sn(u,m), cn(u,m), and dn(u,m).
sobol, a dataset directory which contains samples of the Sobol Quasi Monte Carlo (QMC) sequence;
sobol, a C++ code which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence, by Bennett Fox.
sobol, a Fortran90 code which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence, by Bennett Fox.
sobol, a MATLAB code which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence, by Bennett Fox.
sobol, a Python code which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence.
sobol_dataset, a C++ code which computes a Sobol Quasi Monte Carlo (QMC) sequence and writes it to a file.
sobol_dataset, a Fortran90 code which computes a Sobol Quasi Monte Carlo (QMC) sequence and writes it to a file.
sobol_dataset, a MATLAB code 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 code which implements a linear solver which makes it easy to create doubly-dimensioned arrays and solve associated linear systems.
solve, a C++ code which implements a linear solver which makes it easy to create doubly-dimensioned arrays and solve associated linear systems.
solve, a Fortran77 code which uses Gauss elimination to solve a simple system of linear equations A*x=b.
solve, a Fortran90 code which uses Gauss elimination to solve a simple system of linear equations A*x=b.
solve, a MATLAB code which demonstrates how Gauss elimination solves a simple system of linear equations A*x=b.
solve, an Octave code which demonstrates how Gauss elimination solves a simple system of linear equations A*x=b.
solve, a Python code which demonstrates how Gauss elimination solves a simple system of linear equations A*x=b.
solve_bvp_test, a Python code which calls scipy.integrate.solve_bvp(), which solves boundary value problems (BVP) in one spatial dimension.
solvematrix, an R code which solves a linear system by transforming it to Reduced Row Echelon Form (RREF).
sor, a C code which implements a simple version of the successive over-relaxation (SOR) method for the iteration solution of a linear system of equations.
sor, a C++ code 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 code 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 use sort(), which is a unix system command.
sort_rc, a C code which sorts a list of any kind of objects, using reverse communication (RC).
sort_rc, a C++ code which sorts a list of any kind of objects, using reverse communication (RC).
sort_rc, a Fortran77 code which sorts a list of any kind of objects, using reverse communication (RC).
sort_rc, a Fortran90 code which sorts a list of any kind of objects, using reverse communication (RC).
sort_rc, a MATLAB code which sorts a list of any kind of objects, using reverse communication (RC).
sort_rc, a Python code which sorts a list of any kind of objects, using reverse communication (RC).
sort_test, a bash code which calls the sort() function to sort items of various types.
sort_test, a MATLAB code which calls the sort() function to sort items of various types.
sort_test, an Octave code which calls the sort() function to sort items of various types.
sortrows, a Python code which lexically sorts the rows of an array, in a similar fashion to the MATLAB sortrows() function.
spaeth, a dataset directory which contains datasets for cluster analysis;
spaeth, a Fortran90 code which clusters data according to various principles, by Helmut Spaeth.
spaeth2, a dataset directory which contains datasets for cluster analysis;
spaeth2, a Fortran77 code which clusters data according to various principles, by Helmut Spaeth.
spaeth2, a Fortran90 code which clusters data according to various principles, by Helmut Spaeth.
sparse_count, a C++ code which analyzes 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 code which analyzes 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 code which analyzes 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 code which reads information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is already available in the built-in matlab spy() command.
sparse_display, a C++ code which reads information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is already available in the built-in matlab spy() command.
sparse_display, a Fortran77 code which reads information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is similar to the built-in matlab spy() command.
sparse_display, a Fortran90 code which reads information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is similar to the built-in matlab spy() command.
sparse_display, a MATLAB code which reads information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is already available in the built-in matlab spy() command.
sparse_grid, a Python code which contains classes and functions defining sparse grids, by Jochen Garcke.
sparse_grid_cc, a C code which creates sparse grids based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc, a C++ code which creates sparse grids based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc, a Fortran77 code which creates sparse grids based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc, a Fortran90 code which creates sparse grids based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc, a MATLAB code which creates sparse grids based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc, an Octave code which creates sparse grids based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc_dataset, a C code which creates a sparse grid dataset based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc_dataset, a C++ code which creates a sparse grid dataset based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc_dataset, a Fortran77 code which creates a sparse grid dataset based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc_dataset, a Fortran90 code which creates a sparse grid dataset based on Clenshaw-Curtis (CC) rules.
sparse_grid_cc_dataset, a MATLAB code which creates a sparse grid dataset based on Clenshaw-Curtis (CC) 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 code 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++ code which creates sparse grids based on Gauss-Legendre (GL) rules.
sparse_grid_gl, a Fortran90 code which creates sparse grids based on Gauss-Legendre (GL) rules.
sparse_grid_gl, a MATLAB code which creates sparse grids based on Gauss-Legendre (GL) rules.
sparse_grid_gl, an Octave code which creates sparse grids based on Gauss-Legendre (GL) rules.
sparse_grid_gl_dataset, a C++ code which creates a sparse grid dataset based on Gauss-Legendre rules.
sparse_grid_gl_dataset, a Fortran90 code which creates a sparse grid dataset based on Gauss-Legendre rules.
sparse_grid_gl_dataset, a MATLAB code 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 (GLE) growth rule.
sparse_grid_gll, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Legendre Linear (GLL) growth rule.
sparse_grid_glo, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Legendre Linear Odd (GLO) growth rule.
sparse_grid_gpe, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Patterson Exponential (GPE) growth rule;
sparse_grid_gps, a dataset directory which contains M-dimensional Smolyak sparse grids based on the 1D Gauss-Patterson Slow (GPS) 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++ code which creates sparse grids based on Gauss-Hermite rules.
sparse_grid_hermite, a Fortran90 code which creates sparse grids based on Gauss-Hermite rules.
sparse_grid_hermite, a MATLAB code which creates sparse grids based on Gauss-Hermite rules.
sparse_grid_hermite, an Octave code which creates sparse grids based on Gauss-Hermite rules.
sparse_grid_hermite_dataset, a C++ code which creates a sparse grid dataset based on Gauss-Hermite rules.
sparse_grid_hermite_dataset, a Fortran90 code which creates a sparse grid dataset based on Gauss-Hermite rules.
sparse_grid_hermite_dataset, a MATLAB code which creates a sparse grid dataset based on Gauss-Hermite rules.
sparse_grid_hw, a C code which creates sparse grids based on Gauss-legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
sparse_grid_hw, a C++ code which creates sparse grids based on Gauss-legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
sparse_grid_hw, a Fortran77 code which creates sparse grids based on Gauss-legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
sparse_grid_hw, a Fortran90 code which creates sparse grids based on Gauss-legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
sparse_grid_hw, a MATLAB code which creates sparse grids based on Gauss-legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
sparse_grid_hw, an Octave code which creates sparse grids based on Gauss-legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
sparse_grid_laguerre, a dataset directory which contains M-dimensional Smolyak sparse grids based on the Gauss-Laguerre rule;
sparse_grid_laguerre, a C++ code which creates sparse grids based on Gauss-Laguerre rules.
sparse_grid_laguerre, a Fortran90 code which creates sparse grids based on Gauss-Laguerre rules.
sparse_grid_laguerre, a MATLAB code which creates sparse grids based on Gauss-Laguerre rules.
sparse_grid_laguerre, an Octave code which creates sparse grids based on Gauss-Laguerre rules.
sparse_grid_laguerre_dataset, a C++ code which creates a sparse grid dataset based on Gauss-Laguerrre rules.
sparse_grid_laguerre_dataset, a Fortran90 code which creates a sparse grid dataset based on Gauss-Laguerrre rules.
sparse_grid_laguerre_dataset, a MATLAB code which creates a sparse grid dataset based on Gauss-Laguerrre rules.
sparse_grid_mixed, a C++ code which creates a sparse grid 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 code which creates a sparse grid based on a mixed set of 1D factor rules.
sparse_grid_mixed, a MATLAB code which creates a sparse grid based on a mixed set of 1D factor rules.
sparse_grid_mixed, an Octave code which creates a sparse grid based on a mixed set of 1D factor rules.
sparse_grid_mixed_dataset, a C++ code which creates a sparse grid dataset based on a mixture of 1D rules.
sparse_grid_mixed_dataset, a Fortran90 code which creates a sparse grid dataset based on a mixture of 1D rules.
sparse_grid_mixed_dataset, a MATLAB code 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++ code which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
sparse_grid_open, a Fortran90 code which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
sparse_grid_open, a MATLAB code which creates sparse grids based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
sparse_grid_open_dataset, a C++ code which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
sparse_grid_open_dataset, a Fortran90 code which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
sparse_grid_open_dataset, a MATLAB code which creates a sparse grid dataset based on open rules (Fejer 2, Gauss-Patterson, Newton-Cotes-Open).
sparse_grid_total_poly, a MATLAB code which investigates the efficient approximation of all polynomials up to a given total degree using sparse grids.
sparse_grid_total_poly, an Octave code which investigates the efficient approximation of all polynomials up to a given total degree using sparse grids.
sparse_interp_nd, a C code which defines a sparse interpolant to a function f(x) of a M-dimensional argument.
sparse_interp_nd, a C++ code which defines a sparse interpolant to a function f(x) of a M-dimensional argument.
sparse_interp_nd, a Fortran77 code which defines a sparse interpolant to a function f(x) of a M-dimensional argument.
sparse_interp_nd, a Fortran90 code which defines a sparse interpolant to a function f(x) of a M-dimensional argument.
sparse_interp_nd, a MATLAB code which define a sparses interpolant to a function f(x) of a M-dimensional argument.
sparse_interp_nd, an Octave code which define a sparses interpolant to a function f(x) of a M-dimensional argument.
sparse_parfor, a MATLAB code which constructs a sparse matrix by evaluating individual blocks in parallel with the parfor() command, and then assembled on a single processor using the sparse() command, by Gene Cliff.
sparse_test, a MATLAB code which tests the sparse() functions for creating sparse matrices and carrying out linear algebraic functions on them;
sparse_test, an Octave code which tests the sparse() functions for creating sparse matrices and carrying out linear algebraic functions on them;
sparse_test, a Python code which tests the scipy.sparse() functions for creating sparse matrices and carrying out linear algebraic functions on them;
sparsekit, a Fortran77 code which implements operations on sparse matrices, including conversion between various formats, by Yousef Saad.
sparsekit, a Fortran90 code which implements operations on sparse matrices, including conversion between various formats, by Yousef Saad.
sparsekit2, a Fortran77 code which implements operations on sparse matrices, including conversion between various formats, by Yousef Saad.
sparsepak, a Fortran77 code which is a version of the Waterloo Sparse Matrix Package.
sparsepak, a Fortran90 code which is a version of the Waterloo Sparse Matrix Package.
spd_test, a MATLAB code which performs a few tests on a real matrix to determine whether it is symmetric positive definite (SPD).
spd_test, an Octave code which performs a few tests on a real matrix to determine whether it is symmetric positive definite (SPD).
specfun, a Fortran77 code 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 code 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 code which evaluates special functions, including Airy, Associated Legendre, Bernoulli Numbers, Bessel, Beta, Complete Elliptic Integral, Cosine Integral, Elliptic Integral, Error, Euler Numbers, Exponential Integral, Fresnel Integral, Gamma, Hankel, Hermite polynomials, Hypergeometric 2F1, Incomplete Beta, Incomplete Gamma, Jacobi Elliptic, Kelvin, Kummer Confluent Hypergeometric, Laguerre polynomials, Lambda, Legendre functions, Legendre polynomials, Mathieu, Modified Spherical Bessel, Parabolic Cylinder, Psi, Riccati-Bessel, Sine Integral, Spheroidal Angular, Spheroidal Wave, Struve, Tricomi Confluent Hypergeometric, Whittaker, by Shanjie Zhang, Jianming Jin;
special_functions, a Fortran90 code which evaluates special functions, including Airy, Associated Legendre, Bernoulli Numbers, Bessel, Beta, Complete Elliptic Integral, Cosine Integral, Elliptic Integral, Error, Euler Numbers, Exponential Integral, Fresnel Integral, Gamma, Hankel, Hermite polynomials, Hypergeometric 2F1, Incomplete Beta, Incomplete Gamma, Jacobi Elliptic, Kelvin, Kummer Confluent Hypergeometric, Laguerre polynomials, Lambda, Legendre functions, Legendre polynomials, Mathieu, Modified Spherical Bessel, Parabolic Cylinder, Psi, Riccati-Bessel, Sine Integral, Spheroidal Angular, Spheroidal Wave, Struve, Tricomi Confluent Hypergeometric, Whittaker, by Shanjie Zhang, Jianming Jin;
sphere_cubed_grid, a Fortran90 code 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 code 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, an Octave code 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 code which uses a Centroidal Voronoi Tessellation (CVT) to create a mesh of well-separated points on the surface of the unit sphere in 3D.
sphere_cvt, a MATLAB code which uses a Centroidal Voronoi Tessellation (CVT) to create a mesh of well-separated points on the surface of the unit sphere in 3D.
sphere_cvt, an Octave code which uses a Centroidal Voronoi Tessellation (CVT) to create a mesh of well-separated points on the surface of the unit sphere in 3D.
sphere_delaunay, a Fortran90 code which computes and plots the Delaunay triangulation of points on the surface of the unit sphere in 3D.
sphere_delaunay, a MATLAB code which computes the Delaunay triangulation of points on the surface of the unit sphere in 3D.
sphere_delaunay, an Octave code which computes and plots 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 estimate integrals.
sphere_design_rule, a Fortran90 code which returns point sets on the surface of the unit sphere in 3D, known as designs, which estimate integrals.
sphere_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit sphere in 3D.
sphere_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit sphere in 3D.
sphere_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit sphere in 3D.
sphere_exactness, a C code which tests the exactness of a quadrature rule over the surface of the unit sphere in 3D.
sphere_exactness, a C++ code which tests the exactness of a quadrature rule over the surface of the unit sphere in 3D.
sphere_exactness, a Fortran77 code which tests the exactness of a quadrature rule over the surface of the unit sphere in 3D.
sphere_exactness, a Fortran90 code which tests the exactness of a quadrature rule over the surface of the unit sphere in 3D.
sphere_exactness, a MATLAB code which tests the exactness of a quadrature rule over the surface of the unit sphere in 3D.
sphere_exactness, an Octave code which tests the exactness of a quadrature rule over the surface of the unit sphere in 3D.
sphere_fibonacci_grid, a C code 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++ code 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 code 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 code 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 code which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.
sphere_fibonacci_grid, an Octave code 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 code 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 code which generates 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++ code which generates 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 code which generates 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 code which generates 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 code which generates 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, an Octave code which generates 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 code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
sphere_integrals, a C++ code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
sphere_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
sphere_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
sphere_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
sphere_integrals, an Octave code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
sphere_integrals, a Python code 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 estimate integrals.
sphere_lebedev_rule, a C code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
sphere_lebedev_rule, a C++ code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
sphere_lebedev_rule, a Fortran77 code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
sphere_lebedev_rule, a Fortran90 code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
sphere_lebedev_rule, a MATLAB code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
sphere_lebedev_rule_display, a MATLAB code which reads a file defining a Lebedev quadrature rule on the surface of the unit sphere in 3D and displays the point locations.
sphere_lebedev_rule_display_test
sphere_lebedev_rule_display, an Octave code which reads a file defining a Lebedev quadrature rule on the surface of the unit sphere in 3D and displays the point locations.
sphere_lebedev_rule_display_test
sphere_llq_grid, a C code 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++ code 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 code 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 code 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, an Octave code 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 code 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 code 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++ code 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 code 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 code 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, an Octave code 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 code 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, used for interpolation and quadrature;
sphere_monte_carlo, a C code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.
sphere_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.
sphere_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;
sphere_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;
sphere_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;
sphere_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;
sphere_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;
sphere_positive_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit positive sphere in 3D.
sphere_positive_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit positive sphere in 3D.
sphere_positive_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected on the surface of the unit positive sphere in 3D.
sphere_quad, a C code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
sphere_quad, a C++ code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
sphere_quad, a Fortran77 code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
sphere_quad, a Fortran90 code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
sphere_quad, a MATLAB code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
sphere_quad, an Octave code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D.
sphere_stereograph, a C code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
sphere_stereograph, a C++ code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
sphere_stereograph, a Fortran77 code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
sphere_stereograph, a Fortran90 code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
sphere_stereograph, a MATLAB code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
sphere_stereograph, an Octave code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
sphere_stereograph_display, a MATLAB code which computes and displays the results of several stereographic projections between points on the surface of the unit sphere in 3D and a plane.
sphere_stereograph_display_test
sphere_stereograph_display, an Octave code which computes and displays the results of several stereographic projections between points on the surface of the unit sphere in 3D and a plane.
sphere_stereograph_display_test
sphere_triangle_monte_carlo, a C code 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_test
sphere_triangle_monte_carlo, a C++ code 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_test
sphere_triangle_monte_carlo, a Fortran77 code 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_test
sphere_triangle_monte_carlo, a Fortran90 code 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_test
sphere_triangle_monte_carlo, a MATLAB code 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_test
sphere_triangle_monte_carlo, an Octave code 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_test
sphere_triangle_quad, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code which computes and plots the Voronoi diagram of points on the surface of the unit sphere in 3D.
sphere_voronoi, a MATLAB code which computes the Voronoi diagram of points on the surface of the unit sphere in 3D.
sphere_voronoi, an Octave code which computes the Voronoi diagram of points on the surface of the unit sphere in 3D.
sphere_voronoi_display_opengl, a C++ code 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_voronoi_display_opengl_test
sphere_xyz_display, a MATLAB code 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++ code 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_xyz_display_opengl_test
sphere_xyzf_display, a MATLAB code 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 to display Voronoi diagrams or Delaunay triangulations on the unit sphere.
spherical_harmonic, a MATLAB code which evaluates spherical harmonic functions.
spinterp, a MATLAB code which carries out piecewise linear (PWL) multidimensional hierarchical sparse grid interpolation, quadrature and optimization, by Andreas Klimke; an earlier version of this software is ACM TOMS Algorithm 847.
spinterp_test, a MATLAB code which uses spinterp(), which is sparse grid package for interpolation, optimization, and quadrature in higher dimensions.
spiral_exact, a C code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
spiral_exact, a C++ code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
spiral_exact, a Fortran77 code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
spiral_exact, a Fortran90 code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
spiral_exact, a MATLAB code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
spiral_exact, an Octave code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
spiral_exact, a Python code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
spiral_pde, a MATLAB code which solves a pair of reaction-diffusion partial differential equations (PDE), in two spatial dimensions and time, over a rectangular domain with periodic boundary condition, whose solution is known to evolve into a pair of spirals.
spiral_pde_movie, a MATLAB code which solves a pair of reaction-diffusion partial differential equations (PDE) over a rectangular domain with periodic boundary condition, whose solution is known to evolve into a pair of spirals. The sequence of solutions is bundled into a movie.
spline, a C code which constructs and evaluates spline interpolants and approximants.
spline, a C++ code which constructs and evaluates spline interpolants and approximants.
spline, a Fortran77 code which constructs and evaluates spline interpolants and approximants.
spline, a Fortran90 code which constructs and evaluates spline interpolants and approximants.
spline, a MATLAB code which constructs and evaluates spline interpolants and approximants.
spline, an Octave code which constructs and evaluates spline interpolants and approximants.
spquad, a MATLAB code which computes a sparse grid quadrature rule for an M-dimensional integral, based on the Clenshaw-Curtis quadrature rule, by Greg von Winckel.
spquad, an Octave code which computes a sparse grid quadrature rule for an M-dimensional integral, based on the Clenshaw-Curtis quadrature rule, by Greg von Winckel.
spring_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) for the motion of a spring with mass m, damping b, and stiffness k.
spring_ode, an Octave code which sets up a system of ordinary differential equations (ODE) for the motion of a spring with mass m, damping b, and stiffness k.
spring_ode, a Python code which sets up a system of ordinary differential equations (ODE) for the motion of a spring with mass m, damping b, and stiffness k.
spring_double_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) for a system in which a mass is connected by a spring to a mass connected by a spring to a fixed support.
spring_double_ode, an Octave code which sets up a system of ordinary differential equations (ODE) for a system in which a mass is connected by a spring to a mass connected by a spring to a fixed support.
spring_double_ode, a Python code which sets up a system of ordinary differential equations (ODE) for a system in which a mass is connected by a spring to a mass connected by a spring to a fixed support.
spring_sweep_ode, a MATLAB code which computes a grid of solutions to a parameterized system of ordinary differential equations (ODE) that represent the motion of a spring with mass m, damping b, and stiffness k.
spring_sweep_ode, an Octave code which computes a grid of solutions to a parameterized system of ordinary differential equations (ODE) that represent the motion of a spring with mass m, damping b, and stiffness k.
spring_sweep_ode, a Python code which computes a grid of solutions to a parameterized system of ordinary differential equations (ODE) that represent the motion of a spring with mass m, damping b, and stiffness k.
spring2_ode, a C code which shows how gnuplot() can illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
spring2_ode, a C++ code which shows how gnuplot() can illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
spring2_ode, a Fortran77 code which shows how gnuplot() can illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
spring2_ode, a Fortran90 code which shows how gnuplot() can illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
spring2_ode, a MATLAB code which shows how gnuplot() can illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
spring3_ode, a C code 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.
spring3_ode, a C++ code 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.
spring3_ode, a Fortran77 code 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.
spring3_ode, a Fortran90 code 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.
spring3_ode, a MATLAB code which shows how line printer graphics can be used to make a crude illustration of a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
square_arbq_rule, a C code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_arbq_rule, a C++ code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_arbq_rule, a Fortran77 code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_arbq_rule, a Fortran90 code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_arbq_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_arbq_rule, an Octave code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in the unit square in 2D.
square_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in the unit square in 2D.
square_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in the unit square in 2D.
square_exactness, a C code which computes the exactness of quadrature rules for f(x,y) over the interior of a quadrilateral in 2D.
square_exactness, a C++ code which computes the exactness of quadrature rules for f(x,y) over the interior of a quadrilateral in 2D.
square_exactness, a Fortran77 code which computes the exactness of quadrature rules for f(x,y) over the interior of a quadrilateral in 2D.
square_exactness, a Fortran90 code which computes the exactness of quadrature rules for f(x,y) over the interior of a quadrilateral in 2D.
square_exactness, a MATLAB code which computes the exactness of quadrature rules for f(x,y) over the interior of a quadrilateral in 2D.
square_exactness, an Octave code which computes the exactness of quadrature rules for f(x,y) over the interior of a quadrilateral in 2D.
square_felippa_rule, a C code which returns a Felippa quadrature rule over the interior of a square in 2D.
square_felippa_rule, a C++ code which returns a Felippa quadrature rule over the interior of a square in 2D.
square_felippa_rule, a Fortran77 code which returns a Felippa quadrature rule over the interior of a square in 2D.
square_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule over the interior of a square in 2D.
square_felippa_rule, a MATLAB code which returns a Felippa quadrature rule over the interior of a square in 2D.
square_grid, a C code which computes a grid of points over the interior of a square in 2D.
square_grid, a C++ code which computes a grid of points over the interior of a square in 2D.
square_grid, a Fortran77 code which computes a grid of points over the interior of a square in 2D.
square_grid, a Fortran90 code which computes a grid of points over the interior of a square in 2D.
square_grid, a MATLAB code which computes a grid of points over the interior of a square in 2D.
square_grid, an Octave code which computes a grid of points over the interior of a square in 2D.
square_grid, a Python code 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++ code which computes a hexagonal grid of points over the interior of a square in 2D.
square_hex_grid, a Fortran90 code which computes a hexagonal grid of points over the interior of a square in 2D.
square_hex_grid, a MATLAB code which computes a hexagonal grid of points over the interior of a square in 2D.
square_hex_grid, an Octave code which computes a hexagonal grid of points over the interior of a square in 2D.
square_integrals, a C code 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++ code 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 code which returns the exact value of the integral of any monomial over the interior of the unit square in 2D.
square_integrals, a Fortran90 code 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 code 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, an Octave code 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 code 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 code 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++ code 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 code 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 code 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 code 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 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.
square_monte_carlo, a C++ code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.
square_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;
square_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;
square_monte_carlo, a MATLAB code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;
square_monte_carlo, an Octave code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;
square_monte_carlo, a Python code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D;
square_split, a FreeFem++ code which shows how a mesh can be read from an msh file saved by a previously run FreeFem++ code.
square_surface_distance, a MATLAB code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit square.
square_surface_distance, an Octave code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit square.
square_surface_distance, a Python code which estimates the expected value of the distance between a pair of points randomly selected on the surface of the unit square.
square_symq_rule, a C code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_symq_rule, a C++ code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_symq_rule, a Fortran77 code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_symq_rule, a Fortran90 code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_symq_rule, a MATLAB code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_symq_rule, an Octave code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_symq_rule, a Python code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the square in 2D, by Hong Xiao and Zydrunas Gimbutas.
square_test, a FreeFem++ code which tests the square() function for meshing a square region.
squircle_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) for a pair of functions that generalize the sine and cosine, and whose phase portrait is a squircle, a sort of squared circle.
squircle_ode, an Octave code which sets up a system of ordinary differential equations (ODE) for a pair of functions that generalize the sine and cosine, and whose phase portrait is a squircle, a sort of squared circle.
squircle_ode, a Python code which sets up a system of ordinary differential equations (ODE) for a pair of functions that generalize the sine and cosine, and whose phase portrait is a squircle, a sort of squared circle.
ss_gd_align, a FORTRAN90 code which implements some of the linear space alignment algorithms described in the reference by Chao.
ss_gg_align, a FORTRAN90 code which implements the sequence/sequence global gap alignment, one of the string matching algorithms described by Chao.
ss_lg_align, a FORTRAN90 code which implements the sequence/sequence local alignment, one of the string matching algorithms described by Chao.
ss_qg_align, a FORTRAN90 code which implements the sequence/sequence global gap alignment, one of the string matching algorithms described by Chao.
st, a dataset 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 code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
st_io, a C++ code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
st_io, a Fortran77 code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
st_io, a Fortran90 code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
st_io, a MATLAB code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
st_io, an Octave code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
st_io, a Python code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
st_to_ccs, a C code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format.
st_to_ccs, a C++ code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format.
st_to_ccs, a Fortran77 code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format.
st_to_ccs, a Fortran90 code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format.
st_to_ccs, a MATLAB code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format.
st_to_ccs, an Octave code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format.
st_to_ccs, a Python code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format.
st_to_hb, a Fortran90 code which converts a sparse matrix file from Sparse Triplet (ST) format to Harwell Boeing (HB) format;
st_to_hb, a MATLAB code which converts a sparse matrix file from Sparse Triplet (ST) format to Harwell Boeing (HB) format;
st_to_hb, an Octave code which converts a sparse matrix file from Sparse Triplet (ST) format to Harwell Boeing (HB) format;
st_to_mm, a MATLAB code which converts a sparse matrix file from Sparse Triplet (ST) format to matrix Market (MM) format;
st_to_mm, an Octave code which converts a sparse matrix file from Sparse Triplet (ST) format to matrix Market (MM) format;
st_to_msm, a MATLAB code which reads a Sparse Triplet (ST) file and creates a corresponding matrix in MATLAB Sparse Matrix (MSM) format.
st_to_msm, an Octave code which reads a Sparse Triplet (ST) file and creates a corresponding matrix in MATLAB Sparse Matrix (MSM) format.
st1, a dataset directory which contains examples of the Sparse Triplet (ST1) format, a sparse matrix file format, storing just (I,J,A(I,J)), and using one-based indexing.
star_discrepancy, a C code 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++ code 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.
starpac, a Fortran77 code which carries out statistical data analysis, by Janet Donaldson.
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 code which computes steam table properties including pressure and density, based on a National Bureau of Standards (NBS) package;
steam_interact, a Fortran90 code which queries the National Bureau of Standards (NBS) steam table package;
steam_nbs, a Fortran77 code which contains steam table functions devised by the Nation Bureau of Standards (NBS). This version of the code is (almost) unchanged from the original release. It can be useful when checking the revised Fortran90 version.
steam_nbs_interact, a Fortran77 code which queries the National Bureau of Standards (NBS) steam table package;
steinerberger, a MATLAB code which evaluates the Steinerberger function, a continuous function with discontinuous derivative, which is very hard to accurately plot, integrate, minimize, or interpolate.
steinerberger, an Octave code which evaluates the Steinerberger function, a continuous function with discontinuous derivative, which is very hard to accurately plot, integrate, minimize, or interpolate.
step-1, a dealii code which creates and plots two simple grids.
step-2, a dealii code which assigns degrees of freedom to the nodes of a grid, determines the sparsity pattern of the corresponding matrix, and then reorders the variables to get a tighter bandwidth.
step-2mod, a dealii code which is a variation of step-2, allowing for linear, quadratic or cubic elements, and printing the bandwidth before and after renumbering.
step-3, a dealii code which generates a graphics file which displays the structure of the solution.
step-4, a dealii code which solves the Laplace equation in 2D and in 3D.
step-5, a dealii code which reads grid information from a file.
step-6, a dealii code which generates a sequence of locally refined grids.
step-7, a dealii code which generates TeX files of convergence tables, and shows how to specify nonhomogenous Neumann boundary conditions for the Helmholtz equation.
step-8, a dealii code which sets up the elasticity equations.
step1, a FENICS code which solves a Poisson equation with constant diffusivity kappa(x,y).
step2, a FENICS code which solves a Poisson equation with piecewise constant (PWC) diffusivity kappa(x,y).
step3, a FENICS code which solves a Poisson equation with piecewise constant (PWC) diffusivity kappa(x,y), and computes and plots |grad(u)|.
step4, a FENICS code 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 code 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 code which solves the nonlinear p-laplacian problem directly.
step7, a FENICS code which compares error norm and DPG error indicators for a Poisson problem.
step8, a FENICS code which uses DPG error indicators for adaptive mesh refinement.
step9, a FENICS code 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 code 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 code 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, case 1. The problem uses a discontinuous diffusivity function kappa(x,y).
step12, a FENICS code which uses the mixed Discontinuous Petrov Galerkin (DPG) method to formulate a version of the nonlinear p-Laplacian equation, for which an approximate solution is sought by Picard iteration.
stetter_ode, a MATLAB code which sets up an ordinary differential equation (ODE) for which a specific time step sequence causes the implicit trapezoidal method to be unstable, while the implicit midpoint method will be stable. Note that the right hand side function f(t,y) is periodic, discontinuous, and piecewise linear (PWL).
stetter_ode, an Octave code which sets up an ordinary differential equation (ODE) for which a specific time step sequence causes the implicit trapezoidal method to be unstable, while the implicit midpoint method will be stable. Note that the right hand side function f(t,y) is periodic, discontinuous, and piecewise linear (PWL).
stetter_ode, a Python code which sets up an ordinary differential equation (ODE) for which a specific time step sequence causes the implicit trapezoidal method to be unstable, while the implicit midpoint method will be stable. Note that the right hand side function f(t,y) is periodic, discontinuous, and piecewise linear (PWL).
stiff_ode, a C code which sets up an ordinary differential equation (ODE) which exhibits stiffness, making accurate solution difficult.
stiff_ode, a C++ code which sets up an ordinary differential equation (ODE) which exhibits stiffness, making accurate solution difficult.
stiff_ode, a Fortran90 code which sets up an ordinary differential equation (ODE) which exhibits stiffness, making accurate solution difficult.
stiff_ode, a MATLAB code which sets up an ordinary differential equation (ODE) which exhibits stiffness, making accurate solution difficult.
stiff_ode, an Octave code which sets up an ordinary differential equation (ODE) which exhibits stiffness, making accurate solution difficult.
stiff_ode, a Python code which sets up an ordinary differential equation (ODE) which exhibits stiffness, making accurate solution difficult.
stiff_ode, an R code which sets up an ordinary differential equation (ODE) which exhibits stiffness, making accurate solution difficult.
stiffness_matrix, a FreeFem++ code which computes the stiffness matrix for the finite element method (FEM).
stla, a data directory which contains examples of ASCII stereolithography (STL) files for 3D graphics;
stla_display, a MATLAB code which reads an ASCII stereolithography (STL) file and displays it on the screen.
stla_display, an Octave code which reads an ASCII stereolithography (STL) file and displays it on the screen.
stla_io, a C++ code which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;
stla_io, a Fortran90 code which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;
stla_io, a MATLAB code which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;
stla_io, an Octave code which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;
stla_to_tri_surface, a MATLAB code which reads an ASCII stereolithography (STL) file and extracts the surface mesh data as a tri_surface dataset.
stla_to_tri_surface, an Octave code 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 code which a faster version of stla_to_tri_surface().
stla_to_tri_surface_fast, an Octave code 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 code which implements several versions of a stochastic diffusivity coefficient, using gnuplot() to create graphic images of sample realizations of the diffusivity field.
stochastic_diffusion, a C++ code which implements several versions of a stochastic diffusivity coefficient, using gnuplot() to create graphic images of sample realizations of the diffusivity field.
stochastic_diffusion, a Fortran77 code which implements several versions of a stochastic diffusivity coefficient, using gnuplot() to create graphic images of sample realizations of the diffusivity field.
stochastic_diffusion, a Fortran90 code which implements several versions of a stochastic diffusivity coefficient, using gnuplot() to create graphic images of sample realizations of the diffusivity field.
stochastic_diffusion, a MATLAB code which implements several versions of a stochastic diffusivity coefficient.
stochastic_diffusion, an Octave code which implements several versions of a stochastic diffusivity coefficient.
stochastic_diffusion, a Python code which implements several versions of a stochastic diffusivity coefficient.
stochastic_gradient_nd_noise, a MATLAB code 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 code which implements a finite difference method (FDM) for the steady 2D heat equation with a stochastic heat diffusivity coefficient.
stochastic_heat2d, a C++ code which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.
stochastic_heat2d, a Fortran77 code which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.
stochastic_heat2d, a Fortran90 code which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.
stochastic_heat2d, a MATLAB code which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.
stochastic_heat2d, an Octave code which implements a finite difference method (FDM) for the steady 2D heat equation, with a stochastic heat diffusivity coefficient.
stochastic_rk, a C code which applies a Runge Kutta (RK) scheme to a stochastic differential equation (SDE).
stochastic_rk, a C++ code which applies a Runge Kutta (RK) scheme to a stochastic differential equation (SDE).
stochastic_rk, a Fortran77 code which applies a Runge Kutta (RK) scheme to a stochastic differential equation (SDE).
stochastic_rk, a Fortran90 code which applies a Runge Kutta (RK) scheme to a stochastic differential equation (SDE).
stochastic_rk, a MATLAB code which applies a Runge Kutta (RK) scheme to a stochastic differential equation (SDE).
stochastic_rk, an Octave code which applies a Runge Kutta (RK) scheme to a stochastic differential equation (SDE).
stokes_2d_exact, a C code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
stokes_2d_exact, a C++ code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
stokes_2d_exact, a Fortran77 code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
stokes_2d_exact, a Fortran90 code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
stokes_2d_exact, a MATLAB code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
stokes_2d_exact, an Octave code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
stokes_2d_exact, a Python code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
string_pde, a C code which sets up the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
string_pde, a C++ code which sets up the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
string_pde, a Fortran77 code which sets up the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
string_pde, a Fortran90 code which sets up the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
string_pde, a MATLAB code which sets up and solves the partial differential equations (PDE), in one spatial dimension and time, describing a vibrating string.
string_pde, an Octave code which sets up the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
stripack, a Fortran90 code which computes the Delaunay triangulation or Voronoi diagram of points on a unit sphere, by Robert Renka.
stripack_bench, a Fortran90 code which benchmarks the Delaunay triangulation calculation of STRIPACK by timing computations involving random sets of nodes of increasing size.
stripack_delaunay, a Fortran90 code which reads points on the unit sphere, calls stripack() to compute the Delaunay triangulation, and writes it to a file.
stripack_voronoi, a Fortran90 code which reads points on the unit sphere, computes the Voronoi diagram, and writes it to a file.
stripper, a Fortran90 code which performs a variety of file modifications, such as capitalization, or removal of control characters;
stroud_rule, a C code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
stroud_rule, a C++ code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
stroud_rule, a Fortran77 code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
stroud_rule, a Fortran90 code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
stroud_rule, a MATLAB code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
stroud_rule, an Octave code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
struveh, a Mathematica code which evaluates the Struve H function.
study_classify_logistic, a scikit-learn code which uses the logistic regression algorithm to classify the outcome of students based on study time.
subanagram, a Fortran90 code which finds words which are anagrams formed from some of the letters of a given master word.
subpak, a C code which contains many utility routines;
subpak, a C++ code which contains many utility routines;
subpak, a Fortran77 code which contains many utility routines;
subpak, a Fortran90 code which contains many utility routines;
subpak, a MATLAB code which contains many utility routines;
subset, a C code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Other routines handle continued fractions, Diophantine equations, and Pythagorean triples.
subset, a C++ code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Other routines handle continued fractions, Diophantine equations, and Pythagorean triples.
subset, a Fortran77 code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Other routines handle continued fractions, Diophantine equations, and Pythagorean triples.
subset, a Fortran90 code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Other routines handle continued fractions, Diophantine equations, and Pythagorean triples.
subset, a MATLAB code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Other routines handle continued fractions, Diophantine equations, and Pythagorean triples.
subset, an Octave code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Other routines handle continued fractions, Diophantine equations, and Pythagorean triples.
subset, a Python code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems. Other routines handle continued fractions, Diophantine equations, and Pythagorean triples.
subset_distance, a MATLAB code which estimates the expected value of the Hamming distance between a pair of randomly selected subsets of an M set.
subset_distance, an Octave code which estimates the expected value of the Hamming distance between a pair of randomly selected subsets of an M set.
subset_distance, a Python code which estimates the expected value of the Hamming distance between a pair of randomly selected subsets of an M set.
subset_sum, a C code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
subset_sum, a C++ code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
subset_sum, a Fortran77 code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
subset_sum, a Fortran90 code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
subset_sum, a MATLAB code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
subset_sum, an Octave code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
subset_sum, a Python code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
subset_sum, 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_backtrack, a C code which uses backtracking to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_backtrack, a C++ code which uses backtracking to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_backtrack, a Fortran90 code which uses backtracking to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_backtrack, a MATLAB code which uses backtracking to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_backtrack, an Octave code which uses backtracking to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_backtrack, a Python code which uses backtracking to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_brute, a C code which uses brute force to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_brute, a C++ code which uses brute force to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_brute, a Fortran77 code which uses brute force to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_brute, a Fortran90 code which uses brute force to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_brute, a MATLAB code which uses brute force to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_brute, an Octave code which uses brute force to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_brute, a Python code which uses brute force to solve the subset sum problem, to find a subset of a set of integers which has a given sum.
subset_sum_swap, a C code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
subset_sum_swap, a C++ code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
subset_sum_swap, a Fortran77 code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
subset_sum_swap, a Fortran90 code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
subset_sum_swap, a MATLAB code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
subset_sum_swap, an Octave code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
subset_sum_swap, a Python code which uses swapping to try to improve an initial estimated solution of the subset sum problem, which seeks a subset of a set of integers which has a given sum. Even when an exact solution exists, this approach often only finds an approximate solution.
subset_sum_tasks, a MATLAB code which solves a subset sum problem by exhaustive search, using parallel programming to subdividing the search range among separate tasks.
sudoku, a MATLAB code which handles Sudoku puzzles;
super_blas, a C code which implements some of the Basic Linear Algebra Subprograms (BLAS) for fast execution.
superlu_test, a C code which uses superlu(), which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.
superlu_test, a C++ code which uses superlu(), which which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.
superlu, a Fortran77 code which uses superlu(), which which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.
superlu_test, a Fortran90 code which uses superlu(), which which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.
superlu_test, a MATLAB code which uses superlu(), which which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.
superlu_openmp, a C code which uses superlu() 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++ code which uses superlu() 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 code which uses superlu() 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 code which uses superlu() 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.
surf_test, a MATLAB code which calls surf(), which demonstrates the display of a 3D surface or contour plot for data of the form Z=F(X,Y).
svd_basis, a C++ code which applies the Singular Value Decomposition (SVD) to vectors, extracting dominant modes;
svd_basis, a Fortran90 code which applies the Singular Value Decomposition (SVD) to a collection of data vectors, extracting dominant modes;
svd_basis, a MATLAB code which applies the Singular Value Decomposition (SVD) to a collection of data vectors, extracting dominant modes;
svd_basis, an Octave code which applies the Singular Value Decomposition (SVD) to a collection of data vectors, extracting dominant modes;
svd_basis_weight, a Fortran90 code which is similar to svd_basis(), but which allows the user to assign weights to each data vector.
svd_circle, a MATLAB code which analyzes a linear map of the unit circle caused by an arbitrary 2x2 matrix A, using the singular value decomposition (SVD).
svd_circle, an Octave code which analyzes a linear map of the unit circle caused by an arbitrary 2x2 matrix A, using the singular value decomposition (SVD).
svd_circle, a Python code which analyzes a linear map of the unit circle caused by an arbitrary 2x2 matrix A, using the singular value decomposition (SVD).
svd_faces, a MATLAB code which applies singular value decomposition (SVD) analysis to images.
svd_faces, an Octave code which applies singular value decomposition (SVD) analysis to images.
svd_fingerprint, a MATLAB code which reads a file containing a fingerprint image and uses the Singular Value Decomposition (SVD) to compute and display a series of low rank approximations to the image.
svd_fingerprint, an Octave code 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 code which reads a gray scale image, computes the Singular Value Decomposition (SVD), and constructs a series of low rank approximations to the image.
svd_gray, an Octave code which reads a gray scale image, computes the Singular Value Decomposition (SVD), and constructs a series of low rank approximations to the image.
svd_lls, a MATLAB code which uses the singular value decomposition (SVD) to construct and plot the best affine and linear relationships in the sense of linear least squares (LLS), between two vectors of data.
svd_lls, an Octave code which uses the singular value decomposition (SVD) to construct and plot the best affine and linear relationships in the sense of linear least squares (LLS), between two vectors of data.
svd_lls, a Python code which uses the singular value decomposition (SVD) to construct and plot the best affine and linear relationships in the sense of linear least squares (LLS), between two vectors of data.
svd_powers, a MATLAB code which applies singular value decomposition (SVD) analysis to powers x(i)^(j-1).
svd_powers, an Octave code which applies singular value decomposition (SVD) analysis to powers x(i)^(j-1).
svd_powers, a Python code which applies singular value decomposition (SVD) analysis to powers A[i,j] = x[i]^j.
svd_snowfall, a C code 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++ code 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 code 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 code 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 code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).
svd_snowfall, an Octave code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).
svd_snowfall, a Python code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).
svd_sphere, a MATLAB code which analyzes a linear map of the unit sphere caused by an arbitrary 3x3 matrix A, using the singular value decomposition (SVD).
svd_sphere, an Octave code which analyzes a linear map of the unit sphere caused by an arbitrary 3x3 matrix A, using the singular value decomposition (SVD).
svd_sphere, a Python code which analyzes a linear map of the unit sphere caused by an arbitrary 3x3 matrix A, using the singular value decomposition (SVD).
svd_test, a C code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
svd_test, a C++ code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
svd_test, a Fortran77 code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
svd_test, a Fortran90 code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
svd_test, a FreeFem++ code which demonstrates how FreeFem++ can call some lapack() routines using a specially written interface. In this case, DGESVD is called, to compute the singular value decomposition A = U*S*V'.
svd_test, a MATLAB code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
svd_test, a Python code which demonstrates the Singular Value Decomposition (SVD) for a simple example.
svd_truncated, a C code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
svd_truncated, a C++ code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
svd_truncated, a Fortran77 code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
svd_truncated, a Fortran90 code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
svd_truncated_test, a MATLAB code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
svd_truncated_test, an Octave code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
svd_truncated_test, a Python code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
svdpack, a dataset directory which contains matrices in Harwell-Boeing format, used for testing the singular value decomposition code 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 code which computes Voronoi Diagrams or Delaunay triangulations, by Steve Fortune;
sweep2_delaunay_eps, a Fortran90 code which makes an Encapsulated PostScript (EPS) plot from the Delaunay triangulation information that is output by sweep2;
sweep2_voronoi_eps, a Fortran90 code which makes an Encapsulated PostScript (EPS) plot of the Voronoi diagram information that is output by sweep2;
symbols, a dataset directory which contains large images of numbers and symbols.
symdiff, an R code which applies the symmetric finite difference method (FDM) formula to a function.
sympy_test, an Octave code which tests sympy(), the symbolic mathematics package.
sympy_test, a Python code which uses the sympy() library, which is a symbolic mathematics package which, given a symbolic formula, can evaluate it, differentiate it, integrate it, plot it, compute Taylor series approximations, and many other operations.
szip, examples which use 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.
t_puzzle, a MATLAB code which considers the T puzzle, a set of 4 wooden pieces. The challenge is to arrange the pieces to form the shape of the letter T. Three other challenge shapes are an arrow, a rhombus, and a "fat" T.
t_puzzle, an Octave code which considers the T puzzle, a set of 4 wooden pieces. The challenge is to arrange the pieces to form the shape of the letter T. Three other challenge shapes are an arrow, a rhombus, and a "fat" T.
t_puzzle_cplex_test, a BASH code which calls cplex(), to read the LP file defining the T-puzzle tiling problem, solve the linear programming problem, and write the solution to a file.
t_puzzle_gui, a MATLAB code which sets up a graphical user interface for the T puzzle, by Cleve Moler.
t_puzzle_gurobi_test, a BASH code which calls gurobi(), to read the LP file defining the T-puzzle tiling problem, solve the linear programming problem, and write the solution to a file.
table_columns, a Fortran90 code 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 code which reads a table file where each line has the same number of values, and permutes the columns according to commandline input from the user;
table_delaunay, a C++ code which reads a file of point coordinates in the table format and writes out the Delaunay triangulation.
table_delaunay, a Fortran90 code which reads a file of point coordinates in the table format and writes out the Delaunay triangulation.
table_delaunay, a MATLAB code which reads a file of point coordinates in the table format and writes out the Delaunay triangulation.
table_graph_code, a Fortran90 code which reads a table file representing the adjacency matrix of a graph, and computes the graph code.
table_histogram, a Fortran90 code which reads a table file and histograms each column.
table_io, a C code which reads and writes table files.
table_io, a C++ code which reads and writes table files.
table_io, a Fortran77 code which reads and writes table files.
table_io, a Fortran90 code which reads and writes table files.
table_io, a MATLAB code which reads and writes table files.
table_io, an Octave code which reads and writes table files.
table_latinize, a C++ code which reads a table file of N points in M dimensions, adjusts to form a Latin hypercube;
table_latinize, a Fortran90 code which reads a table file of N points in M dimensions, adjusts to form a Latin hypercube;
table_latinize, a MATLAB code which reads a table file of N points in M dimensions, adjusts to form a Latin hypercube;
table_quality, a C++ code which measures the dispersion quality of points in a dataset read from a file.
table_quality, a Fortran90 code which measures the dispersion quality of points in a dataset read from a file.
table_quality, a MATLAB code which measures the dispersion quality of points in a dataset read from a file.
table_read, a MATLAB code 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 code which reads a table file of N points in 3 dimensions and produces a mesh of tetrahedrons;
table_top, a Fortran90 code which is given a table file of M-dimensional points, makes plots of all coordinate pairs;
table_voronoi, a C++ code which reads 2D points from a table file and prints information about the Voronoi diagram;
table_voronoi, a Fortran90 code 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 code 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++ code 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 code 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 code 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 code 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, an Octave code 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 Python code 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.
tcell, a Fortran77 code which solves the time-dependent Navier Stokes equations (NSE) for fluid flow in a 2D T-shaped region.
tcell, a MATLAB code 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 code which displays a single velocity field solution for the T cell;
tcell_flow_movie, a MATLAB code 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 code which computes the mass matrix for the T-Cell problem, which is needed in order for TCELL_ROM to run the reduced order model (ROM) of the problem.
tcell_rom, a MATLAB code 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 TEC files, used for storing 2D or 3D graphics with attributes;
tec_io, a Fortran90 code which reads or writes a tecplot() ASCII TEC file containing a model associated with the finite element method (FEM).
tec_io, a MATLAB code which reads or writes a tecplot() ASCII TEC file containing a model associated with the finite element method (FEM).
tec_to_fem, a Fortran90 code which converts a tecplot() ASCII file into an FEM model.
tec_to_fem, a MATLAB code which converts a tecplot() ASCII TEC file into an FEM model.
tec_to_obj, a Fortran90 code which reads a tecplot() ASCII file of finite element information and writes an equivalent Alias OBJ file;
tec_to_obj2, a Fortran90 code 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 code 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() and animated.
tecplot, examples which use tecplot(), which is an interactive program for scientific illustration, animation and visualization.
templated, a Fortran77 code which carries out simple versions of various iterative solvers. This is the real 64 bit version.
templates, a Fortran77 code which carries out simple versions of various iterative solvers. This is the real 32 bit version.
templates, a Fortran90 code which carries out simple versions of various iterative solvers.
templates, a MATLAB code which carries out simple versions of various iterative solvers.
tennis_matrix, a MATLAB code which computes the transition matrix for a game of tennis, which has 17 distinct states.
tennis_matrix, an Octave code which computes the transition matrix for a game of tennis, which has 17 distinct states.
tennis_matrix, a Python code which computes the transition matrix for a game of tennis, which has 17 distinct states.
tensor_grid_display, a MATLAB code which displays the grid points of a tensor product rule used for interpolation or quadrature, in 1D, 2D or 3D.
tensor_grid_display, an Octave code which displays the grid points of a tensor product rule used for interpolation or quadrature, in 1D, 2D or 3D.
test_approx, a C code which defines test problems for approximation, provided as (x,y) data.
test_approx, a C++ code which defines test problems for approximation, provided as (x,y) data.
test_approx, a Fortran77 code which defines test problems for approximation, provided as (x,y) data.
test_approx, a Fortran90 code which defines test problems for approximation, provided as (x,y) data.
test_approx, a MATLAB code which defines test problems for approximation, provided as (x,y) data.
test_approx, an Octave code which defines test problems for approximation, provided as (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 code which implements test problems for numerical continuation.
test_con, a Fortran90 code which defines tests for the continuation problem, which considers a function F(X) with N-dimensional argument X and N-1 dimensional result. In general, this defines an implicit one-dimensional curve of solutions X(LAMBDA). A continuation code starts from a single point on this curve and tries to compute a sequence of solutions that form a path.
test_con, a MATLAB code which implements test problems for numerical continuation.
test_con, an Octave code which implements test problems for numerical continuation.
test_eigen, a C code which generates random real symmetric and nonsymmetric matrices with known eigenvalues and eigenvectors, to test eigenvalue algorithms.
test_eigen, a C++ code which generates random real symmetric and nonsymmetric matrices with known eigenvalues and eigenvectors, to test eigenvalue algorithms.
test_eigen, a Fortran77 code which generates random real symmetric and nonsymmetric matrices with known eigenvalues and eigenvectors, to test eigenvalue algorithms.
test_eigen, a Fortran90 code which generates random real symmetric and nonsymmetric matrices with known eigenvalues and eigenvectors, to test eigenvalue algorithms.
test_eigen, a MATLAB code which generates random real symmetric and nonsymmetric matrices with known eigenvalues and eigenvectors, to test eigenvalue algorithms.
test_eigen, an Octave code which generates random real symmetric and nonsymmetric matrices with known eigenvalues and eigenvectors, to test eigenvalue algorithms.
test_eigen, a Python code which generates random real symmetric and nonsymmetric matrices with known eigenvalues and eigenvectors, to test eigenvalue algorithms.
test_int, a C code which defines test integrands for 1D quadrature rules.
test_int, a C++ code which defines test integrands for 1D quadrature rules.
test_int, a Fortran77 code which defines test integrands for 1D quadrature rules.
test_int, a Fortran90 code which defines test integrands for 1D quadrature rules.
test_int, a MATLAB code which defines test integrands for 1D quadrature rules.
test_int, an Octave code which defines test integrands for 1D quadrature rules.
test_int, a Python code which defines test integrands for 1D quadrature rules.
test_int_2d, a C code which defines test integrands f(x,y) for 2D quadrature rules.
test_int_2d, a C++ code which defines test integrands f(x,y) for 2D quadrature rules.
test_int_2d, a Fortran77 code which defines test integrands f(x,y) for 2D quadrature rules.
test_int_2d, a Fortran90 code which defines test integrands f(x,y) for 2D quadrature rules.
test_int_2d, a MATLAB code which defines test integrands f(x,y) for 2D quadrature rules.
test_int_2d, an Octave code which defines test integrands f(x,y) for 2D quadrature rules.
test_int_circle, a Fortran77 code which defines several test integrals over the unit circle, making it possible to check the accuracy of quadrature rules.
test_int_margin, a MATLAB code 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 code which defines test problems for interpolation, provided as (x,y) data.
test_interp, a C++ code which defines test problems for interpolation, provided as (x,y) data.
test_interp, a Fortran77 code which defines test problems for interpolation, provided as (x,y) data.
test_interp, a Fortran90 code which defines test problems for interpolation, provided as (x,y) data.
test_interp, a MATLAB code which defines test problems for interpolation, provided as (x,y) data.
test_interp, an Octave code which defines test problems for interpolation, provided as (x,y) data.
test_interp, a Python code which defines test problems for interpolation, provided as (x,y) data.
test_interp_1d, a C code which defines test problems for interpolation of a function y(x), depending on a 1D argument.
test_interp_1d, a C++ code which defines test problems for interpolation of a function y(x), depending on a 1D argument.
test_interp_1d, a Fortran77 code which defines test problems for interpolation of a function y(x), depending on a 1D argument.
test_interp_1d, a Fortran90 code which defines test problems for interpolation of a function y(x), depending on a 1D argument.
test_interp_1d, a MATLAB code which defines test problems for interpolation of a function y(x), depending on a 1D argument.
test_interp_1d, an Octave code which defines test problems for interpolation of a function y(x), depending on a 1D argument.
test_interp_1d, a Python code which defines test problems for interpolation of a function y(x), depending on a 1D argument.
test_interp_2d, a C code which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.
test_interp_2d, a C++ code which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.
test_interp_2d, a Fortran77 code which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.
test_interp_2d, a Fortran90 code which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.
test_interp_2d, a MATLAB code which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.
test_interp_2d, an Octave code which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.
test_interp_2d, a Python code which defines test problems for interpolation of regular or scattered data z(x,y), depending on a 2D argument.
test_interp_4d, a Fortran90 code which defines test problems for interpolation of data u(w,x,y,z), depending on a 4D argument.
test_interp_fun, a C code which defines test problems for interpolation which are available in functional form.
test_interp_fun, a Fortran77 code which defines test problems for interpolation which are available in functional form.
test_interp_fun, a MATLAB code which defines test problems for interpolation which are available in functional form.
test_interp_fun, an Octave code which defines test problems for interpolation which are available in functional form.
test_interp_nd, a C code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
test_interp_nd, a C++ code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
test_interp_nd, a Fortran77 code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
test_interp_nd, a Fortran90 code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
test_interp_nd, a MATLAB code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
test_interp_nd, an Octave code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
test_laplace, a Fortran77 code which returns examples of a forward function f(t) and its corresponding Laplace transform L(f,z).
test_lls, a C code which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the MxN linear system A*x=b.
test_lls, a C++ code which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the MxN linear system A*x=b.
test_lls, a Fortran77 code which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the MxN linear system A*x=b.
test_lls, a Fortran90 code which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the MxN linear system A*x=b.
test_lls, a MATLAB code which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the MxN linear system A*x=b.
test_lls, an Octave code which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the MxN linear system A*x=b.
test_lls, a Python code which implements linear least squares (LLS) test problems which seek a vector x which minimizes the error in the MxN linear system A*x=b.
test_matrix, a C code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
test_matrix, a C++ code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
test_matrix, a Fortran77 code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
test_matrix, a Fortran90 code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
test_matrix, a MATLAB code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
test_matrix, an Octave code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
test_matrix, a Python code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
test_matrix_higham, a MATLAB code which contains a collection of test matrices by Nick Higham.
test_matrix_exponential, a C code which defines test cases for computing the matrix exponential.
test_matrix_exponential, a C++ code which defines test cases for computing the matrix exponential.
test_matrix_exponential, a Fortran77 code which defines test cases for computing the matrix exponential.
test_matrix_exponential, a Fortran90 code which defines test cases for computing the matrix exponential.
test_matrix_exponential, a MATLAB code which defines test cases for computing the matrix exponential.
test_matrix_exponential, an Octave code which defines test cases for computing the matrix exponential.
test_matrix_exponential, a Python code which defines test cases for computing the matrix exponential.
test_mesh, a Fortran90 code which defines a few test meshes.
test_min, a C code which implements test problems for minimization of a scalar function of a scalar variable.
test_min, a C++ code which implements test problems for minimization of a scalar function of a scalar variable.
test_min, a Fortran77 code which implements test problems for minimization of a scalar function of a scalar variable.
test_min, a Fortran90 code which implements test problems for minimization of a scalar function of a scalar variable.
test_min, a MATLAB code which implements test problems for minimization of a scalar function of a scalar variable.
test_min, an Octave code which implements test problems for minimization of a scalar function of a scalar variable.
test_min, a Python code which implements test problems for minimization of a scalar function of a scalar variable.
test_nint, a C++ code which defines test functions for M-dimensional quadrature routines.
test_nint, a Fortran90 code which defines test functions for M-dimensional quadrature routines.
test_nint, a MATLAB code which defines test functions for M-dimensional quadrature routines.
test_nint, an Octave code which defines test functions for M-dimensional quadrature routines.
test_nls, a Fortran90 code which implements nonlinear least squares (NLS) test problems.
test_nonlin, a Fortran77 code which implements test problems for the solution of systems of nonlinear equations.
test_nonlin, a Fortran90 code which implements test problems for the solution of systems of nonlinear equations.
test_nonlin, a MATLAB code which implements test problems for the solution of systems of nonlinear equations.
test_nonlin, an Octave code which implements test problems for the solution of systems of nonlinear equations.
test_nonlin, a Python code which implements test problems for the solution of systems of nonlinear equations.
test_ode, a Fortran90 code which defines a set of test initial value problems for ordinary differential equations (ODE).
test_ode, a MATLAB code which defines a set of test initial value problems for ordinary differential equations (ODE).
test_opt, a Fortran90 code which defines test problems for the minimization of a scalar function of several variables.
test_opt, a MATLAB code which defines test problems for the minimization of a scalar function of several variables.
test_opt, an Octave code which defines test problems for the minimization of a scalar function of several variables.
test_opt_con, a C code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
test_opt_con, a C++ code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
test_opt_con, a Fortran77 code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
test_opt_con, a Fortran90 code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
test_opt_con, a MATLAB code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
test_opt_con, an Octave code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
test_optimization, a C code which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.
test_optimization, a C++ code which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.
test_optimization, a Fortran77 code which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.
test_optimization, a Fortran90 code which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.
test_optimization, a MATLAB code which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.
test_optimization, an Octave code which defines test problems for the minimization of a scalar function of several variables, as described by Molga and Smutnicki.
test_optimization, a Python code 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 code which generates example cases of the partial digest problem.
test_partial_digest, a C++ code which generates example cases of the partial digest problem.
test_partial_digest, a Fortran90 code which generates example cases of the partial digest problem.
test_partial_digest, a MATLAB code which generates example cases of the partial digest problem.
test_partial_digest, an Octave code which generates example cases of the partial digest problem.
test_partial_digest, a Python code which generates example cases of the partial digest problem.
test_tet_mesh, a Fortran90 code which implements test problems for tetrahedralization or meshing of arbitrary regions in 3 dimensions.
test_triangulation, a Fortran90 code which defines test regions to be triangulated.
test_triangulation, a MATLAB code which defines test regions to be triangulated.
test_triangulation, an Octave code which defines test regions to be triangulated.
test_values, a C code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_values, a C++ code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_values, a Fortran77 code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_values, a Fortran90 code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_values, a Mathematica code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_values, a MATLAB code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_values, an Octave code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_values, a Python code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, Dixon elliptic functions, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi Elliptic functions sn(), cn(), and dn(), the Julian Ephemeris Date, Kelvin, Laguerre, Lambert W, Laplace, Legendre, Lerch, Lobachevsky, Lobatto, Logarithmic integral, Log normal, McNugget numbers, Mertens, Mittag-Leffler, Moebius, Multinomial, Negative binomial, Nine J, Normal, Omega, Owen, Partition, Phi, Pi, Poisson, Polylogarithm, Polynomial Resultant, Polyomino, Prime, Psi, Rayleigh, Hyperbolic Sine integral, Sigma, Sine Power integral, Sine integral, Six J, Sphere area, Sphere volume, Spherical harmonic, Stirling, Stromgen, Struve, Student, Subfactorial, Student probability, Three J, Transport, Trigamma, Truncated normal, van der Corput, von Mises, Weibull, Wright Omega, Zeta.
test_zero, a C code which implements test problems for the solution of a single nonlinear equation in one variable.
test_zero, a C++ code which implements test problems for the solution of a single nonlinear equation in one variable.
test_zero, a Fortran77 code which implements test problems for the solution of a single nonlinear equation in one variable.
test_zero, a Fortran90 code which implements test problems for the solution of a single nonlinear equation in one variable.
test_zero, a MATLAB code which implements test problems for the solution of a single nonlinear equation in one variable.
test_zero, an Octave code which implements test problems for the solution of a single nonlinear equation in one variable.
test_zero, a Python code which implements test problems for the solution of a single nonlinear equation in one variable.
tester, a BASH code which runs the C tests.
tester, a BASH code which runs the C++ tests.
tester, a BASH code which runs the dealii tests.
tester, a BASH code which runs the Fortran77 tests.
tester, a BASH code which runs the Fortran90 tests.
tester, a BASH code which runs the FENICS tests.
tester, a BASH code which runs the FreeFem tests.
tester, a BASH code which runs the Julia tests.
tester, a BASH code which runs the keras tests.
tester, a BASH code which runs the MATLAB tests.
tester, a BASH code which runs the Octave tests.
tester, a BASH code which runs the Python tests.
tester, a BASH code which runs the R tests.
tester, a BASH code which runs the sklearn tests.
testpack, a C code which defines integrands used to test M-dimensional quadrature.
testpack, a C++ code which defines integrands used to test M-dimensional quadrature.
testpack, a Fortran77 code which defines integrands used to test M-dimensional quadrature.
testpack, a Fortran90 code which defines integrands used to test M-dimensional quadrature.
testpack, a MATLAB code which defines integrands used to test M-dimensional quadrature.
tet_mesh, a C code which carries out various operations on meshes formed from tetrahedrons.
tet_mesh, a C++ code which carries out various operations on meshes formed from tetrahedrons.
tet_mesh, a Fortran77 code which carries out various operations on meshes formed from tetrahedrons.
tet_mesh, a Fortran90 code which carries out various operations on meshes formed from tetrahedrons.
tet_mesh, a MATLAB code which carries out various operations on meshes formed from tetrahedrons.
tet_mesh, an Octave code which carries out various operations on meshes formed from tetrahedrons.
tet_mesh_boundary, a C++ code which returns the nodes and faces of the boundary of a mesh of tetrahedrons, which themselves form a 3D triangular mesh or tri_surface.
tet_mesh_boundary, a Fortran90 code which returns the nodes and faces of the boundary of a mesh of tetrahedrons, which themselves form a 3D triangular mesh or tri_surface.
tet_mesh_boundary, a MATLAB code which returns the nodes and faces of the boundary of a mesh of tetrahedrons, which themselves form a 3D triangular mesh or tri_surface.
tet_mesh_boundary, an Octave code which returns the nodes and faces of the boundary of a mesh of tetrahedrons, which themselves form a 3D triangular mesh or tri_surface.
tet_mesh_display, a MATLAB code which reads in the node and element files defining a mesh of tetrahedrons and displays a wireframe image.
tet_mesh_display, an Octave code which reads in the node and element files defining a mesh of tetrahedrons and displays a wireframe image.
tet_mesh_display_opengl, a C++ code which reads a mesh of tetrahedrons and displays the nodes and edges using OpenGL.
tet_mesh_l2q, a C++ code which reads information about a 4-node linear mesh of tetrahedrons and creates data defining a corresponding 10-node quadratic mesh of tetrahedrons;
tet_mesh_l2q, a Fortran90 code which reads information about a 4-node linear mesh of tetrahedrons and creates data defining a corresponding 10-node quadratic mesh of tetrahedrons;
tet_mesh_l2q, a MATLAB code which reads information about a 4-node linear mesh of tetrahedrons and creates data defining a corresponding 10-node quadratic mesh of tetrahedrons;
tet_mesh_l2q, an Octave code which reads information about a 4-node linear mesh of tetrahedrons and creates data defining a corresponding 10-node quadratic mesh of tetrahedrons;
tet_mesh_order4, a dataset directory which contains examples of order 4 linear meshes of tetrahedrons, 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 meshes of tetrahedrons, 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 meshes of tetrahedrons, using a pair of files to list the node coordinates and the 20 nodes that make up each tetrahedron;
tet_mesh_q2l, a C++ code which reads information about a 10-node quadratic meshes of tetrahedrons and creates data defining a corresponding 4-node linear mesh of tetrahedrons;
tet_mesh_q2l, a Fortran90 code which reads information about a 10-node quadratic mesh of tetrahedrons and creates data defining a corresponding 4-node linear mesh of tetrahedrons;
tet_mesh_q2l, a MATLAB code which reads information about a 10-node quadratic mesh of tetrahedrons and creates data defining a corresponding 4-node linear mesh of tetrahedrons;
tet_mesh_q2l, an Octave code which reads information about a 10-node quadratic mesh of tetrahedrons and creates data defining a corresponding 4-node linear mesh of tetrahedrons;
tet_mesh_quad, a C++ code which estimates the integral of a function over a region defined by a mesh of tetrahedrons.
tet_mesh_quad, a Fortran90 code which estimates the integral of a function over a region defined by a mesh of tetrahedrons.
tet_mesh_quad, a MATLAB code which estimates the integral of a function over a region defined by a mesh of tetrahedrons.
tet_mesh_quad, an Octave code which estimates the integral of a function over a region defined by a mesh of tetrahedrons.
tet_mesh_quality, a C++ code which computes quality measures of a mesh of tetrahedrons.
tet_mesh_quality, a Fortran90 code which computes quality measures of a mesh of tetrahedrons.
tet_mesh_quality, a MATLAB code which computes quality measures of a mesh of tetrahedrons.
tet_mesh_quality, an Octave code which computes quality measures of a mesh of tetrahedrons.
tet_mesh_rcm, a C++ code which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a mesh of tetrahedrons, using 4 or 10 node elements;
tet_mesh_rcm, a Fortran90 code which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a mesh of tetrahedrons, using 4 or 10 node elements;
tet_mesh_rcm, a MATLAB code which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a mesh of tetrahedrons, using 4 or 10 node elements.
tet_mesh_rcm, an Octave code which computes the Reverse Cuthill McKee (RCM) reordering for the nodes of a mesh of tetrahedrons, using 4 or 10 node elements.
tet_mesh_refine, a C++ code which refines a mesh of tetrahedrons;
tet_mesh_refine, a Fortran90 code which refines a mesh of tetrahedrons;
tet_mesh_refine, a MATLAB code which refines a mesh of tetrahedrons;
tet_mesh_refine, an Octave code which refines a mesh of tetrahedrons;
tet_mesh_tet_neighbors, a C++ code which reads information about a mesh of tetrahedrons and lists 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 code which reads information about a mesh of tetrahedrons and lists the tetrahedrons that are adjacent to a given tetrahedron;
tet_mesh_tet_neighbors, a MATLAB code which reads information about a mesh of tetrahedrons and lists the tetrahedrons that are adjacent to a given tetrahedron;
tet_mesh_tet_neighbors, an Octave code which reads information about a mesh of tetrahedrons and lists the tetrahedrons that are adjacent to a given tetrahedron;
tet_mesh_to_gmsh, a C++ code which writes a mesh of tetrahedrons to a gmsh() file.
tet_mesh_to_gmsh, a Fortran77 code which writes a mesh of tetrahedrons to a gmsh() file.
tet_mesh_to_gmsh, a Fortran90 code which writes a mesh of tetrahedrons to a gmsh() file.
tet_mesh_to_gmsh, a MATLAB code which writes a mesh of tetrahedrons to a gmsh() file.
tet_mesh_to_gmsh, an Octave code which writes a mesh of tetrahedrons to a gmsh() file.
tet_mesh_to_xml, a C++ code which writes a mesh of tetrahedrons to an XML file.
tet_mesh_to_xml, a Fortran77 code which writes a mesh of tetrahedrons to an XML file.
tet_mesh_to_xml, a Fortran90 code which writes a mesh of tetrahedrons to an XML file.
tet_mesh_to_xml, a MATLAB code which writes a mesh of tetrahedrons to an XML file.
tet_mesh_to_xml, an Octave code which writes a mesh of tetrahedrons to an XML file.
tet_mesh_volumes, a C++ code which computes the volume of each tetrahedron in a mesh of tetrahedrons;
tet_mesh_volumes, a Fortran90 code which computes the volume of each tetrahedron in a mesh of tetrahedrons;
tet_mesh_volumes, a MATLAB code which computes the volume of each tetrahedron in a mesh of tetrahedrons;
tet_mesh_volumes, an Octave code which computes the volume of each tetrahedron in a mesh of tetrahedrons;
tetgen, examples which use tetgen(), which computes the convex hull and Delaunay tetrahedralization of 3D points, or starts with a 3D region defined by its boundaries, and constructs a boundary-constrained conforming quality Delaunay mesh of tetrahedrons, by Hang Si.
tethex, examples which use tethex(), which is a C++ code which reads 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 finite element method code dealii(), by Mikhail Artemiev.
tetrahedron, a C code which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.
tetrahedron, a C++ code which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.
tetrahedron, a Fortran77 code which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.
tetrahedron, a Fortran90 code which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.
tetrahedron, a MATLAB code which carries out geometric calculations involving a general tetrahedron, including solid and facial angles, face areas, point containment, distances to a point, circumsphere and insphere, measures of shape quality, centroid, barycentric coordinates, edges and edge lengths, random sampling, and volumes.
tetrahedron, an Octave code which carries out geometric calculations involving a general tetrahedron, including solid and facial angles, face areas, point containment, distances to a point, circumsphere and insphere, measures of shape quality, centroid, barycentric coordinates, edges and edge lengths, random sampling, and volumes.
tetrahedron, a Python code which carries out geometric calculations involving a general tetrahedron, including solid and facial angles, face areas, point containment, distances to a point, circumsphere and insphere, measures of shape quality, centroid, barycentric coordinates, edges and edge lengths, random sampling, and volumes.
tetrahedron_analyze, a Fortran77 code which computes properties including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume of a tetrahedron in 3D.
tetrahedron_arbq_rule, a C code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
tetrahedron_arbq_rule, a C++ code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
tetrahedron_arbq_rule, a Fortran77 code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
tetrahedron_arbq_rule, a Fortran90 code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
tetrahedron_arbq_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
tetrahedron_arbq_rule, an Octave code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
tetrahedron_arbq_rule, a Python code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
tetrahedron_exactness, a C code which computes the exactness of a quadrature rule over the interior of a tetrahedron in 3D.
tetrahedron_exactness, a C++ code which computes the exactness of a quadrature rule over the interior of a tetrahedron in 3D.
tetrahedron_exactness, a Fortran77 code which computes the exactness of a quadrature rule over the interior of a tetrahedron in 3D.
tetrahedron_exactness, a Fortran90 code which computes the exactness of a quadrature rule over the interior of a tetrahedron in 3D.
tetrahedron_exactness, a MATLAB code which computes the exactness of a quadrature rule over the interior of a tetrahedron in 3D.
tetrahedron_exactness, an Octave code which computes the exactness of a quadrature rule over the interior of a tetrahedron in 3D.
tetrahedron_exactness, a Python code which computes the exactness of a quadrature rule over the interior of a tetrahedron in 3D.
tetrahedron_felippa_rule, a C code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
tetrahedron_felippa_rule, a C++ code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
tetrahedron_felippa_rule, a Fortran77 code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
tetrahedron_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
tetrahedron_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
tetrahedron_felippa_rule, an Octave code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
tetrahedron_felippa_rule, a Python code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
tetrahedron_grid, a C code which computes a grid of points over the interior of a tetrahedron in 3D.
tetrahedron_grid, a C++ code which computes a grid of points over the interior of a tetrahedron in 3D.
tetrahedron_grid, a Fortran77 code which computes a grid of points over the interior of a tetrahedron in 3D.
tetrahedron_grid, a Fortran90 code which computes a grid of points over the interior of a tetrahedron in 3D.
tetrahedron_grid, a MATLAB code which computes a grid of points over the interior of a tetrahedron in 3D.
tetrahedron_grid, an Octave code which computes a grid of points over the interior of a tetrahedron in 3D.
tetrahedron_grid, a Python code which computes a grid of points over the interior of a tetrahedron in 3D.
tetrahedron_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
tetrahedron_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
tetrahedron_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
tetrahedron_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
tetrahedron_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
tetrahedron_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
tetrahedron_integrals, a Python code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
tetrahedron_jaskowiec_rule, a dataset directory which contains the definitions of 20 quadrature rules for the tetrahedron, by Jan Jaskowiec and Natarajan Sukumar.
tetrahedron_jaskowiec_rule, a C code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
tetrahedron_jaskowiec_rule_test
tetrahedron_jaskowiec_rule, a C++ code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
tetrahedron_jaskowiec_rule_test
tetrahedron_jaskowiec_rule, a Fortran90 code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
tetrahedron_jaskowiec_rule_test
tetrahedron_jaskowiec_rule, a MATLAB code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
tetrahedron_jaskowiec_rule_test
tetrahedron_jaskowiec_rule, an Octave code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
tetrahedron_jaskowiec_rule_test
tetrahedron_jaskowiec_rule, a Python code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
tetrahedron_keast_rule, a C code which returns a Keast quadrature rule, with exactness between 0 and 8, over the interior of a tetrahedron in 3D.
tetrahedron_keast_rule, a C++ code which returns a Keast quadrature rule, with exactness between 0 and 8, over the interior of a tetrahedron in 3D.
tetrahedron_keast_rule, a Fortran90 code which returns a Keast quadrature rule, with exactness between 0 and 8, over the interior of a tetrahedron in 3D.
tetrahedron_keast_rule, a MATLAB code which returns a Keast quadrature rule, with exactness between 0 and 8, over the interior of a tetrahedron in 3D.
tetrahedron_keast_rule, an Octave code which returns a Keast quadrature rule, with exactness between 0 and 8, over the interior of a tetrahedron in 3D.
tetrahedron_monte_carlo, a C code which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.
tetrahedron_monte_carlo, a C++ code which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.
tetrahedron_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.
tetrahedron_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate integrals over the interior of a generalt tetrahedron in 3D.
tetrahedron_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.
tetrahedron_monte_carlo, an Octave code which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.
tetrahedron_monte_carlo, a Python code which uses the Monte Carlo method to estimate integrals over the interior of a general tetrahedron in 3D.
tetrahedron_ncc_rule, a C code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_ncc_rule, a C++ code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_ncc_rule, a Fortran90 code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_ncc_rule, a MATLAB code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_ncc_rule, an Octave code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_nco_rule, a C code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_nco_rule, a C++ code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_nco_rule, a Fortran90 code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_nco_rule, a MATLAB code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
tetrahedron_nco_rule, an Octave code which defines Newton-Cotes Open (NCO) quadrature rules over the interior 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_display, a MATLAB code which determines the intersection between a tetrahedron and a plane and displays the result.
tetrahedron_slice_display_test
tetrahedron_slice_display, an Octave code which determines the intersection between a tetrahedron and a plane and displays the result.
tetrahedron_slice_display_test
tetrahedron_slice_movie, a MATLAB code which is given a tetrahedron and a vector, displays an evenly spaced sequence of planes that intersect the tetrahedron and are normal to the vector, and creates a movie of the process.
tetrahedron_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
tetrahedron_witherden_rule_test
tetrahedron_witherden_rule, a C++ code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
tetrahedron_witherden_rule_test
tetrahedron_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
tetrahedron_witherden_rule_test
tetrahedron_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
tetrahedron_witherden_rule_test
tetrahedron_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
tetrahedron_witherden_rule_test
tetrahedron_witherden_rule, a Python code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
tetrahedron01_monte_carlo, a C code which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.
tetrahedron01_monte_carlo_test
tetrahedron01_monte_carlo, a C++ code which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.
tetrahedron01_monte_carlo_test
tetrahedron01_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.
tetrahedron01_monte_carlo_test
tetrahedron01_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.
tetrahedron01_monte_carlo_test
tetrahedron01_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.
tetrahedron01_monte_carlo_test
tetrahedron01_monte_carlo, an Octave code which uses the Monte Carlo method to estimate integrals over the interior of the unit tetrahedron in 3D.
tetrahedron01_monte_carlo_test
tetrahedron01_monte_carlo, a Python code 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 use tetview(), which displays 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++ code which reads a TGA or TARGA graphics file;
tga_read, a C code which reads a TGA or TARGA graphics file and writes an uncompressed version;
theodolite, a MATLAB code 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.
thermal_convection, a FreeFem++ code which simulates the convection and diffusion of heat carried by a fluid.
thermal_design, a FreeFem++ code which models a thermal design problem, in which an insulating wall is made up of two materials with different properties.
theta_method, a MATLAB code which solves one or more ordinary differential equations (ODE) using the theta method.
theta_method, a Python code which solves one or more ordinary differential equations (ODE) using the theta method.
three_body_ode, a C code which sets up ordinary differential equations (ODE) which simulate 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_ode, a C++ code which sets up ordinary differential equations (ODE) which simulate 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_ode, a Fortran90 code which sets up ordinary differential equations (ODE) which simulate 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_ode, a MATLAB code which sets up ordinary differential equations (ODE) which simulate 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_ode, an Octave code which sets up ordinary differential equations (ODE) which simulate 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_ode, a Python code which sets up ordinary differential equations (ODE) which simulate 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 code which contains functions useful for finite element method (FEM) calculations applied within a 3D geometry, by Jeff Borggaard.
threed_to_tecplot, a MATLAB code 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 code 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 code.
threed_to_vtu, a MATLAB code 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 code.
threed_to_vu, a MATLAB code 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 vu() graphics code.
tictoc_test, a MATLAB code which tests the tic() and toc() functions for wallclock timing.
tictoc_test, an Octave code which tests the tic() and toc() functions for wallclock timing.
tictoc, a Python code which provides versions of the tic() and toc() functions for wallclock timing.
tikz, examples which use TIKZ, which is a drawing package for use in TEX and LATEX documents;
tikz, a data directory of examples of tikz files, which are descriptions of drawings to be included in a tex file.
tiler_2d, a Fortran90 code which demonstrates a 2D example of transfinite interpolation.
tiler_3d, a C++ code which demonstrates a 3D example of transfinite interpolation.
tiler_3d, a Fortran90 code 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_test, a C code which returns CPU time or elapsed time.
timer_test, a C++ code which returns CPU time or elapsed time.
timer_test, a Fortran77 code which returns CPU time or elapsed time.
timer_test, a Fortran90 code which returns CPU time or elapsed time.
timer_test, a MATLAB code which compares several methods of timing code execution.
timer_test, an Octave code which compares several methods of timing code execution.
timer_test, a Python code which returns CPU time or elapsed time.
timestamp, a C code which returns the YMDHMS date as a timestamp.
timestamp, a C++ code which returns the YMDHMS date as a timestamp.
timestamp, a Fortran77 code which returns the YMDHMS date as a timestamp.
timestamp, a Fortran90 code which returns the YMDHMS date as a timestamp.
timestamp, a Julia code which returns the YMDHMS date as a timestamp.
timestamp, a Mathematica code which returns the YMDHMS date as a timestamp.
timestamp, a MATLAB code which returns the YMDHMS date as a timestamp.
timestamp, an Octave code which returns the YMDHMS date as a timestamp.
timestamp, a Perl code which returns the YMDHMS date as a timestamp.
timestamp, a Python function which returns the YMDHMS date as a timestamp.
timestamp, an R code which returns the YMDHMS date as a timestamp.
toeplitz, a Fortran77 code solves a variety of Toeplitz and circulant linear systems.
toeplitz, a Fortran90 code solves a variety of Toeplitz and circulant linear systems.
toeplitz_cholesky, a C code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
toeplitz_cholesky, a C++ code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
toeplitz_cholesky, a Fortran77 code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
toeplitz_cholesky, a Fortran90 code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
toeplitz_cholesky, a MATLAB code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
toeplitz_cholesky, an Octave code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
toeplitz_cholesky, a Python code which computes the Cholesky factorization of a symmetric positive definite (SPD) Toeplitz matrix.
toeplitz_inverse, a MATLAB code which computes the inverse of a Toeplitz matrix.
toeplitz_inverse, an Octave code which computes the inverse of a Toeplitz matrix.
toeplitz_inverse, a Python code which computes the inverse of a Toeplitz matrix.
toms097, a C code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
toms097, a C++ code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
toms097, a Fortran77 code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
toms097, a Fortran90 code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
toms097, a MATLAB code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
toms097, an Octave code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
toms097, a Python code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm. This is a version of ACM TOMS algorithm 97.
toms112, a C code 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++ code 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 code 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 code which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.
toms112, an Octave code 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 code 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 code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code 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 code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
toms179, a C++ code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
toms179, a Fortran77 code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
toms179, a Fortran90 code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
toms179, a MATLAB code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
toms179, an Octave code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
toms179, a Python code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
toms243, a C code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
toms243, a C++ code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
toms243, a Fortran90 code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
toms243, a MATLAB code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
toms243, an Octave code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
toms243, a Python code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
toms291, a C code which evaluates the logarithm of the Gamma function, by Malcolm Pike and David Hill. This is a version of ACM TOMS algorithm 291.
toms291, a C++ code which evaluates the logarithm of the Gamma function, by Malcolm Pike and David Hill. This is a version of ACM TOMS algorithm 291.
toms291, a Fortran77 code which evaluates the logarithm of the Gamma function, by Malcolm Pike and David Hill. This is a version of ACM TOMS algorithm 291.
toms291, a Fortran90 code which evaluates the logarithm of the Gamma function, by Malcolm Pike and David Hill. This is a version of ACM TOMS algorithm 291.
toms291, a MATLAB code which evaluates the logarithm of the Gamma function, by Malcolm Pike and David Hill. This is a version of ACM TOMS algorithm 291.
toms291, an Octave code which evaluates the logarithm of the Gamma function, by Malcolm Pike and David Hill. This is a version of ACM TOMS algorithm 291.
toms322, a C code which evaluates the F and Student T Cumulative Density Functions (CDF); This is a version of ACM TOMS algorithm 291.
toms322, a Fortran77 code which evaluates the F and Student T Cumulative Density Functions (CDF). This is a version of ACM TOMS algorithm 322.
toms332, a Fortran77 code which evaluates Jacobi polynomials; this is a version of ACM TOMS algorithm 332.
toms343, a Fortran77 code which computes the eigenvalues and eigenvectors of a general real matrix; this is a version of ACM TOMS algorithm 343.
toms344, a Fortran77 code which calculates the Student T distribution; this is a version of ACM TOMS algorithm 344.
toms347, a Fortran77 code which sorts an integer vector; this is a version of ACM TOMS algorithm 347.
toms351, a Fortran77 code which estimates an integral using Romberg integration. This is a version of ACM TOMS algorithm 351.
toms352, a Fortran77 code which computes the characteristic values and associated solutions of the Mattieu ordinary differential equation (ODE); this is a version of ACM TOMS algorithm 352.
toms353, a Fortran77 code 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 code which computes the singular value decomposition (SVD) of a complex matrix; this is a version of ACM TOMS algorithm 358.
toms358, a Fortran90 code 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 code which computes the factorial analysis of variance; this is a version of ACM TOMS algorithm 359.
toms365, a Fortran77 code which finds a root of an analytic complex function by the downhill method; this is a version of ACM TOMS algorithm 365.
toms370, a Fortran77 code which produces random numbers sampled from an arbitrary Probability Density Function (PDF); this is a version of ACM TOMS algorithm 370.
toms379, a Fortran77 code which estimates an integral, by James Lyness. This is a version of ACM TOMS algorithm 379.
toms384, a Fortran77 code which computes the eigenvalues and eigenvectors of a symmetric matrix; this is a version of ACM TOMS algorithm 384.
toms385, a Fortran77 code which evaluates the exponential integral function; this is a version of ACM TOMS algorithm 385.
toms392, a Fortran77 code which approximates the time evolution of a hyperbolic PDE; this is a version of ACM TOMS algorithm 392.
toms418, a Fortran77 code which estimates Fourier integrals of the form integral ( a<=x<=b ) f(x) * cos(wx) dx, or integral ( a<=x<=b ) f(x) * sin(wx) dx, by Bo Einarsson. This is a version of ACM TOMS algorithm 418.
toms419, a Fortran77 code which seeks all the roots of a polynomial with complex coefficients, commonly known as cpoly(); this is a version of ACM TOMS algorithm 419.
toms419, a Fortran90 code which seeks all the roots of a polynomial with complex coefficients, commonly known as cpoly(); this is a version of ACM TOMS algorithm 419.
toms423, a Fortran77 code which implements Gaussian elimination, revised versions of decomp() and solve(); this is a version of ACM TOMS algorithm 423.
toms424, a Fortran77 code which implements Clenshaw-Curtis integration; this is a version of ACM TOMS algorithm 424.
toms425, a Fortran77 code which generates a sequence of vectors from a multivariate normal distribution with given covariance; this is a version of ACM TOMS algorithm 425.
toms427, a Fortran77 code which estimates the value of a Fourier cosine integral of the form integral ( 0 <= x < +oo ) f(t) cos ( w * t ) dt, by Peter Linz. This is a version of ACM TOMS algorithm 427.
toms429, a Fortran77 code which reports information about the estimated location of roots of a polynomial; this is a version of ACM TOMS algorithm 429.
toms431, a Fortran77 code which solves quadratic and linear programming problems; this is a version of ACM TOMS algorithm 431.
toms434, a Fortran77 code which computes the probability of a given RxC contingency table; this is a version of ACM TOMS algorithm 434.
toms435, a Fortran77 code which evaluates the modified incomplete Gamma function. This is a version of ACM TOMS algorithm 435.
toms436, a Fortran77 code which carries out product-type trapezoid rule integration; this is a version of ACM TOMS algorithm 436.
toms437, a Fortran77 code which carries out product-type Simpson integration; this is a version of ACM TOMS algorithm 437.
toms438, a Fortran77 code which carries out product-type two point Gauss-legendre-Simpson integration; this is a version of ACM TOMS algorithm 438.
toms439, a Fortran77 code which carries out product-type three point Gauss-Legendre-Simpson integration; this is a version of ACM TOMS algorithm 439.
toms441, a Fortran77 code which samples the dipole Probability Density Function (PDF); this is a version of ACM TOMS algorithm 441.
toms443, a C code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
toms443, a C++ code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
toms443, a Fortran77 code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
toms443, a Fortran90 code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
toms443, a MATLAB code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
toms443, an Octave code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
toms443, a Python code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
toms446, a C code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
toms446, a C++ code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
toms446, a Fortran77 code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
toms446, a Fortran90 code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
toms446, a MATLAB code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
toms446, an Octave code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
toms448, a Fortran77 code which counts partitions of an integer into a given set of integers; this is a version of ACM TOMS algorithm 448.
toms449, a Fortran77 code which implements ACM TOMS algorithm 449, which solves linear programming problems in which the variables are restricted to the values 0 and 1.
toms450, a Fortran77 code which minimizes a scalar function of N variables using the method of Rosenbrock; this is a version of ACM TOMS algorithm 450.
toms451, a Fortran77 code which determines quantiles of the Chi-Square Probability Density Function (PDF); this is a version of ACM TOMS algorithm 451.
toms452, a Fortran77 code which generates a sequence of combinations of M things out of N; this is a version of ACM TOMS algorithm 452.
toms453, a Fortran77 code which determines the abscissas and weights for a Gaussian quadrature formula for the Bromwich integral; this is a version of ACM TOMS algorithm 453.
toms453, a Fortran90 code which determines the abscissas and weights for a Gaussian quadrature formula for the Bromwich integral; this is a version of ACM TOMS algorithm 453.
toms454, a Fortran77 code which implements the complex method of constrained optimization; this is a version of ACM TOMS algorithm 454.
toms456, a Fortran77 code which implements the routing algorithm; this is a version of ACM TOMS algorithm 456.
toms460, a Fortran77 code which determines the optimal parameters for an alternating direction implicit (ADI) iteration; this is a version of ACM TOMS algorithm 460.
toms461, a Fortran77 code which applies cubic spline solutions to a class of functional differential equations; this is a version of ACM TOMS algorithm 461.
toms462, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 code which chooses nice ranges for a graph of computer-generated data; this is a version of ACM TOMS algorithm 463.
toms467, a Fortran77 code which transposes a matrix in place; this is a version of ACM TOMS algorithm 467.
toms468, a Fortran77 code 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 code which solves an almost tridiagonal system of linear equations; this is a version of ACM TOMS algorithm 470.
toms493, a Fortran77 code which seeks the roots of a real polynomial; this is commonly called rpoly(); this is a version of ACM TOMS algorithm 493, by Michael Jenkins.
toms493, a Fortran90 code which seeks the roots of a real polynomial; this is commonly called rpoly(); this is a version of ACM TOMS algorithm 493, by Michael Jenkins.
toms494, a Fortran77 code which approximates a 1D partial differential equation (PDE) as a system of ordinary differential equations (ODE); this is commonly called pdeone(); this is a version of ACM TOMS algorithm 494.
toms502, a Fortran77 code 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 code which evaluates Bessel I or J functions of real non-integer order, This is a version of ACM TOMS Algorithm 511;
toms515, a C code which selects random subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
toms515, a C++ code which selects random subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
toms515, a Fortran77 code which selects random subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
toms515, a Fortran90 code which selects random subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
toms515, a MATLAB code which selects random subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
toms515, an Octave code which selects random subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
toms515, a Python code which selects random subsets of size K from a set of size N. This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
toms526, a Fortran77 code which interpolates scattered bivariate data. This is a version of ACM TOMS algorithm 526, by Hiroshi Akima;
toms526, a Fortran90 code which interpolates scattered bivariate data. This is a version of ACM TOMS algorithm 526, by Hiroshi Akima;
toms550, a Fortran77 code which evaluates certain measures of a solid polyhedron, including surface area, centroid, volume, weight, moments and products of inertia; this is a version of ACM TOMS algorithm 550.
toms552, a Fortran77 code which solves an overdetermined constrained linear system this is a version of ACM TOMS algorithm 552.
toms552, a Fortran90 code 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 code 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 code which approximates the solution of a system of time-dependent partial differential equations (PDE) over a 2D domain; this is commonly called pdetwo(); this is a version of ACM TOMS algorithm 565;
toms571, a Fortran77 code which evaluates or inverts the von Mises and Fisher Probability Density Functions (PDF) of directions on a circle or sphere; this is a version of ACM TOMS algorithm 571.
toms573, a Fortran77 code which is an adaptive nonlinear least squares (NLS) algorithm, by John Dennis, David Gay, Roy Welsch, This is a version of ACM TOMS algorithm 573.
toms577, a C code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
toms577, a C++ code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
toms577, a Fortran77 code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
toms577, a Fortran90 code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
toms577, a MATLAB code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
toms577, an Octave code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
toms577, a Python code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
toms581, a Fortran77 code 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 code which seeks to produce a sequence of points that satisfy nonlinear equations with one degree of freedom; this is commonly called PITCON; this is a version of ACM TOMS algorithm 596.
toms597, a Fortran77 code which evaluates Bessel I functions of real non-integer order, by William Cody. This is a version of ACM TOMS Algorithm 597;
toms597, a Fortran90 code which evaluates Bessel I functions of real non-integer order, by William Cody. This is a version of ACM TOMS Algorithm 597;
toms599, a Fortran77 code which produces samples from the exponential, gamma, normal, poisson, and uniform distributions, by Ahrens, Dieter, and Kohrt. This is a version of ACM TOMS algorithm 599.
toms611, a Fortran77 code 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 code 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 code which estimates the integral of a function over a triangle. The code is commonly known as triex(); This is a version of ACM TOMS algorithm 612.
toms614, a Fortran77 code which computes the integral of functions which may have singularities at one or both ends of a interval, which may be finite, semi-infinite, or infinite, by Sikorski, Sprenger, Schwing. This is a version of ACM TOMS algorithm 614.
toms626, a Fortran77 code which creates a contour plot of data associated with a triangulated set of points. This is a version of ACM TOMS algorithm 626.
toms632, a Fortran77 code which solves the multiple knapsack problem, by Silvano Martello and Paolo Toth. This is a version of ACM TOMS algorithm 632.
toms641, a Fortran77 code which computes the exact solution of a system of linear equations, by John Springer. This is a version of ACM TOMS algorithm 641.
toms644, a Fortran77 code which evaluates the Bessel I, J, K, Y functions, the Airy functions Ai and Bi, and the Hankel function, for complex argument and real order. This is a version of ACM TOMS algorithm 644.
toms647, a Fortran77 code which evaluates Faure, Halton and Sobol Quasi Monte Carlo (QMC) sequences. This is a version of ACM TOMS algorithm 647,
toms647, a Fortran90 code which evaluates Faure, Halton and Sobol Quasi Monte Carlo (QMC) sequences. This is a version of ACM TOMS algorithm 647.
toms648, a Fortran77 code which defines non-stiff systems of ordinary differential equations (ODE) to be used as test problems; this is part of ACM TOMS algorithm 648.
toms655, a C code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
toms655, a C++ code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
toms655, a Fortran77 code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
toms655, a Fortran90 code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
toms655, a MATLAB code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
toms655, an Octave code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
toms655, a Python code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655. Only a portion has been converted to Python!
toms655_original, a Fortran77 code which computes the weights for interpolatory quadrature rules; this is commonly called iqpack(), by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
toms659, a Fortran77 code which computes elements of the Sobol Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 659.
toms659, a Fortran90 code which computes elements of the Sobol Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 659.
toms660, a Fortran77 code 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 code 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 code 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 code 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 code which uses Gauss elimination to solve linear systems involving large banded matrices. Disk storage is used when there is not enough memory for the working data. This code is commonly known as gbsol(). This is a version of ACM TOMS algorithm 664.
toms666, a Fortran77 code which locates and evaluates roots of systems of nonlinear equations, by Michael Vrahatis. This is a version of ACM TOMS algorithm 666.
toms672, a Fortran77 code which generates an interpolatory quadrature rule of highest possible order, given preassigned abscissas. This can be used to generate Gauss-Kronrod and Gauss-Patterson quadrature rules. This is commonly called extend(); This is a version of ACM TOMS algorithm 672.
toms672, a Fortran90 code which generates an interpolatory quadrature rule of highest possible order, given preassigned abscissas. This can be used to generate Gauss-Kronrod and Gauss-Patterson quadrature rules. This is commonly called extend(). This is a version of ACM TOMS algorithm 672.
toms699, a Fortran77 code which implements a new representation of the Patterson quadrature formula; this is a version of ACM TOMS algorithm 699.
toms706, a Fortran77 code which estimates the integral of a function over a triangulated region; This code is commonly known as dcutri(). this is a version of ACM TOMS algorithm 706.
toms707, a Fortran77 code which evaluates the confluent hypergeometric function for complex arguments of large magnitude, by Warren Perger, Atul Bhalla, and Mark Nardin. This is a version of ACM TOMS algorithm 707.
toms708, a Fortran77 code 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 code 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 java code 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 code which evaluates special functions, including the Bessel I, J, K, and Y functions of order 0, of order 1, and of any real order, the Dawson 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 code which evaluates special functions, including the Bessel I, J, K, and Y functions of order 0, of order 1, and of any real order, the Dawson 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 code which supports IEEE arithmetic; this is a version of ACM TOMS algorithm 722.
toms723, a Fortran77 code which computes the Fresnel sine and cosine integrals, by W van Snyder. This is a version of ACM TOMS algorithm 723.
toms724, a Fortran77 code which computes the inverse Cumulative Density Function (CDF) or percentiles of the F distribution, by Roger Abernathy and Robert Smith. This is a version of ACM TOMS algorithm 724.
toms725, a Fortran77 code which evaluates multivariate normal integrals associated with the computation of cumulative probability density function CDF associated with a multidimensional variable governed by a normal probability density function (PDF) with a known correlation matrix, by Zvi Drezner. This is a version of ACM TOMS algorithm 725.
toms726, a Fortran77 code which computes recursion coefficients for orthogonal polynomials, and the abscissa and weights for related quadrature rules, by Walter Gautschi. This is commonly called orthpol(). This is a version of ACM TOMS algorithm 726.
toms726, a Fortran90 code which computes recursion coefficients for orthogonal polynomials, and the abscissa and weights for related quadrature rules. by Walter Gautschi. This is commonly called orthpol(). This is a version of ACM TOMS algorithm 726.
toms738, a Fortran77 code which evaluates the Niederreiter Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 738;
toms738, a Fortran90 code which evaluates the Niederreiter Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 738;
toms743, a C code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
toms743, a C++ code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
toms743, a Fortran77 code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
toms743, a Fortran90 code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
toms743, a MATLAB code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
toms743, an Octave code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
toms743, a Python code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
toms757, a Fortran77 code which evaluates uncommon special functions, by Allan Mcleod; this is a version of ACM TOMS algorithm 757;
toms757, a Fortran90 code which evaluates uncommon special functions, by Allan Mcleod; this is a version of ACM TOMS algorithm 757;
toms772, a Fortran77 code which carries out computational geometry on the unit sphere, by Robert Renka. this is commonly called stripack(); this is a version of ACM TOMS algorithm 772.
toms790, a Fortran77 code which computes an interpolating function to scattered data in the plane, by Robert Renka; This is commonly called cshep2d(); this is a version of ACM TOMS algorithm 790.
toms790, a Fortran90 code which computes an interpolating function to scattered data in the plane, by Robert Renka; this is commonly called cshep2d(); this is a version of ACM TOMS algorithm 790.
toms792, a Fortran77 code which tests functions that interpolate scattered data in the plane; by Robert Renka; this is a version of ACM TOMS algorithm 792.
toms792, a Fortran90 code 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 code which carries out Gauss quadrature for rational functions, by Walter Gautschi. This is commonly called gqrat(). This is a version of ACM TOMS algorithm 793.
toms847, a MATLAB code which carries out piecewise linear (PWL) multidimensional hierarchical sparse grid interpolation; this is commonly called spinterp() (version 2.1); this is a version of ACM TOMS Algorithm 847, by Andreas Klimke;
toms847, an Octave code which carries out piecewise linear (PWL) multidimensional hierarchical sparse grid interpolation; this is commonly called spinterp() (version 2.1); this is a version of ACM TOMS Algorithm 847, by Andreas Klimke;
toms866, a MATLAB code 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.
toms866, an Octave code 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 code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
toms886, a C++ code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
toms886, a Fortran77 code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
toms886, a Fortran90 code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
toms886, a MATLAB code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
toms886, an Octave code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
toms917, a C code 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++ code which evaluates the Wright Omega function, by Piers Lawrence, Robert Corless, David Jeffrey. This is a version of ACM TOMS algorithm 917.
toms923, a MATLAB code which evaluates the Pfaffian for a dense or banded skew symmetric matrix, by Michael Wimmer. This is a version of ACM TOMS algorithm 923.
toms923, an Octave code which evaluates the Pfaffian for a dense or banded skew symmetric matrix, by Michael Wimmer. This is a version of ACM TOMS algorithm 923.
toms923, a Python code which evaluates the Pfaffian for a dense or banded skew symmetric matrix, by Michael Wimmer.
tortoise, a MATLAB code which considers the tortoise tiling puzzle, a smaller version of the eternity puzzle. The puzzle specifies a region R composed of 1620 30-60-90 triangles, and a set of 45 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
tortoise_cplex_test a BASH code which calls cplex(), to read the LP file defining the tortoise tiling problem, solve the linear programming problem, and write the solution to a file.
tortoise_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the tortoise tiling problem, solve the linear programming problem, and write the solution to a file.
tough_ode, a MATLAB code which sets up a system of four ordinary differential equations (ODE) which is extremely difficult to solve accurately.
tough_ode, an Octave code which sets up a system of four ordinary differential equations (ODE) which is extremely difficult to solve accurately.
tough_ode, a Python code which sets up a system of four ordinary differential equations (ODE) which is extremely difficult to solve accurately.
traffic, a FreeFem++ code which sets up a traffic flow model with diffusion and lane branching. Two roads cross at a moderate angle.
traffic_simulation, a MATLAB code which simulates the cars waiting to get through a traffic light.
traffic_simulation, an Octave code which simulates the cars waiting to get through a traffic light.
traffic_simulation, a Python code which simulates the cars waiting to get through a traffic light.
trapezoid, an R code which estimates an integral using the trapezoid quadrature rule.
trapezoidal, a C code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and a version of fsolve() to handle the nonlinear equation.
trapezoidal, a C++ code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and a version of fsolve() to handle the nonlinear equation.
trapezoidal, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and a version of fsolve() to handle the nonlinear equation.
trapezoidal, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and a version of fsolve() to handle the nonlinear equation.
trapezoidal, a FreeFem++ code which uses the implicit trapezoidal method to solve a time-dependent boundary value problem (BVP).
trapezoidal, a MATLAB code which solves one or more ordinary differential equations (ODE) using the implicit trapezoidal method, and MATLAB's fsolve() function to handle the nonlinear equation.
trapezoidal, an Octave code which solves one or more ordinary differential equations (ODE) using the implicit trapezoidal method, and the fsolve() function to handle the nonlinear equation.
trapezoidal, a Python code which solves one or more ordinary differential equations (ODE) using the implicit trapezoidal method, using fsolve() to handle the nonlinear equation.
trapezoidal, an R code which implements the implicit trapezoidal method for solving an ordinary differential equation (ODE), using fsolve() to handle the implicit equation, adapted from the pracma() code of Hans Borchers.
trapezoidal_explicit, a MATLAB code which solves one or more ordinary differential equations (ODE) using the explicit trapezoidal method.
trapezoidal_explicit, a Python code which solves one or more ordinary differential equations (ODE) using the explicit trapezoidal method.
trapezoidal_fixed, a MATLAB code which solves one or more ordinary differential equations (ODE) using the implicit trapezoidal method, using the fixed point method.
trapezoidal_fixed, an Octave code which solves one or more ordinary differential equations (ODE) using the implicit trapezoidal method, using the fixed point method.
trapezoidal_fixed, a Python code which solves one or more ordinary differential equation (ODE) using the implicit trapezoidal method, using a fixed point method to handle the implicit system.
trapezoidal_fixed, an R code which implements the implicit trapezoidal method for solving an ordinary differential equation (ODE), using a fixed point method to handle the implicit equation, adapted from the pracma() code of Hans Borchers.
treepack, a C code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
treepack, a C++ code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
treepack, a Fortran77 code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
treepack, a Fortran90 code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
treepack, a MATLAB code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
treepack, an Octave code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
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 code which displays the 3D graphics information in a tri_surface file;
tri_surface_display, an Octave code which displays the 3D graphics information in a tri_surface file;
tri_surface_display_opengl, a C++ code which displays the 3D graphics information in a tri_surface file using OpenGL.
tri_surface_display_opengl_test
tri_surface_io, a C++ code which reads and writes the graphics information in a tri_surface file, describing a surface in 3D consisting of a collection of connected triangles;
tri_surface_io, a Fortran90 code which reads and writes the graphics information in a tri_surface file, describing a surface in 3D consisting of a collection of connected triangles;
tri_surface_io, a MATLAB code which reads and writes the graphics information in a tri_surface file, describing a surface in 3D consisting of a collection of connected triangles;
tri_surface_io, an Octave code which reads and writes the graphics information in a tri_surface file, describing a surface in 3D consisting of a collection of connected triangles;
tri_surface_to_obj, a MATLAB code which reads a tri_surface dataset and extracts the surface mesh data as an OBJ file.
tri_surface_to_obj, an Octave code which reads a tri_surface dataset and extracts the surface mesh data as an OBJ file.
tri_surface_to_ply, a MATLAB code which converts a tri_surface dataset to a dataset suitable for storage as a PLY file.
tri_surface_to_ply, an Octave code which converts a tri_surface dataset to a dataset suitable for storage as a PLY file.
tri_surface_to_stla, a MATLAB code which reads a tri_surface dataset and extracts the surface mesh data as an ASCII stereolithography (STL) file.
tri_surface_to_stla, an Octave code which reads a tri_surface dataset and extracts the surface mesh data as an ASCII stereolithography (STL) file.
triangle, a C code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
triangle, a C++ code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
triangle, a Fortran77 code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
triangle, a Fortran90 code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
triangle, a MATLAB code which computes properties of a triangle, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, quality, Cartesian to barycentric coordinates, barycentric coordinates to Cartesian. A point is treated as a (1,2) array, a list of points as an (n,2) array, and a triangle as a (3,2) array.
triangle, an Octave code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
triangle, a Python code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
triangle_analyze, a C code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
triangle_analyze, a C++ code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
triangle_analyze, a Fortran77 code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
triangle_analyze, a Fortran90 code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
triangle_analyze, a MATLAB code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
triangle_analyze, an Octave code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
triangle_bench, a C code which sets up sample datasets of random points in the unit square, writes them to a file acceptable by Jonathan Shewchuk's triangle() program for computing Delaunay triangulations and Voronoi diagrams, which can then be benchmarked by timing the computation for increasing large sets.
triangle_display, a MATLAB code which displays the nodes and elements of a triangulation, assuming the data has been stored in NODE and ELE files by Jonathan Shewchuk's triangle() program.
triangle_display, an Octave code which displays the nodes and elements of a triangulation, assuming the data has been stored in NODE and ELE files by Jonathan Shewchuk's triangle() program.
triangle_distance, a MATLAB code which computes the expected value of the distance between a pair of points randomly selected in a triangle in 2D.
triangle_distance, an Octave code which computes the expected value of the distance between a pair of points randomly selected in a triangle in 2D.
triangle_distance, a Python code which computes the expected value of the distance between a pair of points randomly selected in a triangle in 2D.
triangle_dunavant_rule, a C++ code which defines Dunavant rules for quadrature over the interior of a triangle in 2D.
triangle_dunavant_rule, a Fortran90 code which defines Dunavant rules for quadrature over the interior of a triangle in 2D.
triangle_dunavant_rule, a MATLAB code which defines Dunavant rules for quadrature over the interior of a triangle in 2D.
triangle_dunavant_rule, an Octave code which defines Dunavant rules for quadrature over the interior of a triangle in 2D.
triangle_exactness, a C code which computes the exactness of a quadrature rule over the interior of a triangle in 2D.
triangle_exactness, a C++ code which computes the exactness of a quadrature rule over the interior of a triangle in 2D.
triangle_exactness, a Fortran77 code which computes the exactness of a quadrature rule over the interior of a triangle in 2D.
triangle_exactness, a Fortran90 code which computes the exactness of a quadrature rule over the interior of a triangle in 2D.
triangle_exactness, a MATLAB code which computes the exactness of a quadrature rule over the interior of a triangle in 2D.
triangle_exactness, an Octave code which computes the exactness of a quadrature rule over the interior of a triangle in 2D.
triangle_exactness, a Python code which computes the exactness of a quadrature rule over the interior of a triangle in 2D.
triangle_fekete_rule, a C code which defines a Fekete rule for interpolation or quadrature over the interior of a triangle in 2D.
triangle_fekete_rule, a C++ code which defines Fekete rules for interpolation or quadrature over the interior of a triangle in 2D.
triangle_fekete_rule, a Fortran90 code which defines Fekete rules for interpolation or quadrature over the interior of a triangle in 2D.
triangle_fekete_rule, a MATLAB code which defines Fekete rules for quadrature or interpolation over the interior of a triangle in 2D.
triangle_felippa_rule, a C code which returns a Felippa quadrature rule for approximating integrals over the interior of a triangle in 2D.
triangle_felippa_rule, a C++ code which returns a Felippa quadrature rule for approximating integrals over the interior of a triangle in 2D.
triangle_felippa_rule, a Fortran77 code which returns a Felippa quadrature rule for approximating integrals over the interior of a triangle in 2D.
triangle_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of a triangle in 2D.
triangle_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of a triangle in 2D.
triangle_files, a data directory which contains examples of files used by Jonathan Shewchuk's triangle() and showme() programs.
triangle_grid, a C code which computes a grid of points over the interior of a triangle in 2D.
triangle_grid, a C++ code which computes a grid of points over the interior of a triangle in 2D.
triangle_grid, a Fortran77 code which computes a grid of points over the interior of a triangle in 2D.
triangle_grid, a Fortran90 code which computes a grid of points over the interior of a triangle in 2D.
triangle_grid, a MATLAB code which computes a grid of points over the interior of a triangle in 2D.
triangle_grid, an Octave code which computes a grid of points over the interior of a triangle in 2D.
triangle_grid, a Python code which computes a grid of points over the interior of a triangle in 2D.
triangle_histogram, a C++ code which computes histograms of data on the unit triangle in 2D.
triangle_histogram, a Fortran90 code which computes histograms of data on the unit triangle in 2D.
triangle_histogram, a MATLAB code which computes histograms of data on the unit triangle in 2D.
triangle_histogram, an Octave code which computes histograms of data on the unit triangle in 2D.
triangle_integrals, a C code which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.
triangle_integrals, a C++ code which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.
triangle_integrals, a Fortran77 code which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.
triangle_integrals, a Fortran90 code which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.
triangle_integrals, a MATLAB code which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.
triangle_integrals, an Octave code which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.
triangle_integrals, a Python code which returns the exact value of the integral of a polynomial over the interior of an arbitrary triangle in 2D.
triangle_integrands, a MATLAB code which defines integrands over triangular regions, for testing quadrature rules.
triangle_integrands, an Octave code which defines integrands over triangular regions, for testing quadrature rules.
triangle_interpolate, a C code which shows how vertex data can be interpolated at any point in the interior of a triangle.
triangle_interpolate, a C++ code which shows how vertex data can be interpolated at any point in the interior of a triangle.
triangle_interpolate, a Fortran90 code which shows how vertex data can be interpolated at any point in the interior of a triangle.
triangle_interpolate, a MATLAB code which shows how vertex data can be interpolated at any point in the interior of a triangle.
triangle_interpolate, an Octave code which shows how vertex data can be interpolated at any point in the interior of a triangle.
triangle_interpolate, a Python code which shows how vertex data can be interpolated at any point in the interior of a triangle.
triangle_io, a C code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
triangle_io, a C++ code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
triangle_io, a Fortran77 code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
triangle_io, a Fortran90 code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
triangle_io, a MATLAB code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
triangle_io, an Octave code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
triangle_lyness_rule, a C++ code which returns a Lyness-Jespersen quadrature rule over the interior of a triangle in 2D.
triangle_lyness_rule, a Fortran90 code which returns a Lyness-Jespersen quadrature rule over the interior of a triangle in 2D.
triangle_lyness_rule, a MATLAB code which returns a Lyness-Jespersen quadrature rule over the interior of a triangle in 2D.
triangle_lyness_rule, an Octave code which returns a Lyness-Jespersen quadrature rule over the interior of a triangle in 2D.
triangle_monte_carlo, a C code which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.
triangle_monte_carlo, a C++ code which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.
triangle_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.
triangle_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.
triangle_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.
triangle_monte_carlo, an Octave code which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.
triangle_monte_carlo, a Python code which uses the Monte Carlo method to estimate integrals over the interior of a general triangle in 2D.
triangle_ncc_rule, a C code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.
triangle_ncc_rule, a C++ code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.
triangle_ncc_rule, a Fortran90 code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.
triangle_ncc_rule, a MATLAB code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.
triangle_nco_rule, a C code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.
triangle_nco_rule, a C++ code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.
triangle_nco_rule, a Fortran90 code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.
triangle_nco_rule, a MATLAB code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.
triangle_nodefile_random, a C code which generates a set of N random nodes in M dimensions, and writes them to a file suitable for processing by Jonathan Shewchuk's triangle() program.
triangle_quadrature_symmetry, a MATLAB code which determines the symmetries of a quadrature rule for a triangle.
triangle_quadrature_symmetry_test
triangle_quadrature_symmetry, an Octave code which determines the symmetries of a quadrature rule for a triangle.
triangle_quadrature_symmetry_test
triangle_refine, a MATLAB code which refines a triangle into c^2 smaller copies of itself, and implements a simple centroid-based quadrature scheme.
triangle_refine, an Octave code which refines a triangle into c^2 smaller copies of itself, and implements a simple centroid-based quadrature scheme.
triangle_samples, a dataset directory which contains examples of sets of sample points from the unit triangle.
triangle_shewchuk, a C code which computes a triangulation of a geometric region, by Jonathan Shewchuk. This program is ordinarily simply known as triangle().
triangle_svg, a C code which uses Scalable Vector graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
triangle_svg, a C++ code which uses Scalable Vector graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
triangle_svg, a Fortran77 code which uses Scalable Vector graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
triangle_svg, a Fortran90 code which uses Scalable Vector graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
triangle_svg, a MATLAB code which uses Scalable Vector graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
triangle_svg, an Octave code 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 code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_rule, a C++ code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_rule, a Fortran77 code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_rule, a Fortran90 code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_rule, a MATLAB code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_rule, an Octave code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_rule, a Python code which returns symmetric quadrature rules, with precision up to 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_rule_convert a MATLAB code which takes quadrature rules for the equilateral triangle and converts them to the reference triangle (0,0), (1,0), (0,1).
triangle_symq_rule_old, a MATLAB code which is based on the original Fortran77 code, which uses an equilateral triangle as the reference element, by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_to_ref, a MATLAB code which creates quadrature rules defined on the half-unit square from symmetric quadrature rules defined on an equilateral triangle, defined by triangle_symq_rule(), by Hong Xiao and Zydrunas Gimbutas.
triangle_symq_to_ref, an Octave code which creates quadrature rules defined on the half-unit square from symmetric quadrature rules defined on an equilateral triangle, defined by triangle_symq_rule(), by Hong Xiao and Zydrunas Gimbutas.
triangle_to_fem, a C code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes two simple mesh format files, listing node coordinates and element connectivity.
triangle_to_fem, a C++ code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
triangle_to_fem, a Fortran77 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
triangle_to_fem, a Fortran90 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
triangle_to_fem, a MATLAB code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes two simple mesh format files, listing node coordinates and element connectivity.
triangle_to_fem, an Octave code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes two simple mesh format files, listing node coordinates and element connectivity.
triangle_to_medit, a C code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
triangle_to_medit, a C++ code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
triangle_to_medit, a Fortran77 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
triangle_to_medit, a Fortran90 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
triangle_to_medit, a MATLAB code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
triangle_to_medit, an Octave code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
triangle_to_xml, a C code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program 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++ code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program 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 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program 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 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program 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 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by dolfin() or fenics().
triangle_to_xml, an Octave code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by dolfin() or fenics().
triangle_twb_rule, a C code which generates a quadrature rule over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
triangle_twb_rule, a C++ code which returns a quadrature rule over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
triangle_twb_rule, a Fortran90 code which returns a quadrature rule over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
triangle_twb_rule, a MATLAB code which returns a quadrature rule over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
triangle_twb_rule, an Octave code which returns a quadrature rule over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
triangle_twb_rule, a Python code which returns a quadrature rule over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
triangle_wandzura_rule, a C++ code which returns a Wandzura quadrature rule of exactness 5, 10, 15, 20, 25 or 30 over the interior of the triangle in 2D.
triangle_wandzura_rule, a Fortran90 code which returns a Wandzura quadrature rule of exactness 5, 10, 15, 20, 25 or 30 over the interior of the triangle in 2D.
triangle_wandzura_rule, a MATLAB code which returns a Wandzura quadrature rule of exactness 5, 10, 15, 20, 25 or 30 over the interior of the triangle in 2D.
triangle_wandzura_rule, an Octave code which returns a Wandzura quadrature rule of exactness 5, 10, 15, 20, 25 or 30 over the interior of the triangle in 2D.
triangle_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
triangle_witherden_rule, a C++ code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
triangle_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
triangle_witherden_rule, a MATLAB code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
triangle_witherden_rule, an Octave code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
triangle_witherden_rule, a Python code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
triangle01_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.
triangle01_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.
triangle01_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.
triangle01_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.
triangle01_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.
triangle01_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit triangle in 2D.
triangle01_integrals, a Python code 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 code which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.
triangle01_monte_carlo, a C++ code which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.
triangle01_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.
triangle01_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.
triangle01_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.
triangle01_monte_carlo, an Octave code which uses the Monte Carlo method to estimate integrals over the interior of the unit triangle in 2D.
triangle01_monte_carlo, a Python code 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 code which triangulates a possibly nonconvex polygon, by Joseph ORourke.
triangulate, a MATLAB code which triangulates a possibly nonconvex polygon, based on a C code by Joseph ORourke.
triangulate, an Octave code which triangulates a possibly nonconvex polygon, based on a C code by Joseph ORourke.
triangulate_rectangle, a MATLAB code which sets up a grid of triangles in a rectangular region.
triangulate_rectangle, an Octave code which sets up a grid of triangles in a rectangular region.
triangulation, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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, a MATLAB code which starts with a triangulation of a simple shape, and determines the triangle edges that form the boundary, and a sequence of nodes that trace the boundary.
triangulation_boundary, an Octave code which starts with a triangulation of a simple shape, and determines the triangle edges that form the boundary, and a sequence of nodes that trace the boundary.
triangulation_boundary_edges, a MATLAB code which reads data defining a triangulation, determines which edges lie on the boundary, organizes them into connected components, and writes this information to a file.
triangulation_boundary_edges_test
triangulation_boundary_edges, an Octave code which reads data defining a triangulation, determines which edges lie on the boundary, organizes them into connected components, and writes this information to a file.
triangulation_boundary_edges_test
triangulation_boundary_nodes, a C++ code which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file.
triangulation_boundary_nodes_test
triangulation_boundary_nodes, a Fortran90 code 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 code which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file.
triangulation_boundary_nodes_test
triangulation_boundary_nodes, an Octave code which reads data defining a triangulation, determines which nodes lie on the boundary, and writes their coordinates to a file.
triangulation_boundary_nodes_test
triangulation_corner, a C++ code which patches triangulations so that no triangle has two sides on the boundary.
triangulation_corner, a Fortran90 code which patches triangulations so that no triangle has two sides on the boundary.
triangulation_corner, a MATLAB code which patches triangulations so that no triangle has two sides on the boundary.
triangulation_delaunay_discrepancy, a C++ code which measures the amount by which a triangulation fails the local Delaunay test;
triangulation_delaunay_discrepancy_test
triangulation_delaunay_discrepancy, a Fortran90 code which measures the amount by which a triangulation fails the local Delaunay test;
triangulation_delaunay_discrepancy, a MATLAB code which measures the amount by which a triangulation fails the local Delaunay test;
triangulation_delaunay_discrepancy_test
triangulation_delaunay_discrepancy, an Octave code which measures the amount by which a triangulation fails the local Delaunay test;
triangulation_delaunay_discrepancy_test
triangulation_display, a MATLAB code which displays the nodes and elements of a triangulation;
triangulation_display, an Octave code which displays the nodes and elements of a triangulation;
triangulation_display_opengl, a C++ code which reads files defining a 2D triangulation and displays an image using OpenGL.
triangulation_display_opengl_test
triangulation_histogram, a C++ code which computes histograms of data over a triangulation.
triangulation_histogram, a Fortran90 code which computes histograms of data over a triangulation.
triangulation_histogram, a MATLAB code which computes histograms of data over a triangulation.
triangulation_l2q, a C++ code which reads information about a 3-node linear triangulation and creates data defining a corresponding 6-node quadratic triangulation;
triangulation_l2q, a Fortran90 code which reads information about a 3-node linear triangulation and creates data defining a corresponding 6-node quadratic triangulation;
triangulation_l2q, a MATLAB code which reads information about a 3-node linear triangulation and creates data defining a corresponding 6-node quadratic triangulation;
triangulation_mask, a C++ code which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;
triangulation_mask, a Fortran90 code which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;
triangulation_mask, a MATLAB code which reads a triangulation and calls a user-supplied routine to consider each triangle for deletion;
triangulation_node_to_element, a C code which reads files describing nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an order1 finite element model of the data.
triangulation_node_to_element_test
triangulation_node_to_element, a C++ code which reads files describing nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an order1 finite element model of the data.
triangulation_node_to_element_test
triangulation_node_to_element, a Fortran77 code which reads files describing nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an order1 finite element model of the data.
triangulation_node_to_element_test
triangulation_node_to_element, a Fortran90 code which reads files describing 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 code which reads files describing nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an order1 finite element model of the data.
triangulation_node_to_element_test
triangulation_node_to_element, an Octave code which reads files describing nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an order1 finite element model of the data.
triangulation_node_to_element_test
triangulation_order1_display, a MATLAB code which plots piecewise constant (PWC) data associated with a triangulation;
triangulation_order1_display_test
triangulation_order1_display, an Octave code which plots piecewise constant (PWC) data associated with a triangulation;
triangulation_order1_display_test
triangulation_order3, a data directory which defines triangulation_order3 files, a description of a linear triangulation 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 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 code which makes a contour plot of piecewise linear (PWL) scalar data defined on an order 3 triangulation.
triangulation_order3_contour_test
triangulation_order3_contour, an Octave code which makes a contour plot of piecewise linear (PWL) scalar data defined on an order 3 triangulation.
triangulation_order3_contour_test
triangulation_order4, a dataset directory which contains triangulation_order4 files, a triangulation of 2D points, using a pair of files to list the node coordinates and the 4 nodes that make up each triangle, the 3 vertices and the centroid;
triangulation_order6, a data directory which defines triangulation_order6 files, a quadratic triangulation 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 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 code which makes contour plots of piecewise quadratic (PWQ) data defined on an order 6 triangulation.
triangulation_order6_contour_test
triangulation_order6_contour, an Octave code which makes contour plots of piecewise quadratic (PWQ) data defined on an order 6 triangulation.
triangulation_order6_contour_test
triangulation_orient, a C++ code which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;
triangulation_orient, a Fortran90 code which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;
triangulation_orient, a MATLAB code which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;
triangulation_orient, an Octave code which ensures that the triangles in an order 3 or order 6 triangulation have positive orientation;
triangulation_plot, a C++ code which plots the nodes and elements of a triangulation as a PostScript (PS) file;
triangulation_plot, a Fortran90 code which plots the nodes and elements of a triangulation as a PostScript (PS) file;
triangulation_plot, a MATLAB code which plots the nodes and elements of a triangulation as a PostScript (PS) file;
triangulation_plot, an Octave code which plots the nodes and elements of a triangulation as a PostScript (PS) file;
triangulation_q2l, a C++ code which reads information about a 6-node quadratic triangulation and creates data defining a corresponding 3-node linear triangulation;
triangulation_q2l, a Fortran90 code which reads information about a 6-node quadratic triangulation and creates data defining a corresponding 3-node linear triangulation;
triangulation_q2l, a MATLAB code which reads information about a 6-node quadratic triangulation and creates data defining a corresponding 3-node linear triangulation;
triangulation_quad, a C++ code which estimates the integral of a function over a triangulated region.
triangulation_quad, a Fortran90 code which estimates the integral of a function over a triangulated region.
triangulation_quad, a MATLAB code which estimates the integral of a function over a triangulated region.
triangulation_quad, an Octave code which estimates the integral of a function over a triangulated region.
triangulation_quality, a C++ code which computes quality measures of a triangulation.
triangulation_quality, a Fortran90 code which computes quality measures of a triangulation.
triangulation_quality, a MATLAB code which computes quality measures of a triangulation.
triangulation_quality, an Octave code which computes quality measures of a triangulation.
triangulation_rcm, a C++ code 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 code 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 code 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++ code which refines a triangulation.
triangulation_refine, a Fortran90 code which refines a triangulation.
triangulation_refine, a MATLAB code which refines a triangulation.
triangulation_refine, an Octave code which refines a triangulation.
triangulation_refine_local, a MATLAB code which refines a triangulation locally; a single triangular element is replaced by four smaller triangles, and neighboring information is updated.
triangulation_refine_local_test
triangulation_refine_local, an Octave code which refines a triangulation locally; a single triangular element is replaced by four smaller triangles, and neighboring information is updated.
triangulation_refine_local_test
triangulation_svg, a C code which creates a Scalable Vector graphics (SVG) image of a triangulation, which can be displayed by a web browser.
triangulation_svg, a C++ code which creates a Scalable Vector Graphics (SVG) image of a triangulation, which can be displayed by a web browser.
triangulation_svg, a Fortran77 code which creates a Scalable Vector graphics (SVG) image of a triangulation, which can be displayed by a web browser.
triangulation_svg, a Fortran90 code which creates a Scalable Vector graphics (SVG) image of a triangulation, which can be displayed by a web browser.
triangulation_svg, a MATLAB code which creates a Scalable Vector graphics (SVG) image of a triangulation, which can be displayed by a web browser.
triangulation_svg, an Octave code 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++ code which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation, using vertices and centroid;
triangulation_t3_to_t4, a Fortran90 code which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation, using vertices and centroid;
triangulation_t3_to_t4, a MATLAB code which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation, using vertices and centroid;
triangulation_t3_to_t4, an Octave code which reads information about a 3-node triangulation and creates data defining a corresponding 4-node triangulation, using vertices and centroid;
triangulation_triangle_neighbors, a C code which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.
triangulation_triangle_neighbors_test
triangulation_triangle_neighbors, a C++ code which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.
triangulation_triangle_neighbors_test
triangulation_triangle_neighbors, a Fortran90 code 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 code which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.
triangulation_triangle_neighbors_test
triangulation_triangle_neighbors, an Octave code which reads data defining a triangulation, determines the neighboring triangles of each triangle, and writes that information to a file.
triangulation_triangle_neighbors_test
tridiagmatrix, an R code which solves a tridiagonal linear system.
tridiagonal_solver, a MATLAB code which solves a tridiagonal linear system.
tridiagonal_solver, an Octave code which solves a tridiagonal linear system.
tridiagonal_solver, a Python code which solves a tridiagonal linear system.
trig_interp, a MATLAB code which performs trigonometric interpolation.
trig_interp, an Octave code which performs trigonometric interpolation.
trig_interp_basis, a MATLAB code which evaluates the cardinal basis functions for trigonometric interpolation of equally spaced data.
trig_interp_basis, an Octave code which evaluates the cardinal basis functions for trigonometric interpolation of equally spaced data.
trig_to_neib, a C code which reads NODE and ELE files, a format prescribed by Jonathan Shewchuk's triangle() program, describing a triangulation, and produces a file defining the neighbor triangles of each element, and information about the Voronoi diagram, by Lili Ju.
trinity, a MATLAB code which considers the trinity puzzle, a smaller version of the eternity puzzle. The trinity puzzle specifies a region R composed of 144 30-60-90 triangles, and 4 "tiles", T1, T2, T3 and T4, each consisting of 36 30-60-90 triangles, and seeks an arrangement of the four tiles that exactly covers the region.
trinity_cplex_test a BASH code which calls cplex(), to read the LP file defining the trinity tiling problem, solve the linear programming problem, and write the solution to a file.
trinity_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the trinity tiling problem, solve the linear programming problem, and write the solution to a file.
trinity_scip_test a BASH code which calls scip(), to read the LP file defining the trinity tiling problem, solve the linear programming problem, and write the solution to a file.
trinity, an Octave code which considers the trinity puzzle, a smaller version of the eternity puzzle. The trinity puzzle specifies a region R composed of 144 30-60-90 triangles, and 4 "tiles", T1, T2, T3 and T4, each consisting of 36 30-60-90 triangles, and seeks an arrangement of the four tiles that exactly covers the region.
triola, a dataset directory which contains datasets used for statistical analysis.
tripack, a Fortran77 code which computes the Delaunay triangulation of points in the plane, ACM TOMS algorithm 751, by Robert Renka.
tripack, a Fortran90 code which computes the Delaunay triangulation of points in the plane, ACM TOMS algorithm 751, by Robert Renka.
truel_simulation, a MATLAB code which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
truel_simulation, an Octave code which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
truel_simulation, a Python code which simulates N repetitions of a duel between three players, each of whom has a known firing accuracy.
truncated_normal, a C code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
truncated_normal, a C++ code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
truncated_normal, a Fortran77 code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
truncated_normal, a Fortran90 code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
truncated_normal, a MATLAB code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
truncated_normal, an Octave code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
truncated_normal, a Python code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
truncated_normal_rule, a C code 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++ code 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 code 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 code 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 code 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 code 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 code which computes a sparse grid based on a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].
truncated_normal_sparse_grid_test
truncated_normal_sparse_grid, an Octave code which computes a sparse grid based on a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].
truncated_normal_sparse_grid_test
tsearch, a MATLAB code which compares several replacements for the obsolete MATLAB tsearch() function, which searched a Delaunay triangulation to find the triangle that encloses a given point.
tsg, a C++ code which uses 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, a Fortran90 code which uses 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 C++ interface by Miroslav Stoyanov.
tsg, a MATLAB code 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 a C++ interface, by Miroslav Stoyanov.
tsp, a dataset directory which contains test data for the traveling salesperson problem (TSP);
tsp_brute, a C code which is given a city-to-city distance table, and solves a (small) traveling salesperson problem (TSP), using brute force.
tsp_brute, a C++ code which is given a city-to-city distance table, and solves a (small) traveling salesperson problem (TSP), using brute force.
tsp_brute, a Fortran77 code which is given a city-to-city distance table, and solves a (small) traveling salesperson problem (TSP), using brute force.
tsp_brute, a Fortran90 code which is given a city-to-city distance table, and solves a (small) traveling salesperson problem (TSP), using brute force.
tsp_brute, a MATLAB code which is given a city-to-city distance table, and solves a (small) traveling salesperson problem (TSP), using brute force.
tsp_brute, an Octave code which is given a city-to-city distance table, and solves a (small) traveling salesperson problem (TSP), using brute force.
tsp_brute, a Python code which is given a city-to-city distance table, and solves a (small) traveling salesperson problem (TSP), using brute force.
tsp_descent, a MATLAB code which is given a city-to-city distance table, chooses an initial tour at random, and then tries simple variations, seeking to quickly find a tour of lower cost for the traveling salesperson problem (TSP).
tsp_descent, an Octave code which is given a city-to-city distance table, chooses an initial tour at random, and then tries simple variations, seeking to quickly find a tour of lower cost for the traveling salesperson problem (TSP).
tsp_descent, a Python code which is given a city-to-city distance table, chooses an initial tour at random, and then tries simple variations, seeking to quickly find a tour of lower cost for the traveling salesperson problem (TSP).
tsp_greedy, a MATLAB code which is given a city-to-city distance table, and solves a small traveling salesperson problem (TSP) using the greedy algorithm. It picks a starting city at random, and then successively visits the nearest unvisited city.
tsp_greedy, an Octave code which is given a city-to-city distance table, and solves a small traveling salesperson problem (TSP) using the greedy algorithm. It picks a starting city at random, and then successively visits the nearest unvisited city.
tsp_greedy, a Python code which is given a city-to-city distance table, and solves a small traveling salesperson problem (TSP) using the greedy algorithm. It picks a starting city at random, and then successively visits the nearest unvisited city.
tsp_io, a Fortran90 code which reads or writes files used for examples of the traveling salesperson problem (TSP).
tsp_lau, a Fortran90 code which implements a heuristic algorithm for the solution of the traveling salesperson problem (TSP).
tsp_moler, a MATLAB code which tries to optimize the traveling salesperson problem (TSP), written by Cleve Moler.
tsp_moler, an Octave code which tries to optimize the traveling salesperson problem (TSP), written by Cleve Moler.
tsp_moler, a Python code which tries to optimize the traveling salesperson problem (TSP), written by Cleve Moler.
tsp_random, a MATLAB code which is given a city-to-city distance table, seeks a solution of the Traveling Salesperson Problem (TSP), by randomly generating round trips that visit every city, returning the tour of shortest length.
tsp_random, an Octave code which is given a city-to-city distance table, seeks a solution of the Traveling Salesperson Problem (TSP), by randomly generating round trips that visit every city, returning the tour of shortest length.
tsp_random, a Python code which is given a city-to-city distance table, seeks a solution of the Traveling Salesperson Problem (TSP), by randomly generating round trips that visit every city, returning the tour of shortest length.
tspsa, an R code which is given a city-to-city distance table, and solves the traveling salesperson problem (TSP) using simulated annealing.
ttyplt, a Fortran77 code which produces simple typewriter graphics plots.
tumor, a MATLAB code which demonstrates a model of tumor growth;
tumor_pde, a MATLAB code which solves the tumor angiogenesis partial differential equations (PDE), in one spatial dimension and time, using MATLAB's pdepe() function.
two_body_ode, a Fortran90 code which sets up ordinary differential equations (ODE) which simulate 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_ode, a MATLAB code which sets up ordinary differential equations (ODE) which simulate the behavior of two bodies, constrained to lie in a plane, moving under the influence of gravity, with one body much more massive than the other.
two_body_ode, an Octave code which sets up ordinary differential equations (ODE) which simulate the behavior of two bodies, constrained to lie in a plane, moving under the influence of gravity, with one body much more massive than the other.
two_body_ode, a Python code which sets up ordinary differential equations (ODE) which simulate the behavior of two bodies, constrained to lie in a plane, moving under the influence of gravity, with one body much more massive than the other.
two_fluid, a FreeFem++ code which simulates the incompressible flow of two liquids of different densities.
twod, a MATLAB code which contains functions useful for implementing the finite element method (FEM) over a 2D region, by Jeff Borggaard.
twod_plotc, a MATLAB code 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 code 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 code.
twod_to_vtu, a MATLAB code 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 code.
txt_to_dat, a Fortran77 code which demonstrates how to copy text data into a binary file.
ubvec, a C code which demonstrates how unsigned binary vectors, strings of 0 and 1, represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.
ubvec, a C++ code which demonstrates how unsigned binary vectors, strings of 0 and 1, represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.
ubvec, a Fortran90 code which demonstrates how unsigned binary vectors, strings of 0 and 1, represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.
ubvec, a MATLAB code which demonstrates how unsigned binary vectors, strings of 0 and 1, represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.
ubvec, a Python code which demonstrates how unsigned binary vectors, strings of 0 and 1, 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.
ulam_spiral, a MATLAB code which displays the integers as a spiral of grid cells, with the primes highlighted, so show that they tend to fall along diagonals, as discovered by Stanislaw Ulam.
ulam_spiral, an Octave code which displays the integers as a spiral of grid cells, with the primes highlighted, so show that they tend to fall along diagonals, as discovered by Stanislaw Ulam.
ulam_spiral, a Python code which displays the integers as a spiral of grid cells, with the primes highlighted, so show that they tend to fall along diagonals, as discovered by Stanislaw Ulam.
umfpack_test, a C code which calls umfpack(), which solves sparse linear systems, part of the SuiteSparse package, by Timothy Davis.
umfpack_test, a C++ code which calls umfpack(), which solves sparse linear systems, part of the SuiteSparse package, by Timothy Davis.
umfpack, a Fortran77 code which solve a sparse linear system, by Timothy Davis.
umfpack_test, a Fortran90 code which calls umfpack() to solve a sparse linear system.
umfpack_2.0, a Fortran77 code which solves unsymmetric sparse linear systems, this is an obsolete version, which has since been rewritten in C, by Timothy Davis, Iain Duff.
umlaut_remover, a Python code which replaces certain special characters in German text by English equivalents, based on work by John Berroa.
uncmin, a Fortran77 code which seeks the unconstrained minimization of a scalar function of several variables.
uncontrol, a C++ code which makes a copy of a text file which contains no control characters.
unicycle, a C code which considers permutations containing a single cycle, sometimes called cyclic permutations.
unicycle, a C++ code which considers permutations containing a single cycle, sometimes called cyclic permutations.
unicycle, a Fortran77 code which considers permutations containing a single cycle, sometimes called cyclic permutations.
unicycle, a Fortran90 code which considers permutations containing a single cycle, sometimes called cyclic permutations.
unicycle, a MATLAB code which considers permutations containing a single cycle, sometimes called cyclic permutations.
unicycle, a Python code which considers permutations containing a single cycle, sometimes called cyclic permutations.
uniform, a dataset directory which contains samples from uniform random number generators (RNG).
uniform, a C code which contains uniform random number generators (RNG) for several arithmetic types.
uniform, a C++ code which contains uniform random number generators (RNG) for several arithmetic types.
uniform, a Fortran77 code which contains uniform random number generators (RNG) for several arithmetic types.
uniform, a Fortran90 code which contains uniform random number generators (RNG) for several arithmetic types.
uniform, a Mathematica code which contains uniform random number generators (RNG) for several arithmetic types.
uniform, a MATLAB code which contains uniform random number generators (RNG) for several arithmetic types.
uniform, a Python code which contains uniform random number generators (RNG) for several arithmetic types.
uniform_dataset, a C++ code which generates a dataset of uniform pseudorandom values and writes them to a file.
uniform_dataset, a Fortran90 code which generates a dataset of multivariate uniform pseudorandom values and writes them to a file.
uniform_dataset, a MATLAB code which generates a dataset of uniform pseudorandom values and writes them to a file.
unstable_ode, a MATLAB code which sets up an unstable ordinary differential equation (ODE) which the backward Euler method incorrectly drives to zero.
unstable_ode, a Python code which sets up an unstable ordinary differential equation (ODE) which the backward Euler method incorrectly drives to zero.
upc, a C code which determines the check digit for a Uniform product Code (UPC), or reports whether a given UPC is valid.
upc, a C++ code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
upc, a Fortran90 code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
upc, a MATLAB code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
upc, an Octave code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
upc, a Python code which determines the check digit for a Uniform product Code (UPC) or reports whether a given UPC is valid.
urn_simulation, a MATLAB code which simulates the experiment of sampling K balls from an urn containing N balls of various colors.
urn_simulation, an Octave code which simulates the experiment of sampling K balls from an urn containing N balls of various colors.
urn_simulation, a Python code which simulates the experiment of sampling K balls from an urn containing N balls of various colors.
usa_box_plot, a MATLAB code which creates simplified maps of the USA in which each state appears as a box, and the placement of the boxes only roughly corresponds to the relative locations of states on an accurate map.
usa_box_plot, a Python code which creates simplified maps of the USA in which each state appears as a box, and the placement of the boxes only roughly corresponds to the relative locations of states on an accurate map.
usa_cvt_geo, a MATLAB code which creates a Centroidal Voronoi Tessellation (CVT) of the continental United States, based solely on geometric considerations.
usa_cvt_geo, an Octave code which creates a Centroidal Voronoi Tessellation (CVT) of the continental United States, based solely on geometric considerations.
usa_matrix, a MATLAB code which defines the adjacency matrix for US states, using a variety of matrix formats.
usa_matrix, an Octave code which defines the adjacency matrix for US states, using a variety of matrix formats.
usa_matrix, a Python code which defines the adjacency matrix for US states, using a variety of matrix formats.
uuid, examples which use UUID, which generates universally unique identifiers.
valgrind_test a C code which uses valgrind(), which detects memory leaks and other execution-time errors.
valgrind_test a C++ code which uses valgrind(), which detects memory leaks and other execution-time errors.
valgrind_test, examples which use valgrind(), which detects memory leaks and other execution-time errors.
valgrind_test a Fortran77 code which uses valgrind(), which detects memory leaks and other execution-time errors.
valgrind_test a Fortran90 code which uses valgrind(), which detects memory leaks and other execution-time errors.
van_der_corput, a dataset directory which contains examples of the one-dimensional van der Corput, for various bases;
van_der_corput, a C code which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence.
van_der_corput, a C++ code which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence.
van_der_corput, a Fortran90 code which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.
van_der_corput, a MATLAB code which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.
van_der_corput, an Octave code which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.
van_der_corput, a Python code which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.
van_der_corput_advanced, a C++ code 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 code 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 code 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++ code which creates a van der Corput Quasi Monte Carlo (QMC) sequence and writes it to a file.
van_der_corput_dataset, a Fortran90 code which creates a van der Corput Quasi Monte Carlo (QMC) sequence and writes it to a file.
van_der_corput_dataset, a MATLAB code which creates a van der Corput Quasi Monte Carlo (QMC) sequence and writes it to a file.
vandermonde, a C code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the vandermonde matrix.
vandermonde, a C++ code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the vandermonde matrix.
vandermonde, a Fortran77 code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the vandermonde matrix.
vandermonde, a Fortran90 code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the vandermonde matrix.
vandermonde, a MATLAB code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the vandermonde matrix.
vandermonde_approx_1d, a C code 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++ code 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 code 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 code 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 code 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, an Octave code 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 Python code 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 code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
vandermonde_approx_2d, a C++ code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
vandermonde_approx_2d, a Fortran77 code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
vandermonde_approx_2d, a Fortran90 code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
vandermonde_approx_2d, a MATLAB code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
vandermonde_approx_2d, an Octave code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
vandermonde_interp_1d, a C code which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_1d, a C++ code which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_1d, a Fortran77 code which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_1d, a Fortran90 code which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_1d, a MATLAB code which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_1d, an Octave code which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_1d, a Python code which finds a polynomial interpolant to data y(x) of a 1D argument, by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_2d, a C code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_2d, a C++ code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_2d, a Fortran77 code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_2d, a Fortran90 code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_2d, a MATLAB code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vandermonde_interp_2d, an Octave code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients, involving the Vandermonde matrix.
vanderpol_ode, a MATLAB code which sets up the van der Pol system of ordinary differential equations (ODE), for which a limit cycle exists.
vanderpol_ode, an Octave code which sets up the van der Pol system of ordinary differential equations (ODE), for which a limit cycle exists.
vanderpol_ode, a Python code which sets up the van der Pol system of ordinary differential equations (ODE), for which a limit cycle exists.
vanderpol_ode_period, a MATLAB code which sets up the ordinary differential equations (ODE) defining the van der Pol oscillator in order to estimate the period of the limit cycle.
vanderpol_ode_period, an Octave code which sets up the ordinary differential equations (ODE) defining the van der Pol oscillator in order to estimate the period of the limit cycle.
vanderpol_ode_period, a Python code which sets up the ordinary differential equations (ODE) defining the van der Pol oscillator in order to estimate the period of the limit cycle.
variomino, a MATLAB code which considers variominoes, which are polyominoes in which each square has been assigned a positive label or "variety", and the determination of tilings of a region using a specific set of variominoes.
variomino, an Octave code which considers variominoes, which are polyominoes in which each square has been assigned a positive label or "variety", and the determination of tilings of a region using a specific set of variominoes.
vec_io, a Fortran90 code which reads and writes vectors of fixed size, to and from a disk file, in any order;
vecnorm, an R code which computes the L2 norm of a vector.
vector, a MATLAB code which considers a problem involving vectors, which can be considered to belong to equivalence classes, for which an arbitrary collection of coefficients must be gathered, averaged, and then scattered again.
vector, an Octave code which considers a problem involving vectors, which can be considered to belong to equivalence classes, for which an arbitrary collection of coefficients must be gathered, averaged, and then scattered again.
vector, a Python code which considers a problem involving vectors, which can be considered to belong to equivalence classes, for which an arbitrary collection of coefficients must be gathered, averaged, and then scattered again.
vector_magnitude_grid, a MATLAB code 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 code which plots velocity fields and the velocity direction fields.
vector_read, a C++ code which reads, one line at a time, numeric data, storing it in a vector returned to the user;
vector_test, a FreeFem++ code which demonstrates how vectors can be defined and manipulated.
velocity_verlet, a MATLAB code which uses a version of the velocity Verlet method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
velocity_verlet, a Python code which uses a version of the velocity Verlet method to solve a second order ordinary differential equation (ODE) of the form y''=f(t,y).
verlet_simulation, a MATLAB code which demonstates the use of Verlet integration to simulate simple problems in dynamics, involving changes in position and velocity.
verlet_simulation, an Octave code which demonstates the use of Verlet integration to simulate simple problems in dynamics, involving changes in position and velocity.
vin, a MATLAB code which computes the check digit for a Vehicle Identification Number (VIN), or verifies that a given VIN is legitimate.
vin, an Octave code which computes the check digit for a Vehicle Identification Number (VIN), or verifies that a given VIN is legitimate.
vin, a Python code which computes the check digit for a Vehicle Identification Number (VIN), or verifies that a given VIN is legitimate.
visit, examples which use the visit() interactive graphics code.
voronoi_city, a MATLAB code 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 computate and use a Voronoi diagram.
voronoi_display, a MATLAB code which computes and displays the Voronoi diagram of a set of points.
voronoi_display, an Octave code which computes and displays the Voronoi diagram of a set of points.
voronoi_mountains, a MATLAB code which makes a mountain plot of a Voronoi diagram, that is, a surface plot of the distance from each point to its nearest Voronoi generator.
voronoi_mountains, an Octave code 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 code which is given points in the plane and determines the Voronoi adjacency structure, that is, which points share an edge of the Voronoi diagram.
voronoi_neighbors, an Octave code which is given 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 code which plots the Voronoi neighborhoods of points in the 2D unit square, using L1, L2, LInfinity or arbitrary LP norms;
voronoi_plot, a MATLAB code which plots the Voronoi neighborhoods of points using L1, L2, LInfinity or arbitrary LP norms;
voronoi_plot, an Octave code which plots the Voronoi neighborhoods of points using L1, L2, LInfinity or arbitrary LP norms;
voronoi_plot, a Python code which plots the Voronoi neighborhoods of points in the 2D unit square, using L1, L2, LInfinity or arbitrary LP norms;
voronoi_test, a MATLAB code which calls the built-in voronoi() function, which computes the Voronoi diagram of points.
voronoi_test, an Octave code which calls the built-in voronoi() function, which computes the Voronoi diagram of points.
voronoi_test, a Python code 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 code which estimates the volume of the Voronoi cells associated with N points in the M dimensional unit hypercube;
vpa_test, a MATLAB code which uses the MATLAB Variable Precision Arithmetic (VPA) feature of the Symbolic Math Toolbox to compute arbitrary precision quantities.
vpa_test, an Octave code which uses the Symbolic package 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 paraview() or visit();
vtk_io, a Fortran90 code 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 code;
vtu, 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 code;
vu, a data directory which contains examples of VU files, a file format used by the VU visualization code;
walker_sample, a C code which efficiently samples a discrete probability vector using Walker sampling.
walker_sample, a C++ code which efficiently samples a discrete probability vector using Walker sampling.
walker_sample, a Fortran90 code which efficiently samples a discrete probability vector using Walker sampling.
walker_sample, a MATLAB code which efficiently samples a discrete probability vector using Walker sampling.
walker_sample, an Octave code which efficiently samples a discrete probability vector using Walker sampling.
walker_sample, a Python code which efficiently samples a discrete probability vector using Walker sampling.
walsh_transform, a C code which implements the Walsh data transform.
walsh_transform, a C++ code which implements the Walsh data transform.
walsh_transform, a Fortran77 code which implements the Walsh data transform.
walsh_transform, a Fortran90 code which implements the Walsh data transform.
walsh_transform, a MATLAB code which implements the Walsh data transform.
walsh_transform, an Octave code which implements the Walsh data transform.
walsh_transform, a Python code which implements the Walsh data transform.
wathen_matrix, a C code 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_matrix, a C++ code 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_matrix, a Fortran77 code 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_matrix, a Fortran90 code 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_matrix, a MATLAB code 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_matrix, an Octave code 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_matrix, a Python code 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, an R code which solves the 1D wave equation using the finite difference method (FDM).
wave_mpi, a C code which uses the finite difference method (FDM) to estimate a solution to the wave equation, using the Message Passing Interface (MPI) for parallel execution.
wave_mpi, a C++ code which uses the finite difference method (FDM) to estimate a solution to the wave equation, using the Message Passing Interface (MPI) for parallel execution.
wave_mpi, a Fortran77 code which uses the finite difference method (FDM) to estimate a solution to the wave equation, using the Message Passing Interface (MPI) for parallel execution.
wave_mpi, a Fortran90 code which uses the finite difference method (FDM) to estimate a solution to the wave equation, using the Message Passing Interface (MPI) for parallel execution.
wave_pde, a MATLAB code which uses the finite difference method (FDM) in space, and the method of lines in time, to set up and solve the partial differential equations (PDE) known as the wave equations, utt = c uxx, in one spatial dimension and time.
wave_pde, an Octave code which uses the finite difference method (FDM) in space, and the method of lines in time, to set up and solve the partial differential equations (PDE) known as the wave equations, utt = c uxx, in one spatial dimension and time.
wave_regression_knn, a scikit-learn code which uses the k-nearest neighbor algorithm to form a regression predictor for the wave dataset.
wave_regression_ols, a scikit-learn code which uses the ordinary least squares algorithm to form a regression predictor for the wave dataset.
wavelet, a C code which does some simple calculations with wavelet transforms;
wavelet, a C++ code which does some simple calculations with wavelet transforms;
wavelet, a Fortran77 code which does some simple calculations with wavelet transforms;
wavelet, a Fortran90 code which does some simple calculations with wavelet transforms;
wavelet, a MATLAB code which does some simple calculations with wavelet transforms;
wavelet, an Octave code which does some simple calculations with wavelet transforms;
web_matrix, a MATLAB code which stores sample matrices describing a web page network. These matrices are typically very sparse, and the examples here are stored using the sparse triplet (ST) format. They can be used to demonstrate pagerank and other graph algorithms.
web_matrix, an Octave code which stores sample matrices describing a web page network. These matrices are typically very sparse, and the examples here are stored using the sparse triplet (ST) format. They can be used to demonstrate pagerank and other graph algorithms.
web_matrix, a Python code which stores sample matrices describing a web page network. These matrices are typically very sparse, and the examples here are stored using the sparse triplet (ST) format. They can be used to demonstrate pagerank and other graph algorithms.
wedge_exactness, a C code which computes the exactness of a quadrature rule over the interior of the unit wedge in 3D.
wedge_exactness, a C++ code which computes the exactness of a quadrature rule over the interior of the unit wedge in 3D.
wedge_exactness, a Fortran77 code which computes the exactness of a quadrature rule over the interior of the unit wedge in 3D.
wedge_exactness, a Fortran90 code which computes the exactness of a quadrature rule over the interior of the unit wedge in 3D.
wedge_exactness, a MATLAB code which computes the exactness of a quadrature rule over the interior of the unit wedge in 3D.
wedge_exactness, an Octave code which computes the exactness of a quadrature rule over the interior of the unit wedge in 3D.
wedge_exactness, a Python code which computes the exactness of a quadrature rule over the interior of the unit wedge in 3D.
wedge_felippa_rule, a C code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
wedge_felippa_rule, a C++ code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
wedge_felippa_rule, a Fortran77 code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
wedge_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
wedge_felippa_rule, a MATLAB code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
wedge_felippa_rule, an Octave code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
wedge_felippa_rule, a Python code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
wedge_grid, a C code which computes a grid of points over the interior of the unit wedge in 3D.
wedge_grid, a C++ code which computes a grid of points over the interior of the unit wedge in 3D.
wedge_grid, a Fortran77 code which computes a grid of points over the interior of the unit wedge in 3D.
wedge_grid, a Fortran90 code which computes a grid of points over the interior of the unit wedge in 3D.
wedge_grid, a MATLAB code which computes a grid of points over the interior of the unit wedge in 3D.
wedge_grid, an Octave code which computes a grid of points over the interior of the unit wedge in 3D.
wedge_grid, a Python code which computes a grid of points over the interior of the unit wedge in 3D.
wedge_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
wedge_integrals, a C++ code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
wedge_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
wedge_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
wedge_integrals, a MATLAB code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
wedge_integrals, an Octave code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
wedge_integrals, a Python code 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 code which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.
wedge_monte_carlo, a C++ code which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.
wedge_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.
wedge_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.
wedge_monte_carlo, a MATLAB code which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.
wedge_monte_carlo, an Octave code which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.
wedge_monte_carlo, a Python code which uses the Monte Carlo method to estimate integrals over the interior of the unit wedge in 3D.
weekday, a C code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, which was a Saturday.
weekday, a C++ code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, which was a Saturday.
weekday, a Fortran77 code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, which was a Saturday.
weekday, a Fortran90 code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, which was a Saturday.
weekday, a MATLAB code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, which was a Saturday.
weekday, an Octave code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, which was a Saturday.
weekday_zeller, a MATLAB code which uses the Zeller congruence to determine the day of the week corresponding to a given date, such as 13 July 1989, Gregorian calendar, which was a Thursday.
weekday_zeller, an Octave code which uses the Zeller congruence to determine the day of the week corresponding to a given date, such as 13 July 1989, Gregorian calendar, which was a Thursday.
weekday_zeller, a Python code which uses the Zeller congruence to determine the day of the week corresponding to a given date, such as 13 July 1989, Gregorian calendar, which was a Thursday.
welzl, a MATLAB code which computes the minimal bounding circle or sphere for a set of points, using algorithms by Welzl or Ritter, by Anton Semechko.
welzl, an Octave code which computes the minimal bounding circle or sphere for a set of points, using algorithms by Welzl or Ritter, by Anton Semechko.
whale, a MATLAB code which considers the whale tiling puzzle, a smaller version of the eternity puzzle. The whale puzzle specifies a region R composed of 288 30-60-90 triangles, and a set of 8 "tiles", each consisting of 36 30-60-90 triangles, and seeks an arrangement of the tiles that exactly covers the region.
whale_cplex_test a BASH code which calls cplex(), to read the LP file defining the whale tiling problem, solve the linear programming problem, and write the solution to a file.
whale_gurobi_test a BASH code which calls gurobi(), to read the LP file defining the whale tiling problem, solve the linear programming problem, and write the solution to a file.
width, a C++ code which returns the length and location of the longest line in a text file;
will_you_be_alive, a MATLAB code which carries out the probability simulations described in 'Will You Be Alive 10 Years From Now?', by Paul Nahin;
will_you_be_alive, an Octave code which carries out the probability simulations described in 'Will You Be Alive 10 Years From Now?', by Paul Nahin;
will_you_be_alive, a Python code which carries out the probability simulations described in 'Will You Be Alive 10 Years From Now?', by Paul Nahin;
wishart_matrix, a C code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
wishart_matrix, a C++ code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
wishart_matrix, a Fortran77 code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
wishart_matrix, a Fortran90 code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
wishart_matrix, a MATLAB code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
wishart_matrix, an Octave code 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 code which rearranges a list of words so that they have maximum overlap;
wrap, a C++ code which makes a copy of a text file in which no line is longer than a user-specified wrap length.
wrap2, a C++ code which wraps long lines in a text file, but which wraps some lines early, so as to avoid breaking words.
wtime, a C code which returns a reading of the wall clock time in seconds.
wtime, a C++ code which returns a reading of the wall clock time in seconds.
wtime, a Fortran77 code which returns a reading of the wall clock time in seconds.
wtime, a Fortran90 code which returns a reading of the wall clock time in seconds.
wtime, a MATLAB code which returns a reading of the wall clock time in seconds.
wtime, an Octave code which returns a reading of the wall clock time in seconds.
wtime, a Python code which returns a reading of the wall clock time in seconds.
x_window_test, a C code which demonstrates some simple uses of x_windows().
x_window_test, a C++ code which demonstrates some simple uses of x_windows()
x_window_display, examples which use x-windows() remotely.
xboids, a C code which simulates the behavior of a flying flock of animals, displaying the results using X Windows, by Conrad Parker.
xdr, a C code which allows a user to transfer data between computers which have different data storage conventions.
xerror, a Fortran77 code which reports and handles errors detected during execution.
xerror, a Fortran90 code which reports and handles errors detected during execution.
xising, a C code which simulates the variation in ferromagnetism in a material, displaying the results using X Windows, by Michael Creutz.
xlf_intrinsics, a Fortran90 code which demonstrates the use of intrinsic functions supplied by the IBM XLF compiler for Fortran90.
xls_io , an R code which illustrates how data can be shared between Microsoft EXCEL and R, using XLS and Comma Separated Value (CSV) files.
xml, a data directory which contains examples of XML files, a standard, general datafile format.
xml_to_fem, a Python code which reads an XML file created by dolfin() or fenics(), 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 code which reads an XML file and converts the data into a MATLAB struct.
xwaves, a C code 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 code which reads XY information defining points in 2D, and displays an image in a MATLAB graphics window;
xy_display_opengl, a C++ code which reads XY information defining points in 2D, and displays an image using OpenGL.
xy_io, a C++ code which reads and writes files in the XY, XYL and XYF formats.
xy_io, a Fortran90 code which reads and writes files in the XY, XYL and XYF formats.
xy_io, a MATLAB code 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 code which reads XYF information defining points and faces in 2D, and displays an image in a MATLAB graphics window.
xyf_display_opengl, a C++ code 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 code which reads XYL information defining points and lines in 2D, and displays an image in a MATLAB graphics window.
xyl_display_opengl, a C++ code 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 code which displays a 3D plot from a file of point coordinates.
xyz_display, an Octave code which displays a 3D plot from a file of point coordinates.
xyz_display_opengl, a C++ code which reads XYZ information defining points in 3D, and displays an image using OpenGL.
xyz_io, a C++ code which reads and writes files in the XYZ, XYZL, and XYZF formats.
xyz_io, a Fortran90 code which reads and writes files in the XYZ, XYZL, and XYZF formats.
xyz_io, a MATLAB code which reads and writes files in the XYZ, XYZL, and XYZF formats.
xyz_plot, a Fortran90 code which an interactive plotter.
xyz_to_pdb, a Fortran90 code 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 code which reads XYZF information defining points and faces in 3D, and displays an image.
xyzf_display_opengl, a C++ code 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 code which reads XYZL information defining points and lines in 3D, and displays an image in a MATLAB graphics window.
xyzl_display_opengl, a C++ code which reads XYZL information defining points and lines in 3D, and displays an image using OpenGL.
zero_brent, a C code which seeks a solution of a scalar nonlinear equation f(x) = 0, by Richard Brent.
zero_brent, a C++ code which seeks a solution of a scalar nonlinear equation f(x) = 0, by Richard Brent.
zero_brent, a Fortran77 code which seeks a solution of a scalar nonlinear equation f(x) = 0, by Richard Brent.
zero_brent, a Fortran90 code which seeks a solution of a scalar nonlinear equation f(x) = 0, by Richard Brent.
zero_brent, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x) = 0, by Richard Brent.
zero_brent, an Octave code which seeks a solution of a scalar nonlinear equation f(x) = 0, by Richard Brent.
zero_brent, a Python code which seeks a solution of a scalar nonlinear equation f(x) = 0, by Richard Brent.
zero_brent, an R code which finds a zero of a scalar function of a scalar variable, by Richard Brent.
zero_chandrupatla, a C code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
zero_chandrupatla, a C++ code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
zero_chandrupatla, a Fortran77 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
zero_chandrupatla, a Fortran90 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
zero_chandrupatla, a MATLAB code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
zero_chandrupatla, an Octave code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
zero_chandrupatla, a Python code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
zero_finder, a Fortran77 code which offers several algorithms for finding a root of a nonlinear equation.
zero_illinois, a Julia code which applies the Illinois method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
zero_itp, a C code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_itp, a C++ code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_itp, a Fortran77 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_itp, a Fortran90 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_itp, a Julia code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_itp, a MATLAB code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_itp, an Octave code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_itp, a Python code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
zero_laguerre, a C code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
zero_laguerre, a C++ code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
zero_laguerre, a Fortran77 code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
zero_laguerre, a Fortran90 code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
zero_laguerre, a MATLAB code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
zero_laguerre, an Octave code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
zero_laguerre, a Python code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
zero_muller, a C code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
zero_muller, a C++ code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
zero_muller, a Fortran77 code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
zero_muller, a Fortran90 code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
zero_muller, a MATLAB code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
zero_muller, an Octave code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
zero_muller, a Python code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
zero_rc, a C code which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.
zero_rc, a C++ code which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.
zero_rc, a Fortran77 code which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.
zero_rc, a Fortran90 code which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.
zero_rc, a MATLAB code which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.
zero_rc, an Octave code which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.
zero_rc, a Python code which seeks a solution of a scalar nonlinear equation f(x) = 0, using reverse communication (RC), by Richard Brent.
ziggurat, a C code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
ziggurat, a C++ code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
ziggurat, a Fortran77 code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
ziggurat, a Fortran90 code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
ziggurat, a MATLAB code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
ziggurat, an Octave code which implements uniform, normal and exponential random number generators (RNG) using the ziggurat method, by Marsaglia and Tsang.
ziggurat_inline, a C code which generates variates from the uniform, normal or exponential distributions, using an inline random number generator for very fast execution, by Marsaglia and Tsang.
ziggurat_inline, a C++ code which generates variates from the uniform, normal or exponential distributions, using an inline random number generator for very fast execution, by Marsaglia and Tsang.
ziggurat_openmp, a C code which uses ziggurat() as a random number generator (RNG) in an OpenMP parallel environment.
ziggurat_openmp, a C++ code which uses ziggurat() as a random number generator (RNG) in an OpenMP parallel environment.
ziggurat_openmp, a Fortran77 code which uses ziggurat() as a random number generator (RNG) in an OpenMP parallel environment.
ziggurat_openmp, a Fortran90 code which uses ziggurat() as a random number generator (RNG) in an OpenMP parallel environment.
zombie_ode, a MATLAB code which sets up a system of ordinary differential equations (ODE) for a generalized SIR infection model to simulate a zombie attack, developed by Philip Munz.
zombie_ode, an Octave code which sets up a system of ordinary differential equations (ODE) for a generalized SIR infection model to simulate a zombie attack, developed by Philip Munz.
zombie_ode, a Python code which sets up a system of ordinary differential equations (ODE) for a generalized SIR infection model to simulate a zombie attack, developed by Philip Munz.
zoomin, a Fortran90 code which implements many procedures for finding the zero of a scalar nonlinear function.
zoomin, a MATLAB code which implements many procedures for finding the zero of a scalar nonlinear function.
zoomin, an Octave code which implements many procedures for finding the zero of a scalar nonlinear function.