C Codes


  1. allocatable_array_test
  2. 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.
  3. alpert_rule_test
  4. 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 files that can be plotted with gnuplot(), based on a C code by Brian Tung.
  5. analemma_test
  6. 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.
  7. annulus_monte_carlo_test
  8. 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.
  9. annulus_rule_test
  10. args, a C code which reports the command line arguments with which it was invoked;
  11. args_test
  12. 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;
  13. asa005_test
  14. 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;
  15. asa006_test
  16. 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.
  17. asa007_test
  18. asa032, a C code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
  19. asa032_test
  20. 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.
  21. asa047_test
  22. 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.
  23. asa053_test
  24. asa058, a C code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
  25. asa058_test
  26. 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.
  27. asa063_test
  28. asa066, a C code which evaluates the Cumulative Density Function (CDF) of the normal probability distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.
  29. asa066_test
  30. 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.
  31. asa076_test
  32. 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.
  33. asa082_test
  34. 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.
  35. asa091_test
  36. asa103, a C code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
  37. asa103_test
  38. asa109, a C code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
  39. asa109_test
  40. 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.
  41. asa111_test
  42. 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.
  43. asa113_test
  44. asa121, a C code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
  45. asa121_test
  46. asa136, a C code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
  47. asa136_test
  48. asa144, a C code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
  49. asa144_test
  50. asa147, a C code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
  51. asa147_test
  52. 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.
  53. asa152_test
  54. asa159, a C code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
  55. asa159_test
  56. 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.
  57. asa172_test
  58. asa183, a C code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
  59. asa183_test
  60. 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.
  61. asa226_test
  62. asa239, a C code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
  63. asa239_test
  64. 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.
  65. asa241_test
  66. 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.
  67. asa243_test
  68. asa245, a C code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
  69. asa245_test
  70. asa266, a C code which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;
  71. asa266_test
  72. 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;
  73. asa299_test
  74. 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.
  75. asa310_test
  76. 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;
  77. asa314_test
  78. ascii_to_mri, a C code which restores MRI data to its original binary format, having been previously converted to an ASCII text file.
  79. ascii_to_mri_test
  80. atbash, a C code which applies the Atbash substitution cipher to a string of text.
  81. atbash_test
  82. backtrack_binary_rc, a C code which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).
  83. backtrack_binary_rc_test
  84. 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.
  85. backward_euler_test
  86. ball_grid, a C code which computes a grid of points over the interior of the unit ball in 3D.
  87. ball_grid_test
  88. 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.
  89. ball_integrals_test
  90. 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;
  91. ball_monte_carlo_test
  92. 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.
  93. bank_test
  94. barycentric_interp_1d, a C code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.
  95. barycentric_interp_1d_test
  96. 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.
  97. bdf2_test
  98. 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.
  99. bellman_ford_test
  100. bernstein_polynomial, a C code which evaluates the Bernstein polynomials;
  101. bernstein_polynomial_test
  102. besselj, a C code which evaluates Bessel J functions of noninteger order;
  103. besselj_test
  104. beta_nc, a C code which evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
  105. beta_nc_test
  106. 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.
  107. bisection_test
  108. 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].
  109. bisection_integer_test
  110. 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).
  111. bisection_rc_test
  112. black_scholes, a C code which implements some simple approaches to the Black-Scholes option valuation theory, by Desmond Higham.
  113. black_scholes_test
  114. blas0, a C code which contains auxilliary functions for the Basic Linear Algebra Subprograms (BLAS).
  115. blas0_test
  116. blas1_d, a C code of the Level 1 Basic Linear Algebra Subprograms (BLAS), using double precision real arithmetic;
  117. blas1_d_test
  118. blas1_z, a C code of the Level 1 Basic Linear Algebra Subprograms (BLAS), using double precision complex arithmetic;
  119. blas1_z_test
  120. blas2_d, a C code which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), using double precision real arithmetic.
  121. blas2_d_test
  122. blas3_d, a C code which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS) for matrix-matrix operations, using double precision real arithmetic.
  123. blas3_d_test
  124. blend, a C code which carries out 1D/2D/3D blending interpolation;
  125. blend_test
  126. box_behnken, a C code which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;
  127. box_behnken_test
  128. brownian_motion_simulation, a C code which simulates Brownian motion in an M-dimensional region, creating graphics files for processing by gnuplot().
  129. brownian_motion_simulation_test
  130. burgers_solution, a C code which evaluates exact solutions of the time-dependent 1D viscous Burgers equation.
  131. burgers_solution_test
  132. bvec, a C code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
  133. bvec_test
  134. c_test, a C code which illustrates some of the features of the C programming language.
  135. c_arrays_test
  136. c_calls_f77, a C code which illustrates how a C program can call a FORTRAN77 subroutine.
  137. c_calls_f90, a C code which illustrates how a C program can call a FORTRAN90 subroutine.
  138. c_files_test, a C code which illustrates the use of files.
  139. c_intrinsics_test, a C code which illustrates the use of intrinsic functions supplied by the C language.
  140. c_mistake, a C code which illustrates some simple but devious programming mistakes in C.
  141. c_monte_carlo, a C code which uses Monte Carlo sampling to estimate areas and integrals.
  142. c_operators_test
  143. c_random_test
  144. 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.
  145. c8_complex_lib, a C code which defines a double precision complex (C8) variable as a structure, and implements certain corresponding elementary functions.
  146. c8_complex_lib_test
  147. c8lib, a C code which implements certain elementary functions for double precision complex (C8) variables using the C99 standard "double complex" datatype.
  148. c8lib_test
  149. c8poly, a C code which operates on complex polynomials.
  150. c8poly_test
  151. caesar, a C code which applies a Caesar Shift Cipher to a string of text.
  152. caesar_test
  153. calpak, a C code which makes various calendar calculations;
  154. calpak_test
  155. cauchy_principal_value, a C code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
  156. cauchy_principal_value_test
  157. cblas_test, a C code which calls cblas(), which implements the Basic Linear Algebra Subprograms.
  158. ccn_rule, a C code which defines a one of a sequence of Clenshaw Curtis Nested (CCN) quadrature rules of any order.
  159. ccn_rule_test
  160. ccs_io, a C code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
  161. ccs_io_test
  162. ccs_to_st, a C code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
  163. ccs_to_st_test
  164. 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.
  165. cdflib_test
  166. 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.
  167. cell_test
  168. cellular_automaton, a C code which demonstrates the 1D Cellular Automaton known as rule #30.
  169. cellular_automaton_test
  170. 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 in which the matrix A is positive definite, only real, positive eigenvalues and symmetric.
  171. cg_test
  172. cg_rc, a C code which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).
  173. cg_rc_test
  174. change_dynamic, a C code which uses dynamic programming to solve the change making problem, in which a given sum is to be formed using coins of various denominations.
  175. change_dynamic_test
  176. chebyshev, a C code which computes the Chebyshev interpolant or approximant to a given function over an interval.
  177. chebyshev_test
  178. chebyshev_interp_1d, a C code which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).
  179. chebyshev_interp_1d_test
  180. 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.
  181. chebyshev_polynomial_test
  182. chebyshev_series, a C code which evaluates a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.
  183. chebyshev_series_test
  184. chrpak, a C code which manipulates characters and strings;
  185. chrpak_test
  186. circle_arc_grid, a C code which computes grid points along a circular arc.
  187. circle_arc_grid_test
  188. 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.
  189. circle_integrals_test
  190. circle_monte_carlo, a C code which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
  191. circle_monte_carlo_test
  192. circle_rule, a C code which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).
  193. circle_rule_test
  194. 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 images using gnuplot().
  195. circle_segment_test
  196. clapack_test
  197. clausen, a C code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
  198. clausen_test
  199. clenshaw_curtis_rule, a C code which implements a Clenshaw Curtis quadrature rule;
  200. clenshaw_curtis_rule_test
  201. cnoise, a C code which generates samples of noise obeying a 1/f^alpha power law, by Miroslav Stoyanov.
  202. cnoise_test
  203. collatz_recursive, a C code which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
  204. collatz_recursive_test
  205. colored_noise, a C code which generates samples of noise obeying a 1/f^alpha power law.
  206. colored_noise_test
  207. combo, a C code which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
  208. combo_test
  209. 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.
  210. communicator_mpi_test
  211. 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.
  212. compass_search_test
  213. complex_numbers_test, a C code which demonstrates the declaration and use of complex numbers.
  214. 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.
  215. components_test
  216. condition, a C code which implements methods of computing or estimating the condition number of a matrix.
  217. condition_test
  218. continued_fraction, a C code which implements some simple algorithms for dealing with simple and generalized continued fractions.
  219. continued_fraction_test
  220. cordic, a C code which computes a few special functions using the CORDIC algorithm.
  221. cordic_test
  222. correlation, a C code which contains statistical correlation functions.
  223. correlation_test
  224. cosine_transform, a C code which demonstrates some simple properties of the discrete cosine transform (DCT).
  225. cosine_transform_test
  226. csparse, a C code which carries out the direct solution of sparse linear systems, by Timothy Davis.
  227. csparse_test
  228. 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.
  229. cube_arbq_rule_test
  230. cube_exactness, a C code which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.
  231. cube_exactness_test
  232. cube_felippa_rule, a C code which returns a Felippa quadrature rules for approximating integrals over the interior of a cube in 3D.
  233. cube_felippa_rule_test
  234. cube_grid, a C code which computes a grid of points over the interior of a cube in 3D.
  235. cube_grid_test
  236. 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.
  237. cube_integrals_test
  238. 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.
  239. cube_monte_carlo_test
  240. 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.
  241. cuda_loop_test
  242. 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.
  243. cycle_brent_test
  244. 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.
  245. cycle_floyd_test
  246. cyclic_reduction, a C code which solves a tridiagonal linear system using cyclic reduction;
  247. cyclic_reduction_test
  248. differ, determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.
  249. differ_test
  250. dijkstra, a C code which implements a simple version of the Dijkstra minimum distance algorithm for graphs.
  251. dijkstra_test
  252. dijkstra_openmp, a C code which uses OpenMP to parallelize a simple example of the Dijkstra minimum distance algorithm for graphs.
  253. dijkstra_openmp_test
  254. 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.
  255. discrete_pdf_sample_2d_test
  256. disk_grid, a C code which computes grid points within the interior of a disk of user specified radius and center in 2D, using gnuplot() to create an image of the grid.
  257. disk_grid_test
  258. disk_monte_carlo, a C code which applies a Monte Carlo method to estimate integrals of a function over the interior of the general disk in 2D;
  259. disk_monte_carlo_test
  260. disk_rule, a C code which computes quadrature rules for the general disk in 2D.
  261. disk_rule_test
  262. disk01_integrals, a C code which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
  263. disk01_integrals_test
  264. disk01_monte_carlo, a C code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
  265. disk01_monte_carlo_test
  266. disk01_positive_monte_carlo, a C code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit positive disk in 2D;
  267. disk01_positive_monte_carlo_test
  268. disk01_rule, a C code which computes quadrature rules for the unit disk in 2D, that is, the interior of the circle of radius 1 and center (0,0).
  269. disk01_rule_test
  270. dislin_test, a C code which uses dislin() to create a variety of graphics.
  271. divdif, a C code which uses divided differences to compute the polynomial interpolant to a given set of data.
  272. divdif_test
  273. 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.
  274. doomsday_test
  275. 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.
  276. dream_test
  277. duel_simulation, a C code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  278. duel_simulation_test
  279. edge, a C code which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities, and using gnuplot() to display the curves or surfaces.
  280. edge_test
  281. ellipse, a C code which carries out geometric calculations for ellipses, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
  282. ellipse_test
  283. ellipse_grid, a C code which computes grid points over the interior of an ellipse in 2D.
  284. ellipse_grid_test
  285. 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.
  286. ellipse_monte_carlo_test
  287. ellipsoid, a C code which carries out geometric calculations for ellipsoids, including area, random sampling, conversion between standard and quadratic forms.
  288. ellipsoid_test
  289. ellipsoid_grid, a C code which computes a grid of points over the interior of an ellipsoid in 3D.
  290. ellipsoid_grid_test
  291. 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.
  292. ellipsoid_monte_carlo_test
  293. elliptic_integral, a C code which evaluates complete elliptic integrals of first, second and third kind, using the Carlson elliptic integral functions.
  294. elliptic_integral_test
  295. euler, a C code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
  296. euler_test
  297. exactness, a C code which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).
  298. exactness_test
  299. f77split, a C code which splits a file containing multiple FORTRAN77 routines into separate files;
  300. f77split_test
  301. f90split, a C code which splits a file containing multiple FORTRAN90 routines into separate files;
  302. f90split_test
  303. fair_dice_simulation, a C code which simulates N tosses of 2 dice, making a histogram of the results.
  304. fair_dice_simulation_test
  305. fd_predator_prey, a C code which solves a pair of predator prey ordinary differential equations (ODE) using a finite difference method (FDM) approximation.
  306. fd_predator_prey_test
  307. 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().
  308. fd1d_advection_diffusion_steady_test
  309. 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().
  310. fd1d_advection_ftcs_test
  311. 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 approximate the time derivative, writing graphics files for processing by gnuplot().
  312. fd1d_advection_lax_test
  313. 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 approximate the time derivative, writing graphics files for processing by gnuplot().
  314. fd1d_advection_lax_wendroff_test
  315. fd1d_burgers_lax, a C code which applies the finite difference method (FDM) and the Lax Wendroff method to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  316. fd1d_burgers_lax_test
  317. fd1d_burgers_leap, a C code which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  318. fd1d_burgers_leap_test
  319. fd1d_bvp, a C code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
  320. fd1d_bvp_test
  321. fd1d_heat_explicit, a C code which implements a finite difference method (FDM), explicit in time, of the time dependent 1D heat equation;
  322. fd1d_heat_explicit_test
  323. fd1d_heat_implicit, a C code which implements a finite difference method (FDM), implicit in time, of the time dependent 1D heat equation;
  324. fd1d_heat_implicit_test
  325. fd1d_heat_steady, a C code which implements a finite difference method (FDM) for the steady time-independent 1D heat equation;
  326. fd1d_heat_steady_test
  327. fd1d_wave, a C code which applies the finite difference method (FDM) to solve the time-dependent wave equation in one spatial dimension.
  328. fd1d_wave_test
  329. fd2d_heat_steady, a C code which implements a finite difference method (FDM) for the steady time-independent 2D heat equation;
  330. fd2d_heat_steady_test
  331. fem_basis, a C code which defines and evaluates finite element method (FEM) basis functions for any degree in an M-dimensional simplex: 1D interval, 2D triangle, 3D tetrahedron, and higher dimensional generalizations.
  332. fem_basis_test
  333. fem_io, a C code which reads or writes FEM files, which describe the nodes, elements, and function values associated with a finite element method (FEM) model;
  334. fem_io_test
  335. fem_to_gmsh, a C code which reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a gmsh() mesh file.
  336. fem_to_gmsh_test
  337. 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 the triangle() program of Jonathan Shewchuk.
  338. fem_to_triangle_test
  339. fem_to_xml, reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding XML file for input to DOLFIN or FENICS.
  340. fem_to_xml_test
  341. fem1d, a C code which applies the finite element method (FEM), using piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  342. fem1d_test
  343. fem1d_adaptive, a C code which uses an adaptive mesh when applying the finite element method (FEM), with piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  344. fem1d_adaptive_test
  345. fem1d_bvp_linear, a C code which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  346. fem1d_bvp_linear_test
  347. fem1d_bvp_quadratic, a C code which applies the finite element method (FEM), with piecewise quadratic elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  348. fem1d_bvp_quadratic_test
  349. fem1d_heat_steady, a C code which implements the finite element method (FEM) for the steady (time independent) 1D heat equation;
  350. fem1d_heat_steady_test
  351. 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.
  352. fem1d_lagrange_test
  353. fem1d_nonlinear, a C code which applies the finite element method (FEM), with piecewise linear basis functions, to a nonlinear two point boundary value problem (BVP) in 1D;
  354. fem1d_nonlinear_test
  355. fem1d_pack, a C code which contains utilities for 1D finite element method (FEM) calculations.
  356. fem1d_pack_test
  357. fem1d_pmethod, a C code which applies the p-method version of the finite element method (FEM) to a linear two point boundary value problem (BVP) in 1D;
  358. fem1d_pmethod_test
  359. fem1d_project, a C code which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element method (FEM) solution from one mesh to another.
  360. fem1d_project_test
  361. fem1d_sample, a C code which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.
  362. fem1d_sample_tesst
  363. fem2d_bvp_linear, a C code which applies the finite element method (FEM), with piecewise linear elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  364. fem2d_bvp_linear_test
  365. fem2d_bvp_quadratic, a C code which applies the finite element method (FEM), with piecewise quadratic elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  366. fem2d_bvp_quadratic_test
  367. 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.
  368. fem2d_bvp_serene_test
  369. fem2d_pack, a C code which implements various 2D finite element method (FEM) calculations;
  370. fem2d_pack_test
  371. fem2d_poisson_rectangle, a C code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.
  372. fem2d_poisson_rectangle_test
  373. 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 triangular elements.
  374. fem2d_poisson_rectangle_linear_test
  375. fern_opengl, a C code which uses OpenGL to display the Barnsley fractal fern.
  376. 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.
  377. feynman_kac_1d_test
  378. 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.
  379. feynman_kac_2d_test
  380. 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.
  381. feynman_kac_3d_test
  382. fft_openmp, a C code which demonstrates the computation of a Fast Fourier Transform (FFT) in parallel, using OpenMP.
  383. fft_openmp_test
  384. fft_serial, a C code which computes a Fast Fourier Transform (FFT), and is intended as a starting point for implementing an OpenMP parallel version.
  385. fft_serial_test
  386. fftpack4, a C code which implements the Fast Fourier Transform (FFT) by Paul Swarztrauber and Dick Valent, translated by Andrew Fernandes;
  387. fftpack4_test
  388. fftw_test
  389. file_name_sequence, a C code which generates a sequence of filenames, which can be useful when generating a sequence of still snapshots to be animated later.
  390. file_name_sequence_test
  391. files_multiple, a C code which opens multiple output files at one time, and write data to any one specific file it chooses.
  392. files_multiple_test
  393. filon_rule, a C code which uses Filon's method to approximate integrals which include an oscillatory factor of sin(k*x) or cos(k*x).
  394. filon_rule_test
  395. filum, a C code which performs various operations with files;
  396. filum_test
  397. fire_simulation, a C code which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.
  398. fire_simulation_test
  399. 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.
  400. floyd, a C code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  401. floyd_test
  402. fn, a C code which evaluates elementary and special functions using Chebyshev polynomials; functions include Airy, Bessel I, J, K and Y, beta, confluent hypergeometric, error, gamma, log gamma, Pochhammer, Spence; integrals include hyperbolic cosine, cosine, Dawson, exponential, logarithmic, hyperbolic sine, sine; by Wayne Fullerton.
  403. fn_test
  404. football_dynamic, a C code which uses dynamic programming to count the ways of achieving a given score in football.
  405. football_dynamic_test
  406. freefem_msh_io, a C code which reads and writes files used by the FreeFem++ finite element program to store mesh information.
  407. freefem_msh_io_test
  408. 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.
  409. fsolve_test
  410. functions_openmp, a C code which demonstrates a few of the OpenMP functions.
  411. functions_openmp_test
  412. gauss_seidel, a C code which implements the Gauss-Seidel iteration for linear systems.
  413. gauss_seidel_test
  414. gcc_intrinsics_test, a C code which demonstrates the intrinsic functions made available by the Gnu gcc compiler for C.
  415. gegenbauer_cc, a C code which computes the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
  416. gegenbauer_cc_test
  417. gegenbauer_polynomial, a C code which evaluates the Gegenbauer polynomial and associated functions.
  418. gegenbauer_polynomial_test
  419. 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.
  420. geometry_test
  421. geompack, a C code which computes Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.
  422. geompack_test
  423. gl_fast_rule, a C code which carries out the rapid computation of the Kth value and weight of an N point Gauss-Legendre quadrature rule, by Ignace Bogaert.
  424. gl_fast_rule_test
  425. glomin, a C code which finds a global minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  426. glomin_test
  427. glomin_nogoto, a C code which finds a global minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent. This version avoids the use of the goto statement, and the alternative duplication of some statements.
  428. glomin_nogoto_test
  429. 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).
  430. gmsh_io_test
  431. 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.
  432. gmsh_to_fem_test
  433. gnuplot_test, a C code which uses gnuplot() to create various kinds of plots.
  434. gnuplot_i, a C code which allows an executing C, C++ or Fortran program to interact with gnuplot(), by Nicholas Devillard.
  435. gnuplot_i_test
  436. gprof_test, a C code which uses the gprof() profiling tool.
  437. graphics_dislin_test, a C code which creates various kinds of plots using dislin().
  438. graphics_gnuplot_test, a C code which creates plots using gnuplot().
  439. gsl_test, a C code which tests the Gnu Scientific Library gsl().
  440. haar_transform, a C code which computes the Haar transform of 1d or 2d data.
  441. haar_transform_test
  442. halton, a C code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
  443. halton_test
  444. hammersley, a C code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
  445. hammersley_test
  446. hankel_cholesky, a C code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) matrix H so that H = R' * R.
  447. hankel_cholesky_test
  448. hankel_spd, a C code which computes a lower triangular matrix L which is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
  449. hankel_spd_test
  450. hdf5_test, a C code which demonstrates the use of the HDF5 data format.
  451. heat_mpi, a C code which demonstrates the use of the Message Passing Interface (MPI), by solving the 1D time dependent heat equation.
  452. heat_mpi_test
  453. heated_plate, a C code which solves the steady state heat equation in a 2D rectangular region, and is intended as a starting point for implementing an OpenMP parallel version.
  454. heated_plate_test
  455. 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.
  456. heated_plate_openmp_test
  457. hello, a C code which prints out "Hello, world!".
  458. hello_test
  459. hello_mpi, a C code which prints out "Hello, world!" using MPI for parallel programming.
  460. hello_mpi_test
  461. hello_openmp, a C code which prints out "Hello, world!" within the OpenMP parallel programming environment.
  462. hello_openmp_test
  463. hermite_cubic, a C code which computes the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolant made up of piecewise Hermite cubic polynomials.
  464. hermite_cubic_test
  465. hermite_exactness, a C code which tests the polynomial exactness of Gauss-Hermite quadrature rules for approximating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
  466. hermite_exactness_test
  467. hermite_integrands, a C code which defines test integrands for Hermite integrals with density exp(-x^2) over the interval (-oo,+oo).
  468. hermite_integrands_test
  469. hermite_interpolant, a C code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
  470. hermite_interpolant_test
  471. hermite_polynomial, a C code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
  472. hermite_polynomial_test
  473. hermite_product_polynomial, a C code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
  474. hermite_product_polynomial_test
  475. hermite_rule, a C code which computes and writes out a Gauss-Hermite quadrature rule for approximating the integral of a function with density exp(-x^2) over the interval (-oo,+oo).
  476. hermite_rule_test
  477. hexahedron_jaskowiec_rule, a C code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
  478. hexahedron_jaskowiec_rule_test
  479. hexahedron_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
  480. hexahedron_witherden_rule_test
  481. 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; the code uses gnuplot() to create a graph of the results.
  482. high_card_simulation_test
  483. hilbert_curve, a C code which computes the sequence of discrete Hilbert curves whose limit is a space-filling curve.
  484. hilbert_curve_test
  485. histogram_data_2d_sample, a C code which demonstrates how to construct a Probability Density Function (PDF) from sample data over a 2D domain, and then to use that PDF to create new samples.
  486. histogram_data_2d_sample_test
  487. humps, a C code which evaluates the humps function, its first and second derivatives and its antiderivative.
  488. humps_test
  489. 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().
  490. hyper_2f1_test
  491. 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.
  492. hyperball_integrals_test
  493. 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;
  494. hyperball_monte_carlo_test
  495. hyperball_volume_monte_carlo, a C code which applies a Monte Carlo procedure to estimate the volume of the unit ball in M dimensions;
  496. hyperball_volume_monte_carlo_test
  497. hypercube_exactness, a C code which tests the polynomial exactness of a quadrature rule over the interior of the unit hypercube in M dimensions.
  498. hypercube_exactness_test
  499. hypercube_grid, a C code which computes a grid of points over the interior of a hypercube in M dimensions.
  500. hypercube_grid_test
  501. 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.
  502. hypercube_integrals_test
  503. 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.
  504. hypercube_monte_carlo_test
  505. 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.
  506. hypersphere_test
  507. 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.
  508. hypersphere_integrals_test
  509. 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;
  510. hypersphere_monte_carlo_test
  511. i4lib, a C code which contains many utility routines, using single precision integer (I4) arithmetic.
  512. i4lib_test
  513. i8lib, a C code which contains many utility routines, using double precision integer (I8) arithmetic.
  514. i8lib_test
  515. ice_io, a C code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
  516. ice_io_test
  517. ice_to_medit, a C code which reads a netcdf() file containing an ICE dataset and rewrites the information as a medit() MESH file.
  518. ice_to_medit_test
  519. image_denoise, a C code which applies simple filtering operations to a noisy image.
  520. image_denoise_test
  521. image_denoise_openmp, a C code which applies simple filtering operations to a noisy image, carrying out the operation in parallel using OpenMP.
  522. image_denoise_openmp_test
  523. image_edge, a C code which demonstrates a simple procedure for edge detection in images.
  524. image_edge_test
  525. index, a C code which converts a multidimensional vector index to a one-dimensional vector index; it can handle zero and one based indexing schemes, as well as column major and row major conventions.
  526. index_test
  527. interp, a C code which parameterizes or interpolates data;
  528. interp_test
  529. 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.
  530. is_test
  531. is_prime, a C code which implements various versions of the sieve of Eratosthenes to determine whether a given integer is prime.
  532. is_prime_test
  533. isbn, a C code which determines the check digit for an International Standard Book Number or report whether a given ISBN is valid.
  534. isbn_test
  535. ising_2d_simulation, a C code which simulates evolution of a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors, using gnuplot() to display the initial and final configurations.
  536. ising_2d_simulation_test
  537. jacobi, a C code which implements the Jacobi iteration for the iterative solution of linear systems.
  538. jacobi_test
  539. jacobi_eigenvalue, a C code which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.
  540. jacobi_eigenvalue_test
  541. jacobi_openmp, a C code which uses OpenMP to parallelize a Jacobi iteration solving A*x=b.
  542. jacobi_openmp_test
  543. jacobi_polynomial, a C code which evaluates the Jacobi polynomial and associated functions.
  544. jacobi_polynomial_test
  545. julia_set, a C code which generates a TGA or TARGA graphics file of a Julia set.
  546. julia_set_test
  547. julia_set_openmp, a C code which produces an image of a Julia set, using OpenMP to carry out the computation in parallel.
  548. julia_set_openmp_test
  549. kmeans, a C code which handles the K-Means problem, which organizes a set of N points in M dimensions into K clusters;
  550. kmeans_test
  551. knapsack_01_brute, a C code which uses brute force to solve small versions of the 0/1 knapsack problem;
  552. knapsack_01_brute_test
  553. kronrod_rule, a C code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  554. kronrod_rule_test
  555. lagrange_approx_1d, a C code which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).
  556. lagrange_approx_1d_test
  557. lagrange_interp_1d, a C code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on a 1D argument, so that p(x(i)) = y(i).
  558. lagrange_interp_1d_test
  559. lagrange_interp_2d, a C code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).
  560. lagrange_interp_2d_test
  561. lagrange_interp_nd, a C code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on a multidimensional argument evaluated on a product grid, so that p(x(i)) = z(i).
  562. lagrange_interp_nd_test
  563. laguerre_exactness, a C code which tests the polynomial exactness of Gauss-Laguerre quadrature rules for integrating functions with density exp(-x) over [0,+oo).
  564. laguerre_exactness_test
  565. laguerre_integrands, a C code which implements test problems for approximate integration over a semi-infinite interval, often carried out using Gauss-Laguerre quadrature.
  566. laguerre_integrands_test
  567. laguerre_polynomial, a C code which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
  568. laguerre_polynomial_test
  569. laguerre_rule, a C code which computes and writes out a Gauss-Laguerre quadrature rule for approximating the integral of a function with density exp(-x) over the interval [0,+oo).
  570. laguerre_rule_test
  571. lambert_w, a C code which evaluates Lambert's W function.
  572. lambert_w_test
  573. laplace_mpi, a C code which solves the Laplace equation on a rectangle, using the Message Passing Interface (MPI) for parallel execution.
  574. laplace_mpi_test
  575. 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 a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
  576. laplacian_test
  577. latin_cover, a C code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
  578. latin_cover_test
  579. latin_random, a C code which computes Latin Random Squares of N points in M dimensions;
  580. latin_random_test
  581. latinize, a C code which adjusts N points in M dimensions to form a Latin Hypercube;
  582. latinize_test
  583. lebesgue, a C code which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation.
  584. lebesgue_test
  585. legendre_exactness, a C code which tests the monomial exactness of quadrature rules for the Legendre problem of integrating a function with density 1 over the interval [-1,+1].
  586. legendre_exactness_test
  587. legendre_fast_rule, a C code which uses a fast, order N, algorithm to compute a Gauss-Legendre quadrature rule of given order to integrate a function with density 1 over the interval [-1,+1].
  588. legendre_fast_rule_test
  589. legendre_polynomial, a C code which evaluates the Legendre polynomial and associated functions.
  590. legendre_polynomial_test
  591. legendre_product_polynomial, a C code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
  592. legendre_product_polynomial_test
  593. legendre_rule, a C code which writes out a Gauss-Legendre quadrature rule of given order to integrate a function with density 1 over the interval [-1,+1].
  594. legendre_rule_test
  595. legendre_shifted_polynomial, a C code which evaluates the shifted Legendre polynomial, with the domain [0,1].
  596. legendre_shifted_polynomial_test
  597. levenshtein_distance, a C code which returns the Levenshtein distance between two strings.
  598. levenshtein_distance_test
  599. levenshtein_matrix, a C code which returns the Levenshtein distance matrix defined by two strings.
  600. levenshtein_matrix_test
  601. life_opengl, a C code which uses OpenGL to display the evolution of John Conway's Game of life, by Simon Green.
  602. 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.
  603. life_serial_test
  604. 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.
  605. line_cvt_lloyd, a C code which applies the Lloyd iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
  606. line_cvt_lloyd_test
  607. 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.
  608. line_fekete_rule_test
  609. line_felippa_rule, a C code which returns a Felippa quadrature rules for approximating integrals over the interior of a line segment in 1D.
  610. line_felippa_rule_test
  611. line_grid, a C code which computes a grid of points over the interior of a line segment in 1D.
  612. line_grid_test
  613. line_integrals, a C code which returns the exact value of the integral of any monomial over the length of the unit line in 1D.
  614. line_integrals_test
  615. 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 in 1D.
  616. line_monte_carlo_test
  617. 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.
  618. line_ncc_rule_test
  619. 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.
  620. line_nco_rule_test
  621. linear_algebra, C codes which carry out various linear algebra operations for matrices stored in a variety of formats.
  622. linpack_bench, a C code which is a version of the LINPACK benchmark;
  623. linpack_bench_test
  624. linpack_d, a C code which factors matrices in a variety of formats, and solving the associated linear systems, using double precision real arithmetic; it includes a function to compute the singular value decomposition (SVD) of a rectangular matrix. The original version of this code is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
  625. linpack_d_test
  626. 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 error to a set of N data points.
  627. llsq_test
  628. lobatto_polynomial, a C code which evaluates Lobatto polynomials similar to Legendre polynomials except that they are 0 at both endpoints.
  629. lobatto_polynomial_test
  630. 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.
  631. local_min_test
  632. 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.
  633. local_min_rc_test
  634. log_normal, a C code which returns quantities related to the log normal Probability Distribution Function (PDF).
  635. log_normal_test
  636. log_normal_truncated_ab, a C code which returns quantities related to the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
  637. log_normal_truncated_ab_test
  638. lorenz_ode, a C code which approximates solutions to the Lorenz system of ordinary differential equations (ODE), creating output files that can be displayed by gnuplot().
  639. lorenz_ode_test
  640. luhn, a C code which computes the Luhn check digit for a string, or verify a string, as used for error detection in credit card numbers.
  641. luhn_test
  642. machar, a C code which dynamically computes the values of various machine characteristic constants, by William Cody;
  643. machar_test
  644. machine, a C code which returns tabulated values of the constants associated with computer arithmetic;
  645. machine_test
  646. makefile_test, a C code which shows how a makefile can be used to manage the compilation and loading of a C code.
  647. mandelbrot, a C code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot set;
  648. mandelbrot_test
  649. mandelbrot_ascii, a C code which generates an ASCII text image of the Mandelbrot set, using just two lines of C code.
  650. mandelbrot_ascii_test
  651. mandelbrot_openmp, a C code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution;
  652. mandelbrot_openmp_test
  653. mandelbrot_ppm, a C code which generates a binary Portable Pixel Map (PPM) image of the Mandelbrot set, by Eric Weeks.
  654. mandelbrot_ppm_test
  655. mario, a C code which creates a sort of "needlepoint" image of Mario, as an array of colored squares.
  656. mario_test
  657. matmul, a C code which carries out a matrix multiplication benchmark;
  658. matmul_test
  659. matrix_chain, a C code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming..
  660. matrix_chain_test
  661. matrix_exponential, a C code which demonstrates some simple approaches to the problem of computing the exponential of a matrix.
  662. matrix_exponential_test
  663. md, a C code which carries out a molecular dynamics (MD) simulation, and is intended as a starting point for implementing an OpenMP parallel version.
  664. md_test
  665. md_openmp, a C code which carries out a molecular dynamics (MD) simulation in parallel using OpenMP.
  666. md_openmp_test
  667. medit_mesh_io, a C code which reads or writes medit() MESH files defining a finite element mesh.
  668. medit_mesh_io_test
  669. 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.
  670. medit_to_fem_test
  671. medit_to_ice, a C code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
  672. medit_to_ice_test
  673. memory, a C code which declares and uses a sequence of larger and larger arrays, to see what the memory limits are on a given computer.
  674. memory_test
  675. mesh_bandwidth, a C code which returns the geometric bandwidth associated with a mesh of elements of any order and in a space of M dimensions.
  676. mesh_bandwidth_test
  677. metis_test
  678. 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.
  679. mgmres_test
  680. mgs, a C code which is an example of legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
  681. mgs_test
  682. 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.
  683. middle_square_test
  684. 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 equation, and using a fixed time step.
  685. midpoint_test
  686. 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.
  687. midpoint_explicit_test
  688. 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.
  689. midpoint_fixed_test
  690. midpoint_gsl_test, a C code which calls the Gnu Scientific Library (GSL) implicit midpoint method solver for ordinary differential equation (ODE), and uses gnuplot() to plot the resulting solution.
  691. minpack, a C code which solves a system of nonlinear equations, by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
  692. minpack_test
  693. mixed_test, a C code which tests various mixed language programs.
  694. mm_io, a C code which reads and writes a Matrix Market (MM) Sparse Matrix File;
  695. mm_io_test
  696. 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.
  697. monomial_test
  698. monomial_value, a C code which evaluates a monomial in M dimensions.
  699. monomial_value_test
  700. mpi_test, a C code which uses the Message Passing Interface (MPI) for parallel programming;
  701. mri_to_ascii, a C code which converts the binary data in a Magnetic Resonance Imaging (MRI) file to ASCII text.
  702. mri_to_ascii_test
  703. 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.
  704. mri_to_pgm_test
  705. multitask_mpi, a C code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using MPI for parallel execution.
  706. multitask_mpi_test
  707. 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.
  708. multitask_openmp_test
  709. 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.
  710. mxm_test
  711. mxm_openmp, a C code which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
  712. mxm_openmp_test
  713. 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.
  714. mxm_serial_test
  715. naca, a C code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The points can be plotted with gnuplot().
  716. naca_test
  717. nas, a C code which runs the NASA kernel benchmark.
  718. nas_test
  719. 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.
  720. navier_stokes_2d_exact_test
  721. 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.
  722. navier_stokes_3d_exact_test
  723. nearest_interp_1d, a C code which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().
  724. nearest_interp_1d_test
  725. netcdf_test
  726. newton_interp_1d, a C code which finds a polynomial interpolant to data using Newton divided differences.
  727. newton_interp_1d_test
  728. nintlib, a C code which implements approximate integration or quadrature in M dimensions;
  729. nintlib_test
  730. normal, a C code which implements random number generators (RNG) for normally distributed values.
  731. normal_test
  732. ode, a C code which solves a system of ordinary differential equations (ODE), by Shampine and Gordon;
  733. ode_test
  734. 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.
  735. ode_moshier_test
  736. openmp_test, a C code which uses OpenMP for parallel programming;
  737. optimize_test
  738. ornstein_uhlenbeck, a C code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SODE) using the Euler method, the Euler-Maruyama method, and the Milstein method, and creating graphics files for processing by gnuplot().
  739. ornstein_uhlenbeck_test
  740. owen, a C code which evaluates the Owen T function;
  741. owen_test
  742. 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 to be processed by gnuplot().
  743. padua_test
  744. partial_digest, a C code which solves the partial digest problem;
  745. partial_digest_test
  746. partition_brute, a C code which uses a brute force algorithm to seek solutions of the partition problem, splitting a set of integers into two subsets with equal sum.
  747. partition_brute_test
  748. patterson_rule, a C code which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
  749. patterson_rule_test
  750. pbma_io, a C code which reads or writes an ASCII Portable Bit Map (PBM) bit map graphics file;
  751. pbma_io_test
  752. pbmb_io, a C code which reads or writes a binary Portable Bit Map (PBM) graphics file;
  753. pbmb_io_test
  754. pbmlib, a C code which reads or writes graphics files in the Portable Bit Map (PBM) format;
  755. pbmlib_test
  756. pce_burgers, a C code which solves a version of the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion in terms of Hermite polynomials, by Gianluca Iaccarino.
  757. pce_burgers_test
  758. pce_ode_hermite, a C code which sets up a simple scalar ordinary differential equation (ODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion in terms of Hermite polynomials.
  759. pce_ode_hermite_test
  760. pcg_basic, a C code which returns a sequence of uniformly distributed pseudorandom numbers, by Melissa O'Neill.
  761. pcg_basic_test
  762. pcg_minimal, a C code which is a minimal implementation of a permuted congruential generator (PCG) of random numbers, by Melissa O'Neill.
  763. pcg_minimal_test
  764. 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.
  765. pdflib_test
  766. pentominoes, a C code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
  767. pentominoes_test
  768. peri1d, a C code which sets up and solves a 1D time-dependent peridynamics problem, by Miroslav Stoyanov;
  769. peri1d_test
  770. persistence, a C code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
  771. persistence_test
  772. pgma_io, a C code which reads or writes ASCII Portable Gray Map (PGM) 2D graphics files;
  773. pgma_io_test
  774. pgmb_io, a C code which reads or writes a binary Portable Gray Map (PGM) 2D graphics file;
  775. pgmb_io_test
  776. pig_latin, a C code which converts its input to Pig Latin; a winner of the International Obfuscated C Code Competition in the Most Humorous category, by Don Dodson;
  777. pig_latin_test
  778. pink_noise, a C code which computes a pink noise signal obeying a 1/f power law.
  779. pink_noise_test
  780. png_io, a C code which reads and writes files in the Portable Network Graphics (PNG) format.
  781. png_io_test
  782. poisson_1d_multigrid, a C code which applies the multigrid method to a discretized version of the 1D Poisson equation.
  783. poisson_1d_multigrid_test
  784. poisson_2d, a C code which computes a solution to the Poisson equation in a rectangle, and is intended as the starting point for the creation of a parallel version.
  785. poisson_2d_test
  786. 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.
  787. poisson_mpi_test
  788. poisson_openmp, a C code which computes a solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
  789. poisson_openmp_test
  790. poisson_simulation, a C code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating graphics files for processing by gnuplot().
  791. poisson_simulation_test
  792. 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, Jacobi, Krawtchouk, Laguerre, Lambert, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling, Tau, Tribonacci, Zernike.
  793. polpak_test
  794. 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.
  795. polygon_test
  796. polygon_grid, a C code which generates a grid of points over the interior of a polygon in 2D.
  797. polygon_grid_test
  798. polygon_integrals, a C code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
  799. polygon_integrals_test
  800. 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.
  801. polygon_monte_carlo_test
  802. polygon_triangulate, a C code which triangulates a possibly nonconvex polygon in 2D, and which can use gnuplot() to display the external edges and internal diagonals of the triangulation.
  803. polygon_triangulate_test
  804. polynomial, a C code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  805. polynomial_test
  806. polynomial_conversion, a C code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Hermite, Laguerre and Legendre forms.
  807. polynomial_conversion_test
  808. polynomial_root_bound, a C code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
  809. polynomial_root_bound_test
  810. polyominoes, a C code which utilities for manipulating polyominoes and tilings.
  811. polyominoes_test
  812. power_method, a C code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  813. power_method_test
  814. power_rule, a C code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
  815. power_rule_test
  816. ppc_array, a C code which provides both typed and generic interfaces to allocate and free memory for vectors and matrices, from Rouben Rostamian's "Programming Projects in C";
  817. ppc_array_test
  818. ppc_array_mine, a C code which is an alternate version of ppc_array(), and manages the dynamic allocation and release of arrays, from "Programming Projects in C", by Rouben Rostamian.
  819. ppc_array_mine_test
  820. 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";
  821. ppc_fetch_line_test
  822. 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";
  823. ppc_fgets_demo_test
  824. ppc_haar, a C code which applies forward and backward Haar transforms to vectors and matrices, from Rouben Rostamian's "Programming Projects in C";
  825. ppc_haar_test
  826. 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";
  827. ppc_image_analysis_test
  828. ppc_netpbm, a C code which demonstrates the use of netpbm() to read and write images, from Rouben Rostamian's "Programming Projects in C";
  829. ppc_netpbm_test
  830. 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";
  831. ppc_netpbm_io_test
  832. 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";
  833. ppc_netpbm_random_test
  834. 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";
  835. ppc_sparse_matrix_test
  836. 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";
  837. ppc_xmalloc, a C code which manages the allocation of memory, from "Programming Projects in C", by Rouben Rostamian;
  838. ppc_xmalloc_test
  839. ppma_io, a C code which reads or writes an ASCII Portable Pixel Map (PPM) 2D graphics file;
  840. ppma_io_test
  841. ppmb_io, a C code which reads or writes a binary Portable Pixel Map (PPM) 2D graphics file;
  842. ppmb_io_test
  843. praxis, a C code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
  844. praxis_test
  845. predator_prey_ode, a C code which solves a time-dependent predator-prey system of ordinary differential equations (ODE).
  846. predator_prey_ode_test
  847. prime, a C code which counts the number of primes between 1 and N, and is intended as a starting point for a parallel version.
  848. prime_test
  849. prime_mpi, a C code which counts the primes between 1 and N, using MPI for parallel execution.
  850. prime_mpi_test
  851. prime_openmp, a C code which counts the number of primes between 1 and N, using OpenMP for parallel execution.
  852. prime_openmp_test
  853. prime_pi, a C code which evaluates Pi(n), the number of primes less than or equal to an integer n.
  854. prime_pi_test
  855. 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.
  856. prism_jaskowiec_rule_test
  857. 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.
  858. prism_witherden_rule_test
  859. prob, a C code which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
  860. prob_test
  861. product_rule, a C code which creates an M-dimensional quadrature rule from a product of distinct 1d quadrature rules;
  862. product_rule_test
  863. pthreads_test
  864. pwl_approx_1d, a C code which approximates a set of data using a piecewise linear function.
  865. pwl_approx_1d_test
  866. pwl_interp_1d, a C code which interpolates a set of data using a piecewise linear function. creating graphics files for processing by gnuplot().
  867. pwl_interp_1d_test
  868. pwl_interp_2d, a C code which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.
  869. pwl_interp_2d_test
  870. pwl_interp_2d_scattered, a C code which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.
  871. pwl_interp_2d_scattered_test
  872. pwl_product_integral, a C code which calculates the exact value of the integral of the product of two piecewise linear functions f(x) and g(x).
  873. pwl_product_integral_test
  874. pyramid_exactness, a C code which investigates the polynomial exactness of a quadrature rule over the interior of the unit pyramid in 3D.
  875. pyramid_exactness_test
  876. pyramid_felippa_rule, a C code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
  877. pyramid_felippa_rule_test
  878. pyramid_grid, a C code which computes a grid of points over the interior of the unit pyramid in 3D;
  879. pyramid_grid_test
  880. 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.
  881. pyramid_integrals_test
  882. pyramid_jaskowiec_rule, a C code which returns quadrature rules, with exactness up to total degree 20, over the interior of a pyramid in 3D, by Jan Jaskowiec, Natarajan Sukumar.
  883. pyramid_jaskowiec_rule_test
  884. 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;
  885. pyramid_monte_carlo_test
  886. pyramid_rule, a C code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D.
  887. pyramid_rule_test
  888. 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.
  889. pyramid_witherden_rule_test
  890. qr_solve, a C code which computes the linear least squares (LLS) solution of a system A*x=b.
  891. qr_solve_test
  892. quad, a C code which applies a quadrature rule to estimate an integral, intended as a starting point for parallelization exercises.
  893. quad_test
  894. quad_mpi, a C code which applies a quadrature rule to estimate an integral, working in parallel by using MPI;
  895. quad_mpi_test
  896. quad_openmp, a C code which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution;
  897. quad_openmp_test
  898. quad_rule, a C code which defines quadrature rules for approximating integrals;
  899. quad_rule_test
  900. quad2d, a C code which applies a product quadrature rule to estimate an integral over a 2D rectangle, intended as a starting point for parallelization exercises.
  901. quad2d_test
  902. quad2d_openmp, a C code which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution;
  903. 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).
  904. quadmom_test
  905. quadrature_golub_welsch, a C code which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure.
  906. quadrature_golub_welsch_test
  907. 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.
  908. quadrature_least_squares_test
  909. quadrature_weights_vandermonde, a C code which computes the weights of a quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  910. quadrature_weights_vandermonde_test
  911. 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.
  912. quadrature_weights_vandermonde_2d_test
  913. quadrilateral_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
  914. quadrilateral_witherden_rule_test
  915. quaternions, a C code which carries out some simple arithmetic operations for quaternions.
  916. quaternions_test
  917. r83, a C code which contains linear algebra routines for r83 matrices, real, 64 bit, tridiagonal 3xN format.
  918. r83_test
  919. r83_np, a C code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
  920. r83_np_test
  921. r83p, a C code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
  922. r83p_test
  923. r83s, a C code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
  924. r83s_test
  925. r83t, a C code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
  926. r83t_test
  927. r83v, a C code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
  928. r83v_test
  929. r85, a C code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
  930. r85_test
  931. r8bb, a C code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
  932. r8bb_test
  933. r8blt, a C code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
  934. r8blt_test
  935. r8bto, a C code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
  936. r8bto_test
  937. r8but, a C code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
  938. r8but_test
  939. r8cb, a C code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
  940. r8cb_test
  941. r8cbb, a C code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
  942. r8cbb_test
  943. r8ccs, a C code which contains linear algebra routines for r8ccs matrices (real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format).
  944. r8ccs_test
  945. r8ci, a C code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
  946. r8ci_test
  947. r8col, a C code which contains utility routines for an R8COL, that is, a double precision real 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.
  948. r8col_test
  949. r8gb, a C code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
  950. r8gb_test
  951. r8gd, a C code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
  952. r8gd_test
  953. r8ge, a C code which contains linear algebra routines for R8GE matrices, real, 64 bit, General format.
  954. r8ge_test
  955. r8lib, a C code which contains many utility routines, using double precision real (R8) arithmetic.
  956. r8lib_test
  957. r8lt, a C code which contains linear algebra routines for R8LT matrices, real, 64 bit, Lower Triangular format.
  958. r8lt_test
  959. r8ltt, a C code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
  960. r8ltt_test
  961. r8ncf, a C code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
  962. r8ncf_test
  963. r8pbl, a C code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
  964. r8pbl_test
  965. r8pbu, a C code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
  966. r8pbu_test
  967. r8po, a C code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
  968. r8po_test
  969. 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.
  970. r8poly_test
  971. r8pp, a C code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
  972. r8pp_test
  973. r8ri, a C code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
  974. r8ri_test
  975. r8row, a C code which contains utility routines for an R8ROW, that is, a double precision real 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.
  976. r8row_test
  977. r8sd, a C code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
  978. r8sd_test
  979. r8sm, a C code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
  980. r8sm_test
  981. r8sr, a C code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
  982. r8sr_test
  983. r8ss, a C code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
  984. r8ss_test
  985. r8st, a C code which contains linear algebra routines for r8st matrices, real, 64 bit, Sparse Triplet format.
  986. r8st_test
  987. r8sto, a C code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
  988. r8sto_test
  989. r8to, a C code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
  990. r8to_test
  991. r8ut, a C code which contains linear algebra routines for r8ut matrices, real, 64 bit, Upper Triangular format.
  992. r8ut_test
  993. r8utp, a C code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
  994. r8utp_test
  995. r8utt, a C code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
  996. r8utt_test
  997. r8vm, a C code which contains linear algebra routines for r8vm matrices (real, 64 bit, vandermonde format).
  998. r8vm_test
  999. rand48_test
  1000. randlc, a C code which implements a random number generator (RNG) used by the NAS Benchmark.
  1001. randlc_test
  1002. random_data, a C code which uses a random number generator (RNG) to sample points for various probability distributions, spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.
  1003. random_data_test
  1004. random_mpi, a C code which generates the same sequence of random numbers for both sequential execution and parallel execution under MPI.
  1005. random_mpi_test
  1006. random_openmp, a C code which illustrates how a parallel program using OpenMP can generate multiple distinct streams of random numbers.
  1007. random_openmp_test
  1008. random_sorted, a C code which generates vectors of random values which are already sorted.
  1009. random_sorted_test
  1010. ranlib, a C code 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.
  1011. ranlib_test
  1012. rbf_interp_1d, a C code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
  1013. rbf_interp_1d_test
  1014. rbf_interp_2d, a C code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
  1015. rbf_interp_2d_test
  1016. rbf_interp_nd, a C code which defines and evaluates radial basis function (RBF) interpolants to M-dimensional data.
  1017. rbf_interp_nd_test
  1018. reactor simulation, a C code which is a Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This code was provided as an example with the book "Numerical Methods and Software."
  1019. reactor simulation_test
  1020. ring_mpi, a C code which uses the MPI parallel programming environment, and measures the time necessary to copy a set of data around a ring of processes.
  1021. ring_mpi_test
  1022. rk4, a C code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.
  1023. rk4_test
  1024. rkf45, a C code which applies the Runge-Kutta-Fehlberg (RKF) algorithm to solve a system of ordinary differential equations (ODE);
  1025. rkf45_test
  1026. 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.
  1027. rnglib_test
  1028. root_rc, a C code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Gaston Gonnet.
  1029. root_rc_test
  1030. roots_rc, a C code which seeks solutions of a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.
  1031. roots_rc_test
  1032. 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.
  1033. rot13_test
  1034. 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.
  1035. row_echelon_integer_test
  1036. sandia_rules, a C code which produces a standard 1D Gauss quadrature rule of Chebyshev, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, and Legendre types.
  1037. sandia_rules_test
  1038. 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.
  1039. satisfy_brute_test
  1040. satisfy_mpi, a C code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfy problem, using MPI to perform the calculation in parallel.
  1041. satisfy_mpi_test
  1042. satisfy_openmp, a C code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfy problem, using OpenMP for parallel execution.
  1043. satisfy_openmp_test
  1044. schedule_openmp, a C code which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.
  1045. schedule_openmp_test
  1046. screenshot_opengl, a C code which uses OpenGL() to save a screenshot of the graphics being displayed.
  1047. sde, a C code which illustrates properties of stochastic ordinary differential equations (SODE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, making graphics files for processing and display by gnuplot(), by Desmond Higham;
  1048. sde_test
  1049. search, a C code which searches the integers from A to B for a value J such that F(J) = C. this is intended as a starting point for a parallel approach.
  1050. search_test
  1051. search_mpi, a C code which searches integers between A and B for a solution J such that F(J)=C, carried out in parallel using MPI.
  1052. search_mpi_test
  1053. set_theory, a C code which demonstrates various set theoretic operations using several models of a set.
  1054. set_theory_test
  1055. sftpack, a C code which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
  1056. sftpack_test
  1057. sgefa_openmp, a C code which compares a standard linear algebra solver against a revised version which can be run in parallel with OpenMP.
  1058. sgefa_openmp_test
  1059. sgmga, a C code which creates sparse grids using a mixture of 1D quadrature rule families, allowing user specified growth rates for each family, allowing anisotropic weights for each dimension.
  1060. sgmga_test
  1061. shallow_water_1d, a C code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.
  1062. shallow_water_1d_test
  1063. shepard_interp_1d, a C code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
  1064. shepard_interp_1d_test
  1065. shepard_interp_2d, a C code which defines and evaluates Shepard interpolants to 2D data, based on inverse distance weighting.
  1066. shepard_interp_2d_test
  1067. shepard_interp_nd, a C code which defines and evaluates Shepard interpolants to M-dimensional data, based on inverse distance weighting.
  1068. shepard_interp_nd_test
  1069. showme, a C code which displays triangulations and meshes, by Jonathan Shewchuk;
  1070. showme_test
  1071. simplex_coordinates, a C code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  1072. simplex_coordinates_test
  1073. 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 over the interior of the simplex in M dimensions.
  1074. simplex_gm_rule_test
  1075. simplex_grid, a C code which generates a regular grid of points over the interior of an arbitrary simplex in M dimensions.
  1076. simplex_grid_test
  1077. 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.
  1078. simplex_integrals_test
  1079. simplex_monte_carlo, a C code which uses the Monte Carlo method to estimate an integral over the interior of the unit simplex in M dimensions.
  1080. simplex_monte_carlo_test
  1081. sine_transform, a C code which demonstrates some simple properties of the discrete sine transform.
  1082. sine_transform_test
  1083. smolpack, a C code which estimates the integral of a function over a M-dimensional hypercube using a sparse grid, by Knut Petras;
  1084. smolpack_test
  1085. snakes_and_ladders, a C code which provides tools for the analysis of the game of Snakes and Ladders.
  1086. snakes_and_ladders_test
  1087. solve, a C code which implements a linear solver which makes it easy to create doubly-dimensioned arrays and solve associated linear systems.
  1088. solve_test
  1089. sort_rc, a C code which sorts a list of any kind of objects, using reverse communication (RC).
  1090. sort_rc_test
  1091. sparse_display, a C code which reads information defining a matrix of numbers and displays the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is already available in the built-in MATLAB spy() command.
  1092. sparse_display_test
  1093. sparse_grid_cc, a C code which creates sparse grids based on Clenshaw-Curtis rules.
  1094. sparse_grid_cc_test
  1095. 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.
  1096. sparse_grid_hw_test
  1097. sparse_interp_nd, a C code which defines a sparse interpolant to a function f(x) of a multidimensional argument.
  1098. sparse_interp_nd_test
  1099. sphere_exactness, a C code which tests the polynomial exactness of a quadrature rule over the surface of the unit sphere in 3D;
  1100. sphere_exactness_test
  1101. 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.
  1102. sphere_fibonacci_grid_test
  1103. sphere_grid, a C code which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, over the surface of the unit sphere in 3D.
  1104. sphere_grid_test
  1105. sphere_integrals, a C code which defines test functions for integration over the surface of the unit sphere in 3D.
  1106. sphere_integrals_test
  1107. sphere_lebedev_rule, a C code which computes Lebedev quadrature rules over the surface of the unit sphere in 3D;
  1108. sphere_lebedev_rule_test
  1109. 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.
  1110. sphere_llq_grid_test
  1111. 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.
  1112. sphere_llt_grid_test
  1113. sphere_monte_carlo, a C code which applies a Monte Carlo method to estimate the integral of a function over the surface of the unit sphere in 3D;
  1114. sphere_monte_carlo_test
  1115. sphere_quad, a C code which used triangulation to approximate an integral over the surface of the unit sphere in 3D;
  1116. sphere_quad_test
  1117. sphere_stereograph, a C code which computes the stereographic mapping between points on the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
  1118. sphere_stereograph_test
  1119. sphere_triangle_monte_carlo, a C code which used the Monte Carlo method to estimate the integral of a function defined in a triangle on the surface of the unit sphere in 3D.
  1120. sphere_triangle_monte_carlo_test
  1121. sphere_triangle_quad, a C code which uses quadrature to estimate the integral of a function in a spherical triangle on the surface of the unit sphere in 3D.
  1122. sphere_triangle_quad_test
  1123. spiral_data, a C code which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot().
  1124. spiral_data_test
  1125. spline, a C code which interpolates or approximates data by piecewise polynomial functions;
  1126. spline_test
  1127. 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.
  1128. square_arbq_rule_test
  1129. square_exactness, a C code which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a rectangle in 2D.
  1130. square_exactness_test
  1131. square_felippa_rule, a C code which returns a Felippa quadrature rules for approximating integrals over the interior of a square in 2D.
  1132. square_felippa_rule_test
  1133. square_grid, a C code which computes a grid of points over the interior of a square in 2D.
  1134. square_grid_test
  1135. 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.
  1136. square_integrals_test
  1137. 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.
  1138. square_minimal_rule_test
  1139. 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.
  1140. square_monte_carlo_test
  1141. square_symq_rule, a C code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  1142. square_symq_rule_test
  1143. st_io, a C code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
  1144. st_io_test
  1145. st_to_ccs, a C code which converts a matrix from the Sparse Triplet (ST) format to the Compressed Column Storage (CCS) format.
  1146. st_to_ccs_test
  1147. stiff_ode, a C code which considers an ordinary differential equation (ODE) which is an example of a stiff ODE.
  1148. stiff_ode_test
  1149. stochastic_diffusion, functions which implement several versions of a stochastic diffusivity coefficient.
  1150. stochastic_diffusion_test
  1151. stochastic_heat2d, a C code which implements a finite difference method (FDM) for the steady time-independent 2D heat equation, with a stochastic heat diffusivity coefficient, using gnuplot() to illustrate the results.
  1152. stochastic_heat2d_test,
  1153. stochastic_rk, a C code which applies a Runge-Kutta (RK) scheme to a stochastic ordinary differential equation (SODE).
  1154. stochastic_rk_test
  1155. stokes_2d_exact, a C code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
  1156. stokes_2d_exact_test
  1157. string_pde, a C code which sets up and solves the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
  1158. string_pde_test
  1159. stroud, 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.
  1160. stroud_test
  1161. 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.
  1162. subset_test
  1163. 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.
  1164. subset_sum_test
  1165. subset_sum_backtrack, a C code which uses backtracking to find solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  1166. subset_sum_backtrack_test
  1167. subset_sum_brute, a C code which uses brute force to find solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  1168. subset_sum_brute_test
  1169. super_blas, a C code which implements some of the BLAS routines, for particular use by superlu();
  1170. super_blas_test
  1171. superlu_test, a C code which illustrates how to use superlu(), which applies a fast direct solution method to solve sparse linear systems, by James Demmel, John Gilbert, and Xiaoye Li.
  1172. svd_test
  1173. svd_snowfall, a C code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD).
  1174. svd_snowfall_test
  1175. 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.
  1176. svd_truncated_test
  1177. table_io, a C code which reads and writes a simple dataset stored as a table file;
  1178. table_io_test
  1179. 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.
  1180. task_division_test
  1181. test_approx, a C code which implements test problems for approximation, provided as a set of (x,y) data.
  1182. test_approx_test
  1183. test_eigen, a C code which implements test matrices for eigenvalue analysis.
  1184. test_eigen_test
  1185. test_int, a C code which implements test problems for approximate integration or quadrature in one dimension.
  1186. test_int_test
  1187. test_int_2d, a C code which implements test problems for approximate integration or quadrature in two dimensions.
  1188. test_int_2d_test
  1189. test_interp, a C code which defines test problems for interpolation, provided as a set of (x,y) data.
  1190. test_interp_test
  1191. test_interp_1d, a C code which defines test problems for interpolation of data y(x), which depends on a 1D argument.
  1192. test_interp_1d_test
  1193. test_interp_2d, a C code which defines test problems for interpolation of data z(x,y), which depends on a 2D argument.
  1194. test_interp_2d_test
  1195. test_interp_nd, a C code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
  1196. test_interp_nd_test
  1197. test_lls, a C code which implements linear least squares (LLS) test problems of the form A*x=b.
  1198. test_lls_test
  1199. 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.
  1200. test_matrix_test
  1201. test_matrix_exponential, a C code which defines a set of test cases for computing the matrix exponential.
  1202. test_matrix_exponential_test
  1203. test_min, a C code which implements test problems for minimization of a scalar function of a scalar variable.
  1204. test_min_test
  1205. test_nearest, a C code which tests the time complexity of various procedures for solving the nearest neighbor problem.
  1206. test_nearest_test
  1207. 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.
  1208. test_opt_con_test
  1209. test_optimization, a C code which implements test problems for optimization of a scalar function of several variables, as described by Molga and Smutnicki.
  1210. test_optimization_test
  1211. test_partial_digest, a C code which generates examples of the partial digest problem.
  1212. test_partial_digest_test
  1213. 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, Exponential integral, Elliptic, Error, Euler, Exponential integral, F probability, Fresnel, Frobenius, Gamma, Gegenbauer, Goodwin, Gudermannian, Harmonic, Hermite, Hypergeometric 1F1, Hypergeometric 2F1, inverse trigonometic, Jacobi, Julian Ephemeris Date, Kelvin, Laguerre, 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, 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.
  1214. test_values_test
  1215. test_zero, a C code which implements test problems for the solution of a single nonlinear equation in one variable.
  1216. test_zero_test
  1217. tester, a BASH script which runs the test programs.
  1218. tet_mesh, a C code which carries out various tasks associated with tetrahedral meshes in 3D;
  1219. tet_mesh_test
  1220. 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.
  1221. tetrahedron_test
  1222. 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.
  1223. tetrahedron_arbq_rule_test
  1224. tetrahedron_exactness, a C code which tests the polynomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.
  1225. tetrahedron_exactness_test
  1226. tetrahedron_felippa_rule, a C code which returns a Felippa quadrature rules for approximating integrals over the interior of a tetrahedron in 3D.
  1227. tetrahedron_felippa_rule_test
  1228. tetrahedron_grid, a C code which computes a grid of points over the interior of a tetrahedron in 3D.
  1229. tetrahedron_grid_test
  1230. 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.
  1231. tetrahedron_integrals_test
  1232. 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.
  1233. tetrahedron_jaskowiec_rule_test
  1234. tetrahedron_keast_rule, a C code which defines a Keast quadrature rule, of degree of exactness 0 through 8, over the interior of the tetrahedron in 3D.
  1235. tetrahedron_keast_rule_test
  1236. tetrahedron_monte_carlo, a C code which uses the Monte Carlo method to estimate an integral over the interior of a general tetrahedron in 3D.
  1237. tetrahedron_monte_carlo_test
  1238. tetrahedron_ncc_rule, a C code which defines Newton-Cotes closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
  1239. tetrahedron_ncc_rule_test
  1240. tetrahedron_nco_rule, a C code which defines Newton-Cotes open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
  1241. tetrahedron_nco_rule_test
  1242. tetrahedron_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
  1243. tetrahedron_witherden_rule_test
  1244. tetrahedron01_monte_carlo, a C code which uses the Monte Carlo method to estimate an integral over the interior of the unit tetrahedron in 3D.
  1245. tetrahedron01_monte_carlo_test
  1246. three_body_ode, a C code which simulates the behavior of three planets, constrained to lie in a plane, and moving under the influence of gravity, by Walter Gander and Jiri Hrebicek.
  1247. three_body_ode_test
  1248. timer_test
  1249. timestamp, a C code which returns the current YMDHMS date as a timestamp, and performs other timing chores;
  1250. timestamp_test
  1251. toeplitz_cholesky, a C code which computes the Cholesky factorization of a symmetrid positive definite (SPD) Toeplitz matrix.
  1252. toeplitz_cholesky_test
  1253. 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.
  1254. toms097_test
  1255. 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.
  1256. toms112_test
  1257. toms178, a C code which seeks the minimizer of a function of several variables, using the Hooke-Jeeves direct search method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.
  1258. toms178_test
  1259. toms179, a C code which calculates the incomplete Beta ratio, by Oliver Ludwig; this is a version of ACM TOMS algorithm 179.
  1260. toms179_test
  1261. toms243, a C code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
  1262. toms243_test
  1263. toms291, a C code which approximates the logarithm of the Gamma function; This is a version of ACM TOMS algorithm 291.
  1264. toms291_test
  1265. toms322, a C code which evaluates the F and the Student T Cumulative Density Function (CDF); This is a version of ACM TOMS algorithm 322.
  1266. toms322_test
  1267. toms443, a C code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 443.
  1268. toms443_test
  1269. toms446, a C code which manipulates Chebyshev series for interpolation and approximation. This is a version of ACM TOMS algorithm 446, by Roger Broucke.
  1270. toms446_test
  1271. toms462, a C code which evaluates the upper right tail of the bivariate normal distribution; that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y. This is a version of ACM TOMS algorithm 462.
  1272. toms462_test
  1273. toms515, a C code which selects subsets of size K from a set of size N, This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
  1274. toms515_test
  1275. 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.
  1276. toms577_test
  1277. toms655, a C code which computes the weights for interpolatory quadrature rule; this code is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
  1278. toms655_test
  1279. 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.
  1280. toms743_test
  1281. 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.
  1282. toms886_test
  1283. 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.
  1284. toms917_test
  1285. 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.
  1286. trapezoidal_test
  1287. 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.
  1288. treepack_test
  1289. triangle, a C code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
  1290. triangle_test
  1291. 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.
  1292. triangle_analyze_test
  1293. triangle_exactness, a C code which tests the polynomial exactness of a quadrature rule over the interior of a triangle in 2D.
  1294. triangle_exactness_test
  1295. triangle_fekete_rule, a C code which returns a Fekete rule for interpolation or quadrature over the interior of a triangle in 2D.
  1296. triangle_fekete_rule_test
  1297. triangle_felippa_rule, a C code which returns a Felippa quadrature rules for approximating integrals over the interior of a triangle in 2D.
  1298. triangle_felippa_rule_test
  1299. triangle_grid, a C code which computes a grid of points over the interior of a triangle in 2D.
  1300. triangle_grid_test
  1301. triangle_integrals, a C code which returns the exact value of the integral of any polynomial over the interior of an arbitrary triangle in 2D.
  1302. triangle_integrals_test
  1303. triangle_interpolate, a C code which shows how vertex data can be interpolated at any point in the interior of a triangle.
  1304. triangle_interpolate_test
  1305. triangle_io, a C code which reads or writes some of the files created by the triangle() program of Jonathan Shewchuk.
  1306. triangle_io_test
  1307. triangle_monte_carlo, a C code which uses the Monte Carlo method to estimate an integral over the interior of a general triangle in 2D.
  1308. triangle_monte_carlo_test
  1309. triangle_ncc_rule, a C code which defines Newton-Cotes closed (NCC) quadrature rules over the interior of a triangle in 2D.
  1310. triangle_ncc_rule_test
  1311. triangle_nco_rule, a C code which defines Newton-Cotes open (NCO) quadrature rules over the interior of a triangle in 2D.
  1312. triangle_nco_rule_test
  1313. triangle_shewchuk, a C code which generates meshes, Delaunay triangulations, and Voronoi diagrams, by Jonathan Shewchuk;
  1314. triangle_shewchuk_test
  1315. 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.
  1316. triangle_svg_test
  1317. triangle_symq_rule, a C code which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
  1318. triangle_symq_rule_test
  1319. triangle_to_fem, a C code which reads the NODE and ELE files created by the triangle() program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
  1320. triangle_to_fem_test
  1321. triangle_to_xml, a C code which reads the NODE and ELE files created by triangle() to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by DOLFIN or FENICS.
  1322. triangle_to_xml_test
  1323. triangle_twb_rule, a C code which generates the points and weights of quadrature rules over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
  1324. triangle_twb_rule_test
  1325. triangle_witherden_rule, a C code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
  1326. triangle_witherden_rule_test
  1327. triangle01_integrals, a C code which returns the integral of any monomial over the interior of the unit triangle in 2D.
  1328. triangle01_integrals_test
  1329. triangle01_monte_carlo, a C code which uses the Monte Carlo method to estimate an integral over the interior of the unit triangle in 2D.
  1330. triangle01_monte_carlo_test
  1331. triangulate, a C code which triangulates a polygonal region, by Joseph ORourke;
  1332. triangulate_test
  1333. triangulation, a C code which computes the triangulation of a set of points in the plane, and performs various operations using a triangulation, including searching a Delaunay triangulation to find which triangle contains a given point.
  1334. triangulation_test
  1335. triangulation_node_to_element, a C code which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an "order1" finite element model of the data.
  1336. triangulation_node_to_element_test
  1337. triangulation_svg, a C code which creates an SVG image of a triangulation, which can be displayed by a web browser.
  1338. triangulation_svg_test
  1339. triangulation_triangle_neighbors, a C code which reads data defining a triangulation, finds the three neighbor triangles for each triangle, and writes them to a file;
  1340. triangulation_triangle_neighbors_test
  1341. trig_to_neib, a C code which reads node and ele files, a format prescribed by the triangle() program of Jonathan Shewchuk, describing a triangulation, and produces a file defining the neighbor triangles of each element; the code can also produce information about the Voronoi diagram. The code is by Lili Ju.
  1342. trig_to_neib_test
  1343. 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.
  1344. truncated_normal_test
  1345. truncated_normal_rule, a C code which computes a quadrature rule for a normal probability density function (PDF), sometimes called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B], or [A,B].
  1346. truncated_normal_rule_test
  1347. tsp_brute, a C code which reads a file of city-to-city distances and solves a small traveling salesperson problem (TSP), using brute force.
  1348. tsp_brute_test
  1349. ubvec, a C code which demonstrates how nonnegative integers can be stored as unsigned binary vectors, and arithmetic can be performed on them.
  1350. ubvec_test
  1351. umfpack_test, a C code which calls umfpack(), which solves sparse linear systems, part of the SuiteSparse package, by Timothy Davis.
  1352. unicycle, a C code which considers permutations containing a single cycle, sometimes called cyclic permutations.
  1353. unicycle_test
  1354. uniform, a C code which contains uniform random number generators (RNG) for several arithmetic types.
  1355. uniform_test
  1356. upc, a C code which computes the check digit associated with a uniform product code (UPC), or reports whether a 12-digit UPC is actually valid.
  1357. upc_test
  1358. valgrind_test
  1359. van_der_corput, a C code which computes elements of the van der Corput one-dimensional Quasi Monte Carlo (QMC) sequence, using a simple interface.
  1360. van_der_corput_test
  1361. vandermonde, a C code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.
  1362. vandermonde_test
  1363. vandermonde_approx_1d, a C code which finds a polynomial approximant to data y(x) of a 1D argument by solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  1364. vandermonde_approx_1d_test
  1365. 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.
  1366. vandermonde_approx_2d_test
  1367. 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, creating graphics files for processing by gnuplot().
  1368. vandermonde_interp_1d_test
  1369. 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.
  1370. vandermonde_interp_2d_test
  1371. walker_sample, a C code which efficiently samples a discrete probability vector using Walker sampling.
  1372. walker_sample_test
  1373. walsh_transform, a C code which implements the Walsh data transform.
  1374. walsh_transform_test
  1375. 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).
  1376. wathen_matrix_test
  1377. wave_mpi, a C code which uses the finite difference method (FDM) and MPI to estimate a solution to the wave equation.
  1378. wave_mpi_test
  1379. wavelet, a C code which does some simple calculations with wavelet transforms;
  1380. wavelet_test
  1381. wedge_exactness, a C code which investigates the polynomial exactness of a quadrature rule over the interior of the unit wedge in 3D.
  1382. wedge_exactness_test
  1383. wedge_felippa_rule, a C code which returns quadrature rules for approximating integrals over the interior of the unit wedge in 3D.
  1384. wedge_felippa_rule_test
  1385. wedge_grid, a C code which computes a grid of points over the interior of the unit wedge in 3D.
  1386. wedge_grid_test
  1387. 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.
  1388. wedge_integrals_test
  1389. wedge_monte_carlo, a C code which uses the Monte Carlo method to estimate an integral over the interior of the unit wedge in 3D.
  1390. wedge_monte_carlo_test
  1391. 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.
  1392. weekday_test
  1393. wishart_matrix, a C code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
  1394. wishart_matrix_test
  1395. wtime, a C code which returns a reading of the wall clock time in seconds.
  1396. wtime_test
  1397. x_window_test
  1398. zero, a C code which seeks a solution of a scalar nonlinear equation f(x)=0, by Richard Brent.
  1399. zero_test
  1400. 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.
  1401. zero_itp_test
  1402. zero_rc, a C code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Richard Brent.
  1403. zero_rc_test
  1404. ziggurat, a C code which samples the uniform, normal or exponential distributions, using the ziggurat method, by Marsaglia and Tsang.
  1405. ziggurat_test
  1406. 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.
  1407. ziggurat_inline_test
  1408. ziggurat_openmp, a C code which demonstrates how ziggurat() can be used as a random number generator (RNG) in an OpenMP parallel program.
  1409. ziggurat_openmp_test


Last revised on 03 March 2024.