Fortran90 Codes


  1. allocatable_array_test
  2. analemma, a Fortran90 code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data files that can be plotted with gnuplot(), based on a C code by Brian Tung.
  3. analemma_test
  4. annulus_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate the integral of a function over the interior of a circular annulus in 2D.
  5. annulus_monte_carlo_test
  6. apportionment, a Fortran90 code which demonstrates some of the methods used or proposed for fairly assigning seats in the House of Representatives to each state;
  7. apportionment_test
  8. args, a Fortran90 code which reports the command line arguments of a Fortran90 code;
  9. args_test
  10. arpack, a Fortran90 code which computes eigenvalues for large matrices, by Richard Lehoucq, Danny Sorensen, Chao Yang;
  11. arpack_test
  12. asa005, a Fortran90 code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
  13. asa005_test
  14. asa006, a Fortran90 code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
  15. asa006_test
  16. asa007, a Fortran90 code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
  17. asa007_test
  18. asa032, a Fortran90 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 Fortran90 code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
  21. asa047_test
  22. asa053, a Fortran90 code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
  23. asa053_test
  24. asa058, a Fortran90 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 Fortran90 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 Fortran90 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 Fortran90 code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
  31. asa076_test
  32. asa082, a Fortran90 code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
  33. asa082_test
  34. asa091, a Fortran90 code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
  35. asa091_test
  36. asa103, a Fortran90 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 Fortran90 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 Fortran90 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 Fortran90 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 Fortran90 code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
  45. asa121_test
  46. asa136, a Fortran90 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 Fortran90 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 Fortran90 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 Fortran90 code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152.
  53. asa152_test
  54. asa159, a Fortran90 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 Fortran90 code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. This is a version of Applied Statistics Algorithm 172.
  57. asa172_test
  58. asa183, a Fortran90 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. asa189, a Fortran90 code which estimates the parameters of a beta binomial distribution based on a sample of values generated by the distribution, by D Smith; this is a version of Applied Statistics Algorithm 189;
  61. asa189_test
  62. asa205, a Fortran90 code which generates all the contingency tables corresponding to a given set of row and column sums. This is a version of Applied Statistics Algorithm 205.
  63. asa205_test
  64. asa226, a Fortran90 code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
  65. asa226_test
  66. asa239, a Fortran90 code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
  67. asa239_test
  68. asa241, a Fortran90 code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
  69. asa241_test
  70. asa243, a Fortran90 code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
  71. asa243_test
  72. asa245, a Fortran90 code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
  73. asa245_test
  74. asa266, a Fortran90 code which evaluates various properties of the Dirichlet Probability Density Function (PDF); this is a version of Applied Statistics Algorithm 266;
  75. asa266_test
  76. asa299, a Fortran90 code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
  77. asa299_test
  78. asa310, a Fortran90 code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
  79. asa310_test
  80. asa314, a Fortran90 code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
  81. asa314_test
  82. atbash, a Fortran90 code which applies the Atbash substitution cipher to a string of text.
  83. atbash_test
  84. backtrack_binary_rc, a Fortran90 code which carries out a backtrack search for binary decisions, using reverse communication (RC).
  85. backtrack_binary_rc_test
  86. backward_euler, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a version of fsolve() for the implicit equation.
  87. backward_euler_test
  88. ball_grid, a Fortran90 code which computes grid points inside a 3D ball.
  89. ball_grid_test
  90. ball_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
  91. ball_integrals_test
  92. ball_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
  93. ball_monte_carlo_test
  94. band_qr, a Fortran90 code which computes the QR factorization of a banded matrix, and solves related linear systems, by Alfredo Remon, Enrique Quintana-Orti, Gregorio Quintana-Orti.
  95. band_qr_test
  96. barycentric_interp_1d, a Fortran90 code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.
  97. barycentric_interp_1d_test
  98. bdf2, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
  99. bdf2_test
  100. bdmlib, a Fortran90 code which estimates the weights in a Dirichlet mixture based on sample data;
  101. bdmlib_test
  102. bellman_ford, a Fortran90 code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
  103. bellman_ford_test
  104. bernstein_polynomial, a Fortran90 code which evaluates the Bernstein polynomials;
  105. bernstein_polynomial_test
  106. besselj, a Fortran90 code which evaluates Bessel J functions of noninteger order;
  107. besselj_test
  108. beta_nc, a Fortran90 code which evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
  109. beta_nc_test
  110. bezier_surface, a Fortran90 code which reads, writes, prints and manipulates the data that defines a Bezier surface;
  111. bezier_surface_test
  112. bisection, a Fortran90 code which applies the bisection method to seek a root of f(x) over a change-of-sign interval a <= x <= b.
  113. bisection_test
  114. bisection_integer, a Fortran90 code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
  115. bisection_integer_test
  116. bisection_rc, a Fortran90 code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication (RC).
  117. bisection_rc_test
  118. bivar, a Fortran90 code which interpolates scattered bivariate data. This is a version of ACM TOMS algorithm 526, by Hiroshi Akima.
  119. bivar_test
  120. black_scholes, a Fortran90 code which implements some simple approaches to the Black-Scholes option valuation theory, creating graphics files for processing by gnuplot(), by Desmond Higham.
  121. black_scholes_test
  122. blend, a Fortran90 code which carries out 1D/2D/3D blending interpolation;
  123. blend_test
  124. box_behnken, a Fortran90 code which computes a Box-Behnken design, that is, arguments to sample the behavior of a function of multiple parameters;
  125. box_behnken_test
  126. brownian_motion_simulation, a Fortran90 code which simulates Brownian motion in an M-dimensional region, creating graphics files for processing by gnuplot().
  127. brownian_motion_simulation_test
  128. burgers_exact, a Fortran90 code which evaluates exact solutions of the time-dependent 1D viscous Burgers equation.
  129. burgers_exact_test
  130. bvec, a Fortran90 code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
  131. bvec_test
  132. c_comment, a Fortran90 code which reads an ASCII text file, and writes a copy, in which C++ style comments have been replaced by equivalent C-style comments.
  133. c_comment_test
  134. c8lib, a Fortran90 code which implements certain elementary functions for double precision complex (C8) variables;
  135. c8lib_test
  136. c8poly, a Fortran90 code which operates on complex polynomials.
  137. c8poly_test
  138. caesar, a Fortran90 code which applies a Caesar Shift Cipher to a string of text.
  139. caesar_test
  140. calendar_nyt, a Fortran90 code which shows the correspondence between dates and the New York Times volume and issue number;
  141. calendar_nyt_test
  142. cauchy_principal_value, a Fortran90 code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
  143. cauchy_principal_value_test
  144. ccn_rule, a Fortran90 code which defines a Clenshaw Curtis Nested (CCN) quadrature rule.
  145. ccn_rule_test
  146. ccs_io, a Fortran90 code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
  147. ccs_io_test
  148. ccs_to_st, a Fortran90 code which converts a sparse matrix from compressed column storage (CCS) to sparse triplet (ST) format.
  149. ccs_to_st_test
  150. cdflib, a Fortran90 code which evaluates the cumulative density function (CDF), inverse CDF, and certain other inverse functions, for distributions including beta, binomial, chi-square, noncentral chi-square, F, noncentral F, gamma, negative binomial, normal, Poisson, and students T, by Barry Brown, James Lovato, Kathy Russell.
  151. cdflib_test
  152. cell, a Fortran90 code which defines a cell array, a generalization of an array which compactly stores and retrieves vector or matrix data of varying size, such as the rows of a triangular matrix.
  153. cell_test
  154. cg, a Fortran90 code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite, only real, positive eigenvalues and symmetric.
  155. cg_test
  156. cg_rc, a Fortran90 code which implements the conjugate gradient (CG) method for solving a positive definite sparse linear system A*x=b, using reverse communication (RC).
  157. cg_rc_test
  158. change_dynamic, a Fortran90 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.
  159. change_dynamic_test
  160. chebyshev, a Fortran90 code which computes the Chebyshev interpolant/approximant to a given function over an interval.
  161. chebyshev_test
  162. chebyshev_interp_1d, a Fortran90 code which determines the combination of Chebyshev polynomials which interpolates data, so that p(x(i)) = y(i).
  163. chebyshev_interp_1d_test
  164. chebyshev_polynomial, a Fortran90 code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
  165. chebyshev_polynomial_test
  166. chebyshev_series, a Fortran90 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.
  167. chebyshev_series_test
  168. chrpak, a Fortran90 code which manipulates characters and strings;
  169. chrpak_test
  170. circle_arc_grid, a Fortran90 code which computes a grid of points over the length of a circle or circular arc in 2D.
  171. circle_arc_grid_test
  172. circle_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
  173. circle_integrals_test
  174. circle_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
  175. circle_monte_carlo_test
  176. circle_packing, a Fortran90 code which performs a circle-packing test on the spacing for points;
  177. circle_packing_test
  178. circle_segment, a Fortran90 code which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature, creating some graphics images using gnuplot().
  179. circle_segment_test
  180. clausen, a Fortran90 code which evaluates a Chebyshev interpolant to the Clausen function Cl2(x).
  181. clausen_test
  182. clenshaw_curtis_grid, a Fortran90 code which sets up a Clenshaw Curtis quadrature rule in multiple dimensions;
  183. clenshaw_curtis_grid_test
  184. closest_pair_brute, a Fortran90 code which uses brute force to solve a 2D version of the closest pair problem, which identifies the closest pair of points in a given collection.
  185. closest_pair_brute_test
  186. cluster_energy, a Fortran90 code which groups data into a given number of clusters to minimize the energy.
  187. cluster_energy_test
  188. cnf_io, a Fortran90 code which reads or writes DIMACS Conjunctive Normal Form (CNF) files defining satisfiability problems in terms of a boolean formula.
  189. cnf_io_test
  190. codepack, a Fortran90 code which determine if two graphs are isomorphic.
  191. codepack_test
  192. collatz_recursive, a Fortran90 code which demonstrates recursive programming by considering the simple Collatz 3n+1 problem.
  193. collatz_recursive_test
  194. color_digraph_adj, a Fortran90 code which carries out operations on color digraphs, a directed graph in which each node has been assigned a color. That information is stored in an adjacency matrix in which the diagonal elements record colors. Operations include counting the colors, computing in- and out-degrees, computing the in- and out-degree sequences, counting the edges, printing the adjacency matrix, generating fixed and random examples.
  195. color_digraph_adj_test
  196. color_graph_adj, a Fortran90 code which carries out operations on color graphs, an undirected graph in which each node has been assigned a color. That information is stored in an adjacency matrix in which the diagonal elements record colors. Operations include counting the colors, computing degrees, computing the degree sequences, counting the edges, printing the adjacency matrix, generating fixed and random examples.
  197. color_digraph_adj_test
  198. colored_noise, a Fortran90 code which generates samples of noise obeying a 1/f^alpha power law.
  199. colored_noise_test
  200. colors, a Fortran90 code which converts between various formats for describing colors;
  201. colors_test
  202. combo, a Fortran90 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.
  203. combo_test
  204. communicator_mpi, a Fortran90 code which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.
  205. communicator_mpi_test
  206. compass_search, a Fortran90 code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
  207. compass_search_test
  208. complex_numbers_test, a Fortran90 code which demonstrates some simple features involved in the use of complex numbers.
  209. components, a Fortran90 code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
  210. components_test
  211. condition, a Fortran90 code which implements methods of computing or estimating the condition number of a matrix.
  212. condition_test
  213. continued_fraction, a Fortran90 code which deals with simple and generalized continued fractions.
  214. continued_fraction_test
  215. cordic, a Fortran90 code which computes a few special functions using the CORDIC algorithm.
  216. cordic_test
  217. cosine_transform, a Fortran90 code which demonstrates some simple properties of the discrete cosine transform (DCT).
  218. cosine_transform_test
  219. csv_io, a Fortran90 code which reads and writes files that use the Comma Separated Value (CSV) format.
  220. csv_io_test
  221. cube_exactness, a Fortran90 code which computes the polynomial exactness of quadrature rules over the interior of a cube in 3D.
  222. cube_exactness_test
  223. cube_grid, a Fortran90 code which computes a grid of points over the interior of a cube in 3D.
  224. cube_grid_test
  225. cube_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
  226. cube_integrals_test
  227. cube_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
  228. cube_monte_carlo_test
  229. cuda_loop, a Fortran90 code which shows how, in a CUDA program running on a Graphics Processing Unit (GPU), the choice of block and thread factors determines the allocation of tasks to processors.
  230. cuda_loop_test
  231. cvt, a Fortran90 code which computes elements of a Centroidal Voronoi Tessellation (CVT).
  232. cvt_test
  233. cvt_basis, a Fortran90 code which uses discrete Centroidal Voronoi Tessellation (CVT) techniques to produce a small set of basis vectors that are good cluster centers for a large set of data vectors;
  234. cvt_basis_test
  235. cvt_basis_flow, a Fortran90 code which extracts dominant solution modes from solutions of a flow problem governed by the Navier Stokes Equations (NSE) using Centroidal Voronoi Tessellation (CVT) methods.
  236. cvtp, a Fortran90 code which creates a Centroidal Voronoi Tessellation on a Periodic region (CVTP).
  237. cvtp_test
  238. cvt_triangulation, a Fortran90 code which applies Centroidal Voronoi Tessellation (CVT) techniques to the test_triangulation() set;
  239. cvt_triangulation_test
  240. cyclic_reduction, a Fortran90 code which solves a tridiagonal linear system using cyclic reduction.
  241. cyclic_reduction_test
  242. differ, a Fortran90 code which determines the finite difference method (FDM) coefficients necessary to compute an approximation of given accuracy to a derivative of a given order.
  243. differ_test
  244. digraph_adj, a Fortran90 code which carries out operations on digraphs, a directed graph. Information is stored in an adjacency matrix. Operations include computing in- and out-degrees, computing the in- and out-degree sequences, counting the edges, printing the adjacency matrix, generating fixed and random examples.
  245. digraph_adj_test
  246. digraph_arc, a Fortran90 code which carries out operations on digraphs, a directed graph. Information is stored in an arc list, pairs of nodes forming edges. Operations include computing in- and out-degrees, computing the in- and out-degree sequences, counting the edges, printing the arc list, generating fixed and random examples.
  247. digraph_arc_test
  248. dijkstra, a Fortran90 code which implements a simple version of the Dijkstra minimum distance algorithm for graphs.
  249. dijkstra_test
  250. discrete_pdf_sample_2d, a Fortran90 code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
  251. discrete_pdf_sample_2d_test
  252. disk_grid, a Fortran90 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.
  253. disk_grid_test
  254. disk_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the general disk in 2D;
  255. disk_monte_carlo_test
  256. disk01_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
  257. disk01_integrals_test
  258. disk01_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
  259. disk01_monte_carlo_test
  260. disk01_positive_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit positive disk in 2D;
  261. disk01_positive_monte_carlo_test
  262. distance_to_position, a Fortran90 code which estimates the positions of cities based on a city-to-city distance table.
  263. distance_to_position_test
  264. dream, a Fortran90 code which implements the DREAM algorithm for accelerating Markov Chain Monte Carlo (MCMC) convergence using differential evolution, using five user functions to define the problem, by Guannan Zhang.
  265. dream_test
  266. duel_simulation, a Fortran90 code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  267. duel_simulation_test
  268. dutch, a Fortran90 code which carries out tasks in computational geometry.
  269. dutch_test
  270. edge, a Fortran90 code which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities. It uses gnuplot() to display the jumps in curves and surfaces.
  271. edge_test
  272. ellipse, a Fortran90 code which carries out geometric calculations for ellipses and ellipsoids, including area, distance to a point, eccentricity, perimeter, points along the perimeter, random sampling, conversion between standard and quadratic forms.
  273. ellipse_test
  274. ellipse_grid, a Fortran90 code which computes grid points over the interior of an ellipse in 2D.
  275. ellipse_grid_test
  276. ellipse_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.
  277. ellipse_monte_carlo_test
  278. ellipsoid, a Fortran90 code which carries out geometric calculations for ellipsoids, including area, random sampling, conversion between standard and quadratic forms.
  279. ellipsoid_test
  280. ellipsoid_grid, a Fortran90 code which computes a grid of points over the interior of an ellipsoid in 3D.
  281. ellipsoid_grid_test
  282. ellipsoid_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
  283. ellipsoid_monte_carlo_test
  284. elliptic_integral, a Fortran90 code which evaluates complete elliptic integrals of first, second and third kind, using the Carlson elliptic integral functions.
  285. elliptic_integral_test
  286. etdrk4, a Fortran90 code which uses the ETD RK4 method to solve systems of stiff ordinary differential equations (ODE), by Aly-Khan Kassam, Lloyd Trefethen.
  287. etdrk4_test
  288. euler, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
  289. euler_test
  290. exactness, a Fortran90 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).
  291. exactness_test
  292. f90_exact, a Fortran90 code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
  293. f90_monte_carlo, a Fortran90 code which uses Monte Carlo sampling to estimate areas and integrals.
  294. f90_random_test, a Fortran90 code which calls the Fortran90 random number generator (RNG) routines.
  295. f90_simulation, a Fortran90 code which uses simulation to study card games, contests, and other processes which have a random element. Usually, the purpose is to try to predict the average behavior of the system over many trials.
  296. f90split, a Fortran90 code which reads a Fortran file and creates individual files for every blockdata, function, module, program, or subroutine in the file.
  297. f90split_test
  298. fair_dice_simulation, a Fortran90 code which simulates N games where two fair dice are thrown and summed, creating graphics files for processing by gnuplot().
  299. fair_dice_simulation_test
  300. fd_predator_prey, a Fortran90 code which solves a pair of predator prey ordinary differential equations (ODE) using the finite difference method (FDM), and plots the data with gnuplot().
  301. fd_predator_prey_test
  302. fd1d_advection_diffusion_steady, a Fortran90 code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot().
  303. fd1d_advection_diffusion_steady_test
  304. fd1d_advection_ftcs, a Fortran90 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the forward time centered space (FTCS) method, writing graphics files for processing by gnuplot().
  305. fd1d_advection_ftcs_test
  306. fd1d_advection_lax, a Fortran90 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to approximate the time derivative, writing graphics files for processing by gnuplot().
  307. fd1d_advection_lax_test
  308. fd1d_advection_lax_wendroff, a Fortran90 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to approximate the time derivative, writing graphics files for processing by gnuplot().
  309. fd1d_advection_lax_wendroff_test
  310. fd1d_burgers_lax, a Fortran90 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.
  311. fd1d_burgers_lax_test
  312. fd1d_burgers_leap, a Fortran90 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.
  313. fd1d_burgers_leap_test
  314. fd1d_bvp, a Fortran90 code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
  315. fd1d_bvp_test
  316. fd1d_heat_explicit, a Fortran90 code which implements a finite difference method (FDM), explicit in time, of the time dependent 1D heat equation;
  317. fd1d_heat_explicit_test
  318. fd1d_heat_implicit, a Fortran90 code which implements a finite difference method (FDM), implicit in time, of the time dependent 1D heat equation;
  319. fd1d_heat_implicit_test
  320. fd1d_heat_steady, a Fortran90 code which implements a finite difference method (FDM) for the steady time-independent 1D heat equation;
  321. fd1d_heat_steady_test
  322. fd1d_predator_prey, a Fortran90 code which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence, by Marcus Garvie.
  323. fd1d_predator_prey_test
  324. fd1d_wave, a Fortran90 code which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.
  325. fd1d_wave_test
  326. fd2d_heat_steady, a Fortran90 code which implements a finite difference method (FDM) for the steady time-independent 2D heat equation;
  327. fd2d_heat_steady_test
  328. fd2d_predator_prey, a Fortran90 code which implements the finite difference method (FDM) for a 2D predator-prey system, by Marcus Garvie.
  329. fd2d_predator_prey_test
  330. fem_basis, a Fortran90 code which defines and evaluates basis functions associated with the finite element method (FEM) for any degree in an M-dimensional simplex: 1D interval, 2D triangle, 3D tetrahedron, and higher dimensional generalizations.)
  331. fem_basis_test
  332. fem_io, a Fortran90 code which reads or writes FEM files, which describe the nodes, elements, and function values associated with a finite element method (FEM) model;
  333. fem_io_test
  334. fem_to_gmsh, a Fortran90 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.
  335. fem_to_gmsh_test
  336. fem_to_medit, a Fortran90 code which reads FEM files defining the node coordinates, boundary nodes, and elements of a finite element mesh, and rewrites the data as a medit() MESH file.
  337. fem_to_medit_test
  338. fem_to_tec, a Fortran90 code which converts FEM models into tecplot ASCII files.
  339. fem_to_tec_test
  340. fem_to_triangle, a Fortran90 code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for Jonathan Shewchuk's triangle() program
  341. fem_to_triangle_test
  342. 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().
  343. fem_to_xml_test
  344. fem1d, a Fortran90 code which applies the finite element method (FEM), using piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  345. fem1d_test
  346. fem1d_adaptive, a Fortran90 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;
  347. fem1d_adaptive_test
  348. fem1d_bvp_linear, a Fortran90 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.
  349. fem1d_bvp_linear_test
  350. fem1d_bvp_quadratic, a Fortran90 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.
  351. fem1d_bvp_quadratic_test
  352. fem1d_heat_steady, a Fortran90 code which implements the finite element method (FEM) for the steady time-independent 1D heat equation;
  353. fem1d_heat_steady_test
  354. fem1d_lagrange, a Fortran90 code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
  355. fem1d_lagrange_test
  356. fem1d_nonlinear, a Fortran90 code which applies the finite element method (FEM), with piecewise linear basis functions, to a nonlinear two point boundary value problem (BVP) in 1D;
  357. fem1d_nonlinear_test
  358. fem1d_pack, a Fortran90 code which contains utilities for 1D finite element method (FEM) calculations.
  359. fem1d_pack_test
  360. fem1d_pmethod, a Fortran90 code which applies the p-method version of the finite element method (FEM) to a linear two point boundary value problem (BVP) in 1D;
  361. fem1d_pmethod_test
  362. fem1d_project, a Fortran90 code which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.
  363. fem1d_project_test
  364. fem1d_sample, a Fortran90 code which samples a scalar or vector finite element function of one variable, defined by FEM files, returning interpolated values at the sample points.
  365. fem1d_sample_test
  366. fem2d_bvp_linear, a Fortran90 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.
  367. fem2d_bvp_linear_test
  368. fem2d_bvp_quadratic, a Fortran90 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.
  369. fem2d_bvp_quadratic_test
  370. fem2d_bvp_serene, a Fortran90 code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  371. fem2d_bvp_serene_test
  372. fem2d_heat, a Fortran90 code which uses the finite element method (FEM) and the backward Euler method to solve the time-dependent heat equation on an arbitrary triangulated region in 2D. The user supplies some information in some problem-dependent subroutines.
  373. fem2d_heat_test
  374. fem2d_heat_rectangle, a Fortran90 code which implements the finite element method (FEM) for the time dependent heat equation on a triangulated square in 2D;
  375. fem2d_heat_rectangle_test
  376. fem2d_pack, a Fortran90 code which implements simple 2D finite element method (FEM) calculations;
  377. fem2d_pack_test
  378. fem2d_poisson_rectangle, a Fortran90 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.
  379. fem2d_poisson_rectangle_test
  380. fem2d_poisson_rectangle_linear, a Fortran90 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.
  381. fem2d_poisson_rectangle_linear_test
  382. fem2d_sample, a Fortran90 code which samples at arbitray points a finite element function, defined by FEM files, three text files describing the nodes, triangles, and coefficients.
  383. fem2d_sample_test
  384. fem3d_pack, a Fortran90 code which contains utilities for 3D finite element method (FEM) calculations.
  385. fem3d_pack_test
  386. fem3d_sample, a Fortran90 code which evaluates a finite element function defined on a 3D tetrahedral mesh.
  387. fem3d_sample_test
  388. fftpack5, a Fortran90 code which computes Fast Fourier Transforms (FFTs), by Paul Swarztrauber and Dick Valent;
  389. fftpack5_test
  390. fftpack51, a Fortran90 code which computes Fast Fourier Transforms (FFTs), using real 64 bit arithmetic, by Paul Swarztrauber and Dick Valent;
  391. fftpack51_test
  392. fftw_test, a Fortran90 code which calls fftw(), which computes Fast Fourier Transforms (FFT), by Matteo Frigo and Steven Johnson.
  393. file_name_sequence, a Fortran90 code which demonstrates ways to generate a sequence of filenames, which can be useful when generating a sequence of still snapshots to be animated later.
  394. file_name_sequence_test
  395. filon_rule, a Fortran90 code which uses Filon's method to approximate integrals which include an oscillatory factor of sin(k*x) or cos(k*x).
  396. filon_rule_test
  397. filum, a Fortran90 code which performs various operations on files;
  398. filum_test
  399. fisher_exact, a Fortran90 code which returns an exact solution of the Kolmogorov Petrovsky Piskonov Fisher partial differential equation (PDE) ut=uxx+u*(1-u).
  400. fisher_exact_test
  401. flame_exact, a Fortran90 code which returns the exact solution of an ordinary differential equation (ODE) which models the growth of a ball of flame in a combustion process. The exact solution is defined in terms of the Lambert W function.
  402. flame_exact_test
  403. floyd, a Fortran90 code which implements the Floyd algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  404. floyd_test
  405. football_dynamic, a Fortran90 code which uses dynamic programming to count the ways of achieving a given score in football.
  406. football_dynamic_test
  407. football_rank, a Fortran90 code which is given a set of game scores, and produces a ranking of college football teams.
  408. football_rank_test
  409. freefem_msh_io, a Fortran90 code which reads and writes files used by FreeFem++ to store mesh information for the finite element method (FEM).
  410. freefem_msh_io_test
  411. fsolve, a Fortran90 code which solves systems of nonlinear equations, inspired by the fsolve() function in minpack(), with special interfaces fsolve_bdf2(), fsolve_be() and fsolve_tr() for handling systems associated with implicit ODE solvers of type bdf2, backward Euler, midpoint, or trapezoidal.
  412. fsolve_test
  413. fsplit, a Fortran90 code which reads a Fortran file and creates individual files for every function, program, or subroutine in the file, by Van Snyder.
  414. fsplit_test
  415. gauss_seidel, a Fortran90 code which implements the Gauss-Seidel iteration for linear systems.
  416. gauss_seidel_test
  417. gdb_test, a Fortran90 code which uses the GNU debugger;
  418. gegenbauer_cc, a Fortran90 code which computes the Gegenbauer weighted integral of a function f(x) using a Clenshaw-Curtis approach.
  419. gegenbauer_cc_test
  420. gegenbauer_exactness, a Fortran90 code which tests the polynomial exactness of Gauss-Gegenbauer quadrature rules.
  421. gegenbauer_exactness_test
  422. gegenbauer_polynomial, a Fortran90 code which evaluates the Gegenbauer polynomial and associated functions.
  423. gegenbauer_polynomial_test
  424. gegenbauer_rule, a Fortran90 code which computes and writes out a Gauss-Gegenbauer quadrature rule of given order.
  425. gegenbauer_rule_test
  426. gen_hermite_exactness, a Fortran90 code which tests the polynomial exactness of generalized Gauss-Hermite quadrature rules.
  427. gen_hermite_exactness_test
  428. gen_hermite_rule, a Fortran90 code which computes and writes out a generalized Gauss-Hermite quadrature rule of given order and parameter value.
  429. gen_hermite_rule_test
  430. gen_laguerre_exactness, a Fortran90 code which tests the polynomial exactness of generalized Gauss-Laguerre quadrature rules.
  431. gen_laguerre_exactness_test
  432. gen_laguerre_rule, a Fortran90 code which computes and writes out a generalized Gauss-Laguerre quadrature rule of given order and parameter value.
  433. gen_laguerre_rule_test
  434. gene_cluster, a Fortran90 code which clusters sets of genetic expression data;
  435. gene_cluster_test
  436. geometry, a Fortran90 code which performs geometric calculations in 2, 3 and M dimensional space, including the computation of angles, areas, containment, distances, intersections, lengths, and volumes.
  437. geometry_test
  438. geompack, a Fortran90 code which computes Delaunay triangulations, Voronoi diagrams, and other information, by Barry Joe.
  439. geompack_test
  440. gl_fast_rule, a Fortran90 code which carries out the rapid computation of the Kth value and weight of an N point Gauss-Legendre quadrature rule, by Ignace Bogaert.
  441. gl_fast_rule_test
  442. glomin, a Fortran90 code which finds a global minumum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  443. glomin_test
  444. gmsh_io, a Fortran90 code which reads or writes some of the files created by gmsh() for 1D, 2D or 3D meshes used by the finite element method (FEM).
  445. gmsh_io_test
  446. gmsh_to_fem, a Fortran90 code which reads a mesh data file created by gmsh() and writes a pair of node and element files that correspond to the FEM format.
  447. gmsh_to_fem_test
  448. graph_adj, a Fortran90 code which carries out operations on abstract graphs, with undirected edges, represented by an adjacency matrix. Operations include breadth-first search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure.
  449. graph_adj_test
  450. graph_arc, a Fortran90 code which carries out operations on graphs. Information is stored in an arc list, pairs of nodes forming edges. Operations include the chromatic polynomial, computing degrees, computing the degree sequence, counting the edges, determining edge and node connectivity, Euler circuits, spanning trees, shortest path, printing the arc list, generating fixed and random examples.
  451. graph_arc_test
  452. graph_dist, a Fortran90 code which carries out operations on abstract graphs, defined by undirected edges with an associated distance matrix.
  453. graph_dist_test
  454. graph_paper, a Fortran90 code which makes PostScript (PS) graph paper;
  455. graph_paper_test
  456. graph_theory, a Fortran90 code which carries out operations on abstract graphs, such as a breadth-first-search, the computation of a minimum spanning tree, an Euler or Hamilton circuit, blocks, chromatic polynomial, or transitive closure. Objects include undirected and directed graphs, weighted graphs, and trees.
  457. graph_theory_test
  458. graphics_dislin_test, a Fortran90 code which graphically displays various kinds of data, using the dislin() graphics library.
  459. graphics_gnuplot_test, a Fortran90 code which graphically displays various kinds of data, using the gnuplot() graphics program.
  460. grf_io, a Fortran90 code which reads or writes a grf file which represents a mathematical graph;
  461. grf_io_test
  462. grf_to_eps, a Fortran90 code which converts a grf file to Encapsulated PostScript (EPS) format;
  463. grf_to_eps_test
  464. haar_transform, a Fortran90 code which computes the Haar transform of 1d or 2d data.
  465. haar_transform_test
  466. halton, a Fortran90 code which computes elements of a Halton Quasi Monte Carlo (QMC) sequence, using a simple interface.
  467. halton_test
  468. hammersley, a Fortran90 code which computes elements of a Hammersley Quasi Monte Carlo (QMC) sequence, using a simple interface.
  469. hammersley_test
  470. hankel_cholesky, a Fortran90 code which computes the upper Cholesky factor R of a symmetric positive definite (SPD) Hankel matrix H so that H = R' * R.
  471. hankel_cholesky_test
  472. hankel_spd, a Fortran90 code which computes a lower triangular matrix L that is the Cholesky factor of a symmetric positive definite (SPD) Hankel matrix H, that is, H = L * L'.
  473. hankel_spd_test
  474. hb_io, a Fortran90 code which reads and writes sparse linear systems stored in the Harwell Boeing (HB) format for sparse matrices.
  475. hb_io_test
  476. hb_to_st, a Fortran90 code which converts a sparse matrix from Harwell Boeing (HB) format to Sparse Triplet (ST) format.
  477. hb_to_st_test
  478. heat_mpi, a Fortran90 code which solves the 1D time dependent heat equation in parallel, using the Message Passing Interface (MPI).
  479. heat_mpi_test
  480. heated_plate, a Fortran90 code which solves the steady (time independent) heat equation in a 2D rectangular region, and is intended as a starting point for implementing a parallel version.
  481. heated_plate_test
  482. heated_plate_openmp, a Fortran90 code which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.
  483. heated_plate_openmp_test
  484. hello, a Fortran90 code which prints out "Hello, world!".
  485. hello_test
  486. hello_mpi, a Fortran90 code which prints 'Hello, world!' using the Message Passing Interface (MPI) for parallel execution.
  487. hello_mpi_test
  488. hello_openmp, a Fortran90 code which prints 'Hello, world!', using OpenMP for parallel execution.
  489. hello_openmp_test
  490. hermite_cubic, a Fortran90 code which computes the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.
  491. hermite_cubic_test
  492. hermite_exactness, a Fortran90 code which tests the monomial exactness of quadrature rules for estimating Hermite-type integrals of a function f(x) with density rho(x)=exp(-x^2) over the interval (-oo,+oo).
  493. hermite_exactness_test
  494. hermite_integrands, a Fortran90 code which defines test integrands for Hermite integrals with density exp(-x^2) over the interval (-oo,+oo).
  495. hermite_integrands_test
  496. hermite_interpolant, a Fortran90 code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
  497. hermite_interpolant_test
  498. hermite_polynomial, a Fortran90 code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
  499. hermite_polynomial_test
  500. hermite_product_polynomial, a Fortran90 code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
  501. hermite_product_polynomial_test
  502. hexahedron_jaskowiec_rule, a Fortran90 code which returns a symmetric Jaskowiec quadrature rule for the hexahedron, with exactness up to total degree 21.
  503. hexahedron_jaskowiec_rule_test
  504. hexahedron_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the hexahedron, with exactness up to total degree 11.
  505. hexahedron_witherden_rule_test
  506. high_card_simulation, a Fortran90 code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; using gnuplot() for graphics.
  507. high_card_simulation_test
  508. humps, a Fortran90 code which evaluates the humps function, its first and second derivatives, and its antiderivative.
  509. humps_test
  510. hyper_2f1, a Fortran90 code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real or complex parameters a, b, c, and argument x, by N. Michel and M. Stoitsov.
  511. hyper_2f1_test
  512. hyperball_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.
  513. hyperball_integrals_test
  514. hyperball_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
  515. hyperball_monte_carlo_test
  516. hypercube_exactness, a Fortran90 code which tests the polynomial exactness of a quadrature rule over the interior of the unit hypercube in M dimensions.
  517. hypercube_exactness_test
  518. hypercube_grid, a Fortran90 code which computes a grid of points over the interior of a hypercube in M dimensions.
  519. hypercube_grid_test
  520. hypercube_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.
  521. hypercube_integrals_test
  522. hypercube_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.
  523. hypercube_monte_carlo_test
  524. hypergeometric, a Fortran90 code which evaluates the generalized hypergeometric functions pFq, for integer p and q, for complex arguments of large magnitude, by Warren Perger, Atul Bhalla, and Mark Nardin.
  525. hypergeometric_test
  526. hypersphere, a Fortran90 code which carries out various operations for an M dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
  527. hypersphere_test
  528. hypersphere_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.
  529. hypersphere_integrals_test
  530. hypersphere_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
  531. hypersphere_monte_carlo_test
  532. i4lib, a Fortran90 code which contains utilities which use single precision integer (I4) arithmetic.
  533. i4lib_test
  534. i8lib, a Fortran90 code which contains many utility routines, using double precision integer (I8) arithmetic.
  535. i8lib_test
  536. ice_io, a Fortran90 code which reads or writes an ICE dataset, which defines a 3D grid, using the netcdf() file format.
  537. ice_io_test
  538. ice_to_medit, a Fortran90 code which reads a netcdf() file containing an ICE dataset and rewrites the information as a medit() MESH file.
  539. ice_to_medit_test
  540. interp, a Fortran90 code which parameterizies and interpolates data;
  541. interp_test
  542. intlib, a Fortran90 code which carries out approximate integration (quadrature) in one dimension;
  543. intlib_test
  544. is_prime, a Fortran90 code which implements various versions of the sieve of Eratosthenes to determine whether a given integer is prime.
  545. is_prime_test
  546. ising_2d_simulation, a Fortran90 code which carries out a Monte Carlo simulation of an Ising model, a 2D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors, using gnuplot() to make images of the initial and final configurations.
  547. ising_2d_simulation_test
  548. ising_3d_simulation, a Fortran90 code which carries out a Monte Carlo simulation of an Ising model, a 3D array of positive and negative charges, each of which is likely to flip to be in agreement with neighbors.
  549. ising_3d_simulation_test
  550. jacobi, a Fortran90 code which implements the Jacobi method for the iterative solution of linear systems.
  551. jacobi_test
  552. jacobi_eigenvalue, a Fortran90 code which implements the Jacobi iteration for the determination of the eigenvalues and eigenvectors of a real symmetric matrix.
  553. jacobi_eigenvalue_test
  554. jacobi_exactness, a Fortran90 code which tests the monomial exactness of quadrature rules for integrals that include a Jacobi weight.
  555. jacobi_exactness_test
  556. jacobi_openmp, a Fortran90 code which uses OpenMP to parallelize a Jacobi iteration for solving A*x=b.
  557. jacobi_openmp_test
  558. jacobi_polynomial, a Fortran90 code which evaluates the Jacobi polynomial and associated functions.
  559. jacobi_polynomial_test
  560. jacobi_rule, a Fortran90 code which computes and print a Gauss-Jacobi quadrature rule.
  561. jacobi_rule_test
  562. kdv_exact, a Fortran90 code which evaluates exact solutions of the Korteweg-deVries (KdV) partial differential equation (PDE).
  563. kdv_exact_test
  564. kdv_ift, a FORTRAN90 code which uses the IFT method to solve the Korteweg-DeVries equation, by Aly-Khan Kassam, Lloyd Trefethen.
  565. kdv_ift_test
  566. ketel_one, a Fortran90 code which finds all words formed from the letters in "ketel one vodka";
  567. ketel_one_test
  568. kmeans, a Fortran90 code which handles the K-Means problem, which organizes N points in M dimensions into K clusters;
  569. kmeans_test
  570. knapsack_01_brute, a Fortran90 code which uses brute force to solve small versions of the 0/1 knapsack problem;
  571. knapsack_01_brute_test
  572. kronrod_rule, a Fortran90 code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  573. kronrod_rule_test
  574. lagrange_approx_1d, a Fortran90 code which evaluates the Lagrange polynomial p(x) of degree m which approximates n data points (x(i),y(i)).
  575. lagrange_approx_1d_test
  576. lagrange_interp_1d, a Fortran90 code which evaluates the Lagrange polynomial p(x) which interpolates data depending on a 1D argument, so that p(x(i)) = y(i).
  577. lagrange_interp_1d_test
  578. lagrange_interp_2d, a Fortran90 code which evaluates the Lagrange polynomial p(x,y) which interpolates data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).
  579. lagrange_interp_2d_test
  580. lagrange_interp_nd, a Fortran90 code which evaluates the Lagrange polynomial p(x) which interpolates data depending on a multidimensional argument that was evaluated on a product grid, so that p(x(i)) = z(i).
  581. lagrange_interp_nd_test
  582. lagrange_nd, a Fortran90 code which implements several multivariate Lagrange interpolation schemes developed by Tomas Sauer.
  583. lagrange_nd_test
  584. laguerre_exactness, a Fortran90 code which tests the monomial exactness of Gauss-Laguerre quadrature rules for estimating the integral of a function f(x) with density rho(x)=exp(-x) over the interval [0,+oo).
  585. laguerre_exactness_test
  586. laguerre_integrands, a Fortran90 code which implements test problems for Gauss-Laguerre quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
  587. laguerre_integrands_test
  588. laguerre_polynomial, a Fortran90 code which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
  589. laguerre_polynomial_test
  590. laguerre_rule, a Fortran90 code which computes and print a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
  591. laguerre_rule_test
  592. lambert_w, a Fortran90 code which evaluates Lambert's W function.
  593. lambert_w_test
  594. lapack_test, a Fortran90 code which calls lapack(), which is a standard linear algebra package for solving linear systems, computing matrix factorizations, and solving eigenvalue problems.
  595. lapack_d, a Fortran90 code which is the double precision real version of the LAPACK linear algebra code.
  596. laplacian, a Fortran90 code which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
  597. laplacian_test
  598. latin_center, a Fortran90 code which computes N points in an M dimensional Latin Center square;
  599. latin_center_test
  600. latin_cover, a Fortran90 code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
  601. latin_cover_test
  602. latin_edge, a Fortran90 code which returns N points in an M dimensional Latin Edge square;
  603. latin_edge_test
  604. latin_random, a Fortran90 code which returns N points in an M dimensional Latin Random square;
  605. latin_random_test
  606. latinize, a Fortran90 code which adjusts N points in M dimensions to form a Latin hypercube;
  607. latinize_test
  608. lattice_rule, a Fortran90 code which approximates M-dimensional integrals using lattice rules.
  609. lattice_rule_test
  610. lau_np, a Fortran90 code which implements heuristic algorithms for various NP-hard combinatorial problems, including the integer linear programming problem, the K-center problem, the K-median problem, the 0-1 knapsack problem, the multiple knapsack problem, the graph matching problem, the graph partitioning problem, the minimal Steiner tree problem, and the traveling salesman problem;
  611. lau_np_test
  612. laupack, a Fortran90 code which computes properties of mathematical graphs, including Euler circuits, Hamiltonian circuits, cliques, strongly connected components, minimal spanning tree, chromatic number, shortest paths, maximal flow, and planarity.
  613. laupack_test
  614. lcvt, a Fortran90 code which computes a Latinized Centroidal Voronoi Tessellation (CVT).
  615. lcvt_test
  616. lebesgue, a Fortran90 code which is given nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation, and which uses gnuplot() to make plots of the Lebesgue function.
  617. lebesgue_test
  618. legendre_exactness, a Fortran90 code which tests the monomial exactness of quadrature rules for estimating Legendre-type integrals of a function f(x) with density rho(x)=1 over the interval [-1,+1].
  619. legendre_exactness_test
  620. legendre_fast_rule, a Fortran90 code which uses a fast algorithm to compute a Gauss-Legendre quadrature rule for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
  621. legendre_fast_rule_test
  622. legendre_polynomial, a Fortran90 code which evaluates the Legendre polynomial and associated functions.
  623. legendre_polynomial_test
  624. legendre_product_polynomial, a Fortran90 code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
  625. legendre_product_polynomial_test
  626. legendre_rule, a Fortran90 code which computes Gauss-Legendre quadrature rules for estimating the integral of a function with density rho(x)=1 over the interval [-1,+1].
  627. legendre_rule_test
  628. legendre_shifted_polynomial, a Fortran90 code which evaluates the shifted Legendre polynomial, with domain [0,1].
  629. legendre_shifted_polynomial_test
  630. levenshtein_distance, a Fortran90 code which returns the Levenshtein distance between two strings.
  631. levenshtein_distance_test
  632. levenshtein_matrix, a Fortran90 code which returns the Levenshtein distance matrix defined by two strings.
  633. levenshtein_matrix_test
  634. line_cvt_lloyd, a Fortran90 code which applies the Lloyd iteration repeatedly to N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
  635. line_cvt_lloyd_test
  636. line_fekete_rule, a Fortran90 code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
  637. line_fekete_rule_test
  638. line_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule over the interior of a line segment in 1D.
  639. line_felippa_rule_test
  640. line_grid, a Fortran90 code which computes a grid of points over the interior of a line segment in 1D.
  641. line_grid_test
  642. line_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the length of the unit line in 1D.
  643. line_integrals_test
  644. line_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line in 1D.
  645. line_monte_carlo_test
  646. line_ncc_rule, a Fortran90 code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  647. line_ncc_rule_test
  648. line_nco_rule, a Fortran90 code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  649. line_nco_rule_test
  650. linear_algebra, Fortran90 codes which carry out various linear algebra operations for matrices stored in a variety of formats.
  651. llsq, a Fortran90 code which solves the simple linear least squares (LLS) problem of finding the formula of a straight line y=a*x+b which minimizes the root mean square error to N data points.
  652. llsq_test
  653. lobatto_polynomial, a Fortran90 code which evaluates Lobatto polynomials, similar to Legendre polynomials except that they are zero at both endpoints.
  654. lobatto_polynomial_test
  655. local_min, a Fortran90 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  656. local_min_test
  657. local_min_rc, a Fortran90 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
  658. local_min_rc_test
  659. log_normal, a Fortran90 code which returns quantities related to the log normal Probability Distribution Function (PDF).
  660. log_normal_test
  661. log_normal_truncated_ab, a Fortran90 code which returns quantities related to the log normal Probability Distribution Function (PDF) truncated to the interval [A,B].
  662. log_normal_truncated_ab_test
  663. lorenz_ode, a Fortran90 code which approximates solutions to the Lorenz system of ordinary differential equations (ODE), creating output files that can be displayed by gnuplot().
  664. lorenz_ode_test
  665. machar, a Fortran90 code which dynamically computes the values of various machine characteristic constants by William Cody;
  666. machar_test
  667. machine, a Fortran90 code which returns tabulated values of the constants associated with computer arithmetic;
  668. machine_test
  669. mandelbrot, a Fortran90 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set;
  670. mandelbrot_test
  671. mandelbrot_openmp, a Fortran90 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution.
  672. mandelbrot_openmp_test
  673. matman, a Fortran90 code which allows a user to interactively define and manipulate matrices using integer, real, or rational arithmetic, and to perform various operations in linear algebra or linear programming modes.
  674. matman_test
  675. matmul, a Fortran90 code which benchmarks matrix multiplication.
  676. matmul_test
  677. matrix_chain_dynamic, a Fortran90 code which finds the cost of the most efficient ordering to use when multiplying a sequence of matrices, using dynamic programming.
  678. matrix_chain_dynamic_test
  679. matrix_exponential, a Fortran90 code which demonstrates some simple approaches to the problem of computing the exponential of a matrix;
  680. matrix_exponential_test
  681. maze, a Fortran90 code which carries out operations on a maze, including the diameter, a random example, or a path that solves the maze.
  682. maze_test
  683. md, a Fortran90 code which carries out a molecular dynamics simulation, intended as a starting point for implementing a parallel version.
  684. md_test
  685. md_openmp, a Fortran90 code which carries out a molecular dynamics simulation, using OpenMP for parallel execution.
  686. md_openmp_test
  687. medit_mesh_io, a Fortran90 code which reads or writes medit() MESH files defining a finite element mesh.
  688. medit_mesh_io_test
  689. medit_to_fem, a Fortran90 code which reads a medit() MESH file and rewrites the information as an FEM file.
  690. medit_to_fem_test
  691. medit_to_ice, a Fortran90 code which reads a medit() MESH file containing an ICE dataset and rewrites the information as a netcdf() file.
  692. medit_to_ice_test
  693. mgmres, a Fortran90 code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
  694. mgmres_test
  695. mgs, a Fortran90 code which is an obscure legacy code, which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
  696. mgs_test
  697. middle_square, a Fortran90 code which implements the middle square algorithm for generating random integers. This is a very early method, attributed to von Neumann, which actually is deeply flawed, with short cycles.
  698. middle_square_test
  699. midpoint, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with a version of fsolve() handling the associated nonlinear equation, and using a fixed time step.
  700. midpoint_test
  701. midpoint_explicit, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
  702. midpoint_explicit_test
  703. midpoint_fixed, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a fixed point iteration for the nonlinear equation.
  704. midpoint_fixed_test
  705. minpack, a Fortran90 code which solves systems of nonlinear equations, or the least squares minimization of the residual of linear or nonlinear equations, by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
  706. minpack_test
  707. mm_io, a Fortran90 code which reads and writes sparse linear systems stored in the Matrix Market (MM) format.
  708. mm_io_test
  709. monomial, a Fortran90 code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
  710. monomial_test
  711. monomial_value, a Fortran90 code which evaluates a monomial in M dimensions.
  712. monomial_value_test
  713. multitask_mpi, a Fortran90 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using the message passing interface (MPI) for parallel execution.
  714. multitask_mpi_test
  715. multitask_openmp, a Fortran90 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.
  716. multitask_openmp_test
  717. mxm_openmp, a Fortran90 code which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
  718. mxm_openmp_test
  719. naca, a Fortran90 code which takes the parameters of certain NACA airfoils and returns the coordinates of a sequence of points that outline the wing shape. The data is displayed with the gnuplot() graphics program.
  720. naca_test
  721. nas, a Fortran90 code which runs the NASA kernel benchmark.
  722. nas_test
  723. navier_stokes_2d_exact, a Fortran90 code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 2D.
  724. navier_stokes_2d_exact_test
  725. navier_stokes_3d_exact, a Fortran90 code which evaluates an exact solution to the incompressible time-dependent Navier-Stokes equations (NSE) over an arbitrary domain in 3D.
  726. navier_stokes_3d_exact_test
  727. nearest_interp_1d, a Fortran90 code which interpolates data using a piecewise constant interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().
  728. nearest_interp_1d_test
  729. newton_interp_1d, a Fortran90 code which finds a polynomial interpolant to data using Newton divided differences.
  730. newton_interp_1d_test
  731. newton_rc, a Fortran90 code which solves a system of nonlinear equations by Newton's method, using reverse communication (RC).
  732. newton_rc_test
  733. niederreiter2, a Fortran90 code which computes elements of a Niederreiter Quasi Monte Carlo (QMC) sequence using base 2.
  734. niederreiter2_test
  735. nintlib, a Fortran90 code which implements approximate integration or quadrature in M dimensions;
  736. nintlib_test
  737. nms, a Fortran90 code which includes a wide variety of numerical software, including solvers for linear systems of equations, interpolation of data, numerical quadrature, linear least squares (LLS) data fitting, the solution of nonlinear equations, ordinary differential equations (ODE), optimization and nonlinear least squares (NLS), simulation and random numbers, trigonometric approximation and Fast Fourier Transforms (FFT).
  738. nms_test
  739. normal, a Fortran90 code which implements a random number generator (RNG) for normally distributed values;
  740. normal_test
  741. normal_dataset, a Fortran90 code which creates a multivariate normal random dataset and writes it to a file.
  742. normal_dataset_test
  743. ode, a Fortran90 code which solves a system of ordinary differential equations (ODE), by Shampine and Gordon;
  744. ode_test
  745. openmp_test, a Fortran90 code which uses OpenMP, which is an application program interface for carrying out parallel computations in a shared memory environment.
  746. optimize_test, a Fortran90 code which looks at the use of automatic optimization by the compiler to make the executable code run faster.
  747. ornstein_uhlenbeck, a Fortran90 code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SDE) using the Euler method and the Euler-Maruyama method, and creating graphics files for processing by gnuplot().
  748. ornstein_uhlenbeck_test
  749. owen, a Fortran90 code which evaluates the Owen T function.
  750. owen_test
  751. padua, a Fortran90 code which returns the coordinates of the 2D Padua points, as well as interpolation weights or quadrature weights, and images of the points in gnuplot() graphics files.
  752. padua_test
  753. partition_brute, a Fortran90 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.
  754. partition_brute_test
  755. patterson_rule, a Fortran90 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.
  756. patterson_rule_test
  757. pbma_io, a Fortran90 code which reads or writes graphics files that use the ASCII Portable Bit Map (PBM) format.
  758. pbma_io_test
  759. pce_burgers, a Fortran90 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.
  760. pce_burgers_test
  761. pce_ode_hermite, a Fortran90 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.
  762. pce_ode_hermite_test
  763. pdflib, a Fortran90 code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
  764. pdflib_test
  765. pentominoes, a Fortran90 code which forms or plots any of the 12 members of the pentomino family, shapes formed from 5 adjacent squares.
  766. pentominoes_test
  767. persistence, a Fortran90 code which demonstrates how to initialize, get, or set data stored within a function, using static/persistent/saved/local memory.
  768. persistence_test
  769. pgma_io, a Fortran90 code which reads or writes graphics files that use the ASCII Portable Gray Map (PGM) format.
  770. pgma_io_test
  771. pink_noise, a Fortran90 code which computes a pink noise signal obeying a 1/f power law.
  772. pink_noise_test
  773. plot_points, a Fortran90 code which makes an Encapsulated PostScript (EPS) plot of points in 2D.
  774. plot_points_test
  775. plot_to_ps, a Fortran90 code which reads simple text commands and creates a PostScript (PS) image;
  776. plot_to_ps_test
  777. poisson_1d_multigrid, a Fortran90 code which applies the multigrid method to a discretized version of the 1D Poisson equation.
  778. poisson_1d_multigrid_test
  779. poisson_openmp, a Fortran90 code which computes an approximate solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
  780. poisson_openmp_test
  781. poisson_simulation, a Fortran90 code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating output for graphics by gnuplot().
  782. poisson_simulation_test
  783. polpak, a Fortran90 code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Jacobi, Krawtchouk, Laguerre, Lambert, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling, Tau, Tribonacci, Zernike.
  784. polpak_test
  785. polygon, a Fortran90 code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, counter clockwise ordering, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling, and triangulation.
  786. polygon_test
  787. polygon_grid, a Fortran90 code which generates a grid of points over the interior of a polygon in 2D.
  788. polygon_grid_test
  789. polygon_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
  790. polygon_integrals_test
  791. polygon_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
  792. polygon_monte_carlo_test
  793. polygon_triangulate, a Fortran90 code which triangulates a possibly nonconvex polygon in 2D, and which uses gnuplot() to display the external edges and internal diagonals of the triangulation.
  794. polygon_triangulate_test
  795. polynomial, a Fortran90 code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  796. polynomial_test
  797. polynomial_conversion, a Fortran90 code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
  798. polynomial_conversion_test
  799. polynomial_root_bound, a Fortran90 code which computes the Cauchy bound on the magnitude of all roots of a polynomial with complex coefficients.
  800. polynomial_root_bound_test
  801. polynomials, a Fortran90 code which defines multivariate polynomials over rectangular domains, for which certain information is to be determined, such as the maximum and minimum values.
  802. polynomials_test
  803. polyominoes, a Fortran90 code which manipulates polyominoes and tilings.
  804. polyominoes_test
  805. power_method, a Fortran90 code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  806. power_method_test
  807. power_rule, a Fortran90 code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
  808. power_rule_test
  809. ppma_io, a Fortran90 code which reads or writes graphics files that use the ASCII Portable Pixel Map (PPM) format.
  810. ppma_io_test
  811. pppack, a Fortran90 code which computes piecewise polynomial functions, including cubic splines, by Carl deBoor.
  812. pppack_test
  813. praxis, a Fortran90 code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
  814. praxis_test
  815. predator_prey_ode, a Fortran90 code which solves a time-dependent predator-prey system of ordinary differential equations (ODE).
  816. predator_prey_ode_test
  817. prime, a Fortran90 code which counts the number of primes between 1 and N, and is intended as a starting point for a parallel version.
  818. prime_test
  819. prime_mpi, a Fortran90 code which counts primes between 1 and N, using Message Passing Interface (MPI) for parallel execution.
  820. prime_mpi_test
  821. prime_openmp, a Fortran90 code which counts primes between 1 and N, using OpenMP for parallel execution.
  822. prime_openmp_test
  823. prime_pi, a Fortran90 code which evaluates Pi(n), the number of primes less than or equal to an integer n.
  824. prime_pi_test
  825. prism_jaskowiec_rule, a Fortran90 code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of a prism with triangular base, by Jan Jaskowiec, Natarajan Sukumar.
  826. prism_jaskowiec_rule_test
  827. prism_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for a prism with triangular base, with exactness up to total degree 10.
  828. prism_witherden_rule_test
  829. prob, a Fortran90 code which evaluates, samples, inverts, and characterizes Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
  830. prob_test
  831. product_rule, a Fortran90 code which constructs a product quadrature rule from distinct 1D factor rules.
  832. product_rule_test
  833. puzzles, a Fortran90 code which was used to solve various puzzles.
  834. pwl_approx_1d, a Fortran90 code which approximates data using a piecewise linear function.
  835. pwl_approx_1d_test
  836. pwl_interp_1d, a Fortran90 code which interpolates data using a piecewise linear function.
  837. pwl_interp_1d_test
  838. pwl_interp_2d, a Fortran90 code which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.
  839. pwl_interp_2d_test
  840. pwl_interp_2d_scattered, a Fortran90 code which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.
  841. pwl_interp_2d_scattered_test
  842. pwl_product_integral, a Fortran90 code which calculates the exact value of the integral of the product of two piecewise linear functions f(x) and g(x).
  843. pwl_product_integral_test
  844. pyramid_exactness, a Fortran90 code which computes the monomial exactness of a quadrature rule over the interior of a pyramid in 3D.
  845. pyramid_exactness_test
  846. pyramid_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of a pyramid in 3D.
  847. pyramid_felippa_rule_test
  848. pyramid_grid, a Fortran90 code which computes a grid of points over the interior of the unit pyramid in 3D;
  849. pyramid_grid_test
  850. pyramid_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
  851. pyramid_integrals_test
  852. pyramid_jaskowiec_rule, a Fortran90 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.
  853. pyramid_jaskowiec_rule_test
  854. pyramid_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
  855. pyramid_monte_carlo_test
  856. pyramid_rule, a Fortran90 code which computes a conical product quadrature rule over the interior of the unit pyramid in 3D;
  857. pyramid_rule_test
  858. pyramid_witherden_rule, a Fortran90 code which returns a Witherden quadrature rule, with exactness up to total degree 10, over the interior of a pyramid.
  859. pyramid_witherden_rule_test
  860. qr_solve, a Fortran90 code which computes the linear least squares (LLS) solution of a system A*x=b.
  861. qr_solve_test
  862. quad, a Fortran90 code which approximates an integral using a quadrature rule, and is intended as a starting point for parallelization exercises.
  863. quad_test
  864. quad_mpi, a Fortran90 code which approximates an integral using a quadrature rule, and carries out the computation in parallel using the Message Passing Interface (MPI).
  865. quad_mpi_test
  866. quad_openmp, a Fortran90 code which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution.
  867. quad_openmp_test
  868. quad_rule, a Fortran90 code which implements rules for approximate integration (quadrature) in one dimension;
  869. quad_rule_test
  870. quad2d, a Fortran90 code which estimates an integral over a 2D rectangle using quadrature, intended as the starting point for program optimization or parallelization.
  871. quad2d_test
  872. quadmom, a Fortran90 code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
  873. quadmom_test
  874. quadpack, a Fortran90 code which estimates integrals using numerical quadrature, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.
  875. quadpack_test
  876. quadrature_golub_welsch, a Fortran90 code which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure, assuming that the points have been specified.
  877. quadrature_golub_welsch_test
  878. quadrature_least_squares, a Fortran90 code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
  879. quadrature_least_squares_test
  880. quadrature_weights_vandermonde, a Fortran90 code which computes the weights of a quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  881. quadrature_weights_vandermonde_test
  882. quadrature_weights_vandermonde_2d, a Fortran90 code which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  883. quadrature_weights_vandermonde_2d_test
  884. quadrilateral_mesh, a Fortran90 code which handles meshes of quadrilaterals over a 2D region;
  885. quadrilateral_mesh_test
  886. quadrilateral_mesh_rcm, a Fortran90 code which computes the Reverse Cuthill McKee (RCM) reordering for nodes in a mesh of 4-node quadrilaterals.
  887. quadrilateral_mesh_rcm_test
  888. quadrilateral_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the quadrilateral, with exactness up to total degree 21.
  889. quadrilateral_witherden_rule_test
  890. quality, a Fortran90 code which computes quality of distribution measures for pointsets in M dimensions;
  891. quality_test
  892. quaternions, a Fortran90 code which carries out some simple arithmetic operations for quaternions.
  893. quaternions_test
  894. quotes, a Fortran90 code which prints a random quote from a file;
  895. quotes_test
  896. r83, a Fortran90 code which contains linear algebra routines for r83 matrices (real, 64 bit, tridiagonal 3xN format).
  897. r83_test
  898. r83_np, a Fortran90 code which contains linear algebra routines for r83_np matrices (real, 64 bit, tridiagonal 3xN format, nonpivoting factorization).
  899. r83_np_test
  900. r83p, a Fortran90 code which contains linear algebra routines for r83p matrices (real, 64 bit, tridiagonal periodic format).
  901. r83p_test
  902. r83s, a Fortran90 code which contains linear algebra routines for r83s matrices (real, 64 bit, tridiagonal scalar format).
  903. r83s_test
  904. r83t, a Fortran90 code which contains linear algebra routines for r83t matrices (real, 64 bit, tridiagonal Mx3 format).
  905. r83t_test
  906. r83v, a Fortran90 code which contains linear algebra routines for r83v matrices (real, 64 bit, tridiagonal three vector format).
  907. r83v_test
  908. r85, a Fortran90 code which contains linear algebra routines for r85 matrices (real, 64 bit, pentadiagonal format).
  909. r85_test
  910. r8bb, a Fortran90 code which contains linear algebra routines for r8bb matrices (real, 64 bit, border banded format).
  911. r8bb_test
  912. r8blt, a Fortran90 code which contains linear algebra routines for r8blt matrices (real, 64 bit, band lower triangular format).
  913. r8blt_test
  914. r8bto, a Fortran90 code which contains linear algebra routines for r8bto matrices (real, 64 bit, block Toeplitz format).
  915. r8bto_test
  916. r8but, a Fortran90 code which contains linear algebra routines for r8but matrices (real, 64 bit, band upper triangular format).
  917. r8but_test
  918. r8cb, a Fortran90 code which contains linear algebra routines for r8cb matrices (real, 64 bit, Compressed Band format).
  919. r8cb_test
  920. r8cbb, a Fortran90 code which contains linear algebra routines for r8cbb matrices (real, 64 bit, Compressed Border Banded format).
  921. r8cbb_test
  922. r8ccs, a Fortran90 code which contains linear algebra routines for r8ccs matrices (real, 64 bit, Compressed Column Storage (Colptr,Row,Value) format).
  923. r8ccs_test
  924. r8ci, a Fortran90 code which contains linear algebra routines for r8ci matrices (real, 64 bit, circulant format).
  925. r8ci_test
  926. r8col, a Fortran90 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.
  927. r8col_test
  928. r8gb, a Fortran90 code which contains linear algebra routines for r8gb matrices (real, 64 bit, General Banded format).
  929. r8gb_test
  930. r8gd, a Fortran90 code which contains linear algebra routines for r8gd matrices (real, 64 bit, general diagonal format).
  931. r8gd_test
  932. r8ge, a Fortran90 code which contains linear algebra routines for R8GE matrices (real, 64 bit, General format).
  933. r8ge_test
  934. r8lib, a Fortran90 code which contains many utility routines, using double precision real (R8) arithmetic.
  935. r8lib_test
  936. r8lt, a Fortran90 code which contains linear algebra routines for R8LT matrices (real, 64 bit, Lower Triangular).
  937. r8lt_test
  938. r8ltt, a Fortran90 code which contains linear algebra routines for r8ltt matrices (real, 64 bit, lower triangular Toeplitz format).
  939. r8ltt_test
  940. r8ncf, a Fortran90 code which contains linear algebra routines for r8ncf matrices (real, 64 bit, nonsymmetric coordinate format).
  941. r8ncf_test
  942. r8pbl, a Fortran90 code which contains linear algebra routines for r8pbl matrices (real, 64 bit, symmetric positive definite (SPD) band lower format).
  943. r8pbl_test
  944. r8pbu, a Fortran90 code which contains linear algebra routines for r8pbu matrices (real, 64 bit, symmetric positive definite (SPD) band upper format).
  945. r8pbu_test
  946. r8po, a Fortran90 code which contains linear algebra routines for r8po matrices (real, 64 bit, symmetric positive definite (SPD) format).
  947. r8po_test
  948. r8poly, a Fortran90 code which operates on real polynomials, including evaluation, differentiation, integration, multiplication, synthetic division, shifting the base, computing a power, taking the norm. It also defines Chebyshev, Lagrange and Legendre polynomials.
  949. r8poly_test
  950. r8pp, a Fortran90 code which contains linear algebra routines for r8pp matrices (real, 64 bit, symmetric positive definite (SPD) packed format).
  951. r8pp_test
  952. r8ri, a Fortran90 code which contains linear algebra routines for r8ri matrices (real, 64 bit, row indexed format).
  953. r8ri_test
  954. r8row, a Fortran90 code which contains utilities 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.
  955. r8row_test
  956. r8sd, a Fortran90 code which contains linear algebra routines for r8sd matrices (real, 64 bit, symmetric diagonal format).
  957. r8sd_test
  958. r8sm, a Fortran90 code which contains linear algebra routines for r8sm matrices (real, 64 bit, Sherman-Morrison A-u*v' format).
  959. r8sm_test
  960. r8sr, a Fortran90 code which carries out linear algebra operations for r8sr matrices (real, 64 bit, diagonal + compressed row offdiagonal format).
  961. r8sr_test
  962. r8ss, a Fortran90 code which carries out linear algebra operations for r8ss matrices (real, 64 bit, symmetric skyline format).
  963. r8ss_test
  964. r8st, a Fortran90 code which contains linear algebra routines for R8ST matrices (real, 64 bit, Sparse Triplet).
  965. r8st_test
  966. r8sto, a Fortran90 code which contains linear algebra routines for r8sto matrices (real, 64 bit, symmetric Toeplitz N format).
  967. r8sto_test
  968. r8to, a C code which contains linear algebra routines for r8to matrices (real, 64 bit, Toeplitz 2*N-1 format).
  969. r8to_test
  970. r8ut, a Fortran90 code which contains linear algebra routines for r8ut matrices (real, 64 bit, Upper Triangular).
  971. r8ut_test
  972. r8utp, a Fortran90 code which carries out linear algebra operations on r8utp matrices, real 64 bit, Upper Triangular Packed format.
  973. r8utp_test
  974. r8utt, a Fortran90 code which contains linear algebra routines for r8utt matrices (real, 64 bit, upper triangular Toeplitz format).
  975. r8utt_test
  976. r8vm, a Fortran90 code which contains linear algebra routines for r8vm matrices (real, 64 bit, Vandermonde format).
  977. r8vm_test
  978. randlc, a Fortran90 code which implements a random number generator (RNG) used by the nas() benchmarks.
  979. randlc_test
  980. random_data, a Fortran90 code which uses a random number generator (RNG) to sample points distributed according to various probability density functions (PDF), spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.
  981. random_data_test
  982. random_mpi, a Fortran90 code which generates the same sequence of values from a random number generator (RNG) for both sequential execution and parallel execution under the Message Passing Interface (MPI).
  983. random_mpi_test
  984. random_openmp, a Fortran90 code which generates multiple distinct streams of random numbers using OpenMP for parallel execution.
  985. random_openmp_test
  986. random_sorted, a Fortran90 code which uses a random number generator (RNG) to create a vector of random values which are already sorted.
  987. random_sorted_test
  988. ranlib, a Fortran90 code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
  989. ranlib_test
  990. ranmap, a Fortran90 code which creates PostScript (PS) images of iterated affine mappings, including the Barnsley fractal fern and the Levy dragon.
  991. ranmap_test
  992. rbf_interp_1d, a Fortran90 code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
  993. rbf_interp_1d_test
  994. rbf_interp_2d, a Fortran90 code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
  995. rbf_interp_2d_test
  996. rbf_interp_nd, a Fortran90 code which defines and evaluates radial basis function (RBF) interpolants to multidimensional data.
  997. rbf_interp_nd_test
  998. reactor_simulation, a Fortran90 code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This was provided as an example with the book 'Numerical Methods and Software'.
  999. reactor_simulation_test
  1000. reformat, a Fortran90 code which makes a copy of a file with a given number of words per line.
  1001. reformat_test
  1002. region, a Fortran90 code which reads 3D magnetic resonance imaging (MRI) voxel data, and groups the voxels into connected regions, called components or segments;
  1003. region_test
  1004. ring_mpi, a Fortran90 code which uses the Message Passing Interface (MPI), and measures the time necessary to copy data around a ring of processes.
  1005. ring_mpi_test
  1006. rk4, a Fortran90 code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE).
  1007. rk4_test
  1008. rkf45, a Fortran90 code which applies a Runge-Kutta-Fehlberg (RKF) solver to a system of ordinary differential equations (ODE);
  1009. rkf45_test
  1010. rnglib, a Fortran90 code which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
  1011. rnglib_test
  1012. root_rc, a Fortran90 code which seeks a solution of a scalar nonlinear equation f(x) = 0, or a system of nonlinear equations, using reverse communication (RC), by Gaston Gonnet.
  1013. root_rc_test
  1014. roots_rc, a Fortran90 code which seeks a solution of a system of nonlinear equations f(x) = 0, using reverse communication (RC), by Gaston Gonnet.
  1015. roots_rc_test
  1016. row_echelon_integer, a Fortran90 code which carries out the exact computation of the integer row echelon form (IREF) and integer reduced row echelon form (IRREF) of an integer matrix.
  1017. row_echelon_integer_test
  1018. sandia_cubature, a Fortran90 code which computes M-dimensional quadrature rules for certain regions and weight functions.
  1019. sandia_cubature_test
  1020. sandia_cvt, a Fortran90 code which positions a given number of points in an arbitrary region, using probabilistic Centroidal Voronoi Tessellation (CVT) techniques to achieve good coverage and separation; developed for Sandia National Laboratory;
  1021. sandia_cvt_test
  1022. sandia_rules, a Fortran90 code which produces 1D quadrature rules of Chebyshev, Clenshaw Curtis, Fejer 2, Gegenbauer, generalized Hermite, generalized Laguerre, Hermite, Jacobi, Laguerre, legendre and Patterson types.
  1023. sandia_rules_test
  1024. sandia_sgmgg, a Fortran90 code which explores a generalized construction method for sparse grids.
  1025. sandia_sgmgg_test
  1026. sandia_sparse, a Fortran90 code which produces a M-dimensional sparse grid, based on a variety of 1D quadrature rules; only isotropic grids are generated, that is, the same rule is used in each dimension, and the same maximum order is used in each dimension.
  1027. sandia_sparse_test
  1028. satisfy_brute, a Fortran90 code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
  1029. satisfy_brute_test
  1030. satisfy_mpi, a Fortran90 code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using the Message Passing Interface (MPI) to work in parallel.
  1031. satisfy_mpi_test
  1032. satisfy_openmp, a Fortran90 code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using OpenMP for parallel execution.
  1033. satisfy_openmp_test
  1034. schedule_openmp, a Fortran90 code which demonstrates the default, static, and dynamic methods of scheduling loop iterations in OpenMP to avoid work imbalance.
  1035. schedule_openmp_test
  1036. sde, a Fortran90 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;
  1037. sde_test
  1038. search_mpi, a Fortran90 code which searches integers between A and B for a value J such that F(J) = C, using MPI for parallel execution.
  1039. search_mpi_test
  1040. set_theory, a Fortran90 code which demonstrates various set theoretic operations using several models of a set.
  1041. set_theory_test
  1042. sftpack, a Fortran90 code which implements the slow Fourier transform, intended as a teaching tool and comparison with the Fast Fourier Transform (FFT).
  1043. sftpack_test
  1044. shallow_water_1d, a Fortran90 code which simulates the evolution of a 1D fluid governed by the time-dependent shallow water equations.
  1045. shallow_water_1d_test
  1046. shepard_interp_1d, a Fortran90 code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
  1047. shepard_interp_1d_test
  1048. shepard_interp_2d, a Fortran90 code which defines and evaluates Shepard interpolants to 2D data, based on inverse distance weighting.
  1049. shepard_interp_2d_test
  1050. shepard_interp_nd, a Fortran90 code which defines and evaluates Shepard interpolants to multidimensional data, based on inverse distance weighting.
  1051. shepard_interp_nd_test
  1052. simplex_coordinates, a Fortran90 code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  1053. simplex_coordinates_test
  1054. simplex_gm_rule, a Fortran90 code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or a simplex in M dimensions.
  1055. simplex_gm_rule_test
  1056. simplex_grid, a Fortran90 code which generates a regular grid of points over the interior of an arbitrary simplex in M dimensions.
  1057. simplex_grid_test
  1058. simplex_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.
  1059. simplex_integrals_test
  1060. simplex_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate an integral over the interior of the unit simplex in M dimensions.
  1061. simplex_monte_carlo_test
  1062. sine_gordon_exact, a Fortran90 code which returns an exact solution of the Sine-Gordon equation, a partial differential equation (PDE) of the form uxy=sin(u).
  1063. sine_gordon_exact_test
  1064. sine_transform, a Fortran90 code which demonstrates some simple properties of the discrete sine transform (DST).
  1065. sine_transform_test
  1066. slap, a Fortran90 code which forms the Sparse Linear Algebra Package (SLAP), for the iterative solution of sparse linear systems, by Anne Greenbaum and Mark Seager.
  1067. slap_test
  1068. slap_io, a Fortran90 code which reads and writes sparse matrix files in the SLAP format;
  1069. slap_io_test
  1070. slatec, a FORTRAN90 code which collects standard numerical libraries, including blas(), bvsup(), dassl(), depac(), drive(), eispack(), fftpack(), fishpack(), fnlib(), linpack(), machine(), minpack(), mp(), pchip(), pppack(), quadpack(), slap(), sos(), splp(), and xerror().
  1071. slatec_test
  1072. snakes_and_ladders, a Fortran90 code which provides tools for the study of the game of Snakes and Ladders.
  1073. snakes_and_ladders_test
  1074. sncndn, a Fortran90 code which evaluates the Jacobi elliptic functions SN, CN, and DN.
  1075. sncndn_test
  1076. sobol, a Fortran90 code which computes elements of a Sobol Quasi Monte Carlo (QMC) sequence, by Bennett Fox.
  1077. sobol_test
  1078. solve, a Fortran90 code which demonstrates how Gauss elimination can be used to solve a linear system A*x=b.
  1079. solve_test
  1080. sort_rc, a Fortran90 code which sorts a list of any kind of objects, using reverse communication (RC).
  1081. sort_rc_test
  1082. sparse_display, a Fortran90 code which reads information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is similar to the MATLAB spy() command.
  1083. sparse_display_test
  1084. sparse_grid_cc, a Fortran90 code which creates sparse grids based on Clenshaw-Curtis rules.
  1085. sparse_grid_cc_test
  1086. sparse_grid_gl, a Fortran90 code which creates sparse grids based on Gauss-legendre rules.
  1087. sparse_grid_gl_test
  1088. sparse_grid_hermite, a Fortran90 code which creates sparse grids based on Gauss-Hermite rules.
  1089. sparse_grid_hermite_test
  1090. sparse_grid_hw, a Fortran90 code which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
  1091. sparse_grid_hw_test
  1092. sparse_grid_laguerre, a Fortran90 code which creates sparse grids based on Gauss-Laguerre rules.
  1093. sparse_grid_laguerre_test
  1094. sparse_grid_mixed, a Fortran90 code which creates a sparse grid dataset based on a mixed set of 1D factor rules.
  1095. sparse_grid_mixed_test
  1096. sparse_interp_nd, a Fortran90 code which defines a sparse interpolant to a function f(x) of a multidimensional argument.
  1097. sparse_interp_nd_test
  1098. specfun, a Fortran90 code which computes special functions, including Bessel I, J, K and Y functions, and the Dawson, E1, EI, Erf, Gamma, log Gamma, Psi/Digamma functions, by William Cody and Laura Stoltz;
  1099. specfun_test
  1100. special_functions, a Fortran90 code which evaluates special functions, including Airy, Associated Legendre, Bernoulli Numbers, Bessel, Beta, Complete Elliptic Integral, Cosine Integral, Elliptic Integral, Error, Euler Numbers, Exponential Integral, Fresnel Integral, Gamma, Hankel, Hermite polynomials, Hypergeometric 2F1, Incomplete Beta, Incomplete Gamma, Jacobian Elliptic, Kelvin, Kummer Confluent Hypergeometric, Laguerre polynomials, Lambda, Legendre functions, Legendre polynomials, Mathieu, Modified Spherical Bessel, Parabolic Cylinder, Psi, Riccati-Bessel, Sine Integral, Spheroidal Angular, Spheroidal Wave, Struve, Tricomi Confluent Hypergeometric, Whittaker, by Shanjie Zhang, Jianming Jin;
  1101. special_functions_test
  1102. sphere_cubed_grid, a Fortran90 code which uses the projection of a cube to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.
  1103. sphere_cubed_grid_test
  1104. sphere_cvt, a Fortran90 code which uses a Centroidal Voronoi Tessellation (CVT) to generate a mesh of well-separated points on the surface of the unit sphere in 3D.
  1105. sphere_cvt_test
  1106. sphere_delaunay, a Fortran90 code which reads a file containing the coordinates of points on the surface of the unit sphere in 3D, computes the Delaunay triangulation, and outputs a PostScript (PS) file of the image;
  1107. sphere_delaunay_test
  1108. sphere_exactness, a Fortran90 code which tests the monomial exactness of a quadrature rule over the surface of the unit sphere in 3D.
  1109. sphere_exactness_test
  1110. sphere_fibonacci_grid, a Fortran90 code which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.
  1111. sphere_fibonacci_grid_test
  1112. sphere_grid, a Fortran90 code which generates grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.
  1113. sphere_grid_test
  1114. sphere_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
  1115. sphere_integrals_test
  1116. sphere_lebedev_rule, a Fortran90 code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
  1117. sphere_lebedev_rule_test
  1118. sphere_llq_grid, a Fortran90 code which uses longitudes and latitudes to create grids of points, lines, and quadrilaterals on the surface of the unit sphere in 3D.
  1119. sphere_llq_grid_test
  1120. sphere_llt_grid, a Fortran90 code which uses longitudes and latitudes to create grids of points, lines, and triangles on the surface of the unit sphere in 3D.
  1121. sphere_llt_grid_test
  1122. sphere_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D;
  1123. sphere_monte_carlo_test
  1124. sphere_quad, a Fortran90 code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D;
  1125. sphere_quad_test
  1126. sphere_stereograph, a Fortran90 code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
  1127. sphere_stereograph_test
  1128. sphere_triangle_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D;
  1129. sphere_triangle_monte_carlo_test
  1130. sphere_triangle_quad, a Fortran90 code which uses quadrature to estimate the integral of a function over a spherical triangle on the surface of the unit sphere in 3D.
  1131. sphere_triangle_quad_test
  1132. sphere_voronoi, a Fortran90 code which reads a file containing the coordinates of points on the surface of the unit sphere in 3D, computes the Voronoi diagram, and outputs a PostScript (PS) file of the image;
  1133. sphere_voronoi_test
  1134. spiral_exact, a Fortran90 code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
  1135. spiral_exact_test
  1136. spline, a Fortran90 code which interpolates and approximates via splines;
  1137. spline_test
  1138. square_arbq_rule, a Fortran90 code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  1139. square_arbq_rule_test
  1140. square_exactness, a Fortran90 code which computes the polynomial exactness of quadrature rules for f(x,y) over the interior of a quadrilateral in 2D.
  1141. square_exactness_test
  1142. square_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule over the interior of a square in 2D.
  1143. square_felippa_rule_test
  1144. square_grid, a Fortran90 code which computes a grid of points over the interior of a square in 2D.
  1145. square_grid_test
  1146. square_hex_grid, a Fortran90 code which computes a hexagonal grid of points over the interior of a square in 2D.
  1147. square_hex_grid_test
  1148. square_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit square or symmetric unit square in 2D.
  1149. square_integrals_test
  1150. square_minimal_rule, a Fortran90 code which returns almost minimal quadrature rules, with exactness up to total degree 55, over the interior of the symmetric square in 2D, by Mattia Festa and Alvise Sommariva.
  1151. square_minimal_rule_test
  1152. square_monte_carlo, a Fortran90 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.
  1153. square_monte_carlo_test
  1154. square_symq_rule, a Fortran90 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.
  1155. square_symq_rule_test
  1156. ss_gd_align, a Fortran90 code which implements some of the linear space alignment algorithms described in the reference by Chao.
  1157. ss_gd_align_test
  1158. ss_gg_align, a Fortran90 code which implements the sequence/sequence global gap alignment, one of the string matching algorithms described in the reference by Chao.
  1159. ss_gg_align_test
  1160. ss_lg_align, a Fortran90 code which implements the sequence/sequence local alignment, one of the string matching algorithms described by Chao.
  1161. ss_lg_align_test
  1162. ss_qg_align, a FORTRAN90 code which implements the sequence/sequence global gap alignment, one of the string matching algorithms described by Chao.
  1163. ss_qg_align_test
  1164. st_io, a Fortran90 code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
  1165. st_io_test
  1166. st_to_ccs, a Fortran90 code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format;
  1167. st_to_ccs_test
  1168. st_to_hb, a Fortran90 code which converts a sparse matrix file from Sparse Triplet (ST) format to Harwell Boeing (HB) format;
  1169. st_to_hb_test
  1170. steam, a Fortran90 code which computes steam table properties including pressure and density, based on a National Bureau of Standards (NBS) package;
  1171. steam_test
  1172. stiff_ode, a Fortran90 code which considers an ordinary differential equation (ODE) which is an example of a stiff ODE.
  1173. stiff_ode_test
  1174. stla_io, a Fortran90 code which reads and writes the 3D graphics information in an ASCII stereolithography (STL) file;
  1175. stla_io_test
  1176. stokes_2d_exact, a Fortran90 code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
  1177. stokes_2d_exact_test
  1178. string_pde, a Fortran90 code which sets up and solves the partial differential equations (PDE) describing a vibrating string, creating files that can be displayed by gnuplot().
  1179. string_pde_test
  1180. stripack, a Fortran90 code which computes the Delaunay triangulation or Voronoi diagram of points on a unit sphere, by Robert Renka.
  1181. stripack_test
  1182. stroud, a Fortran90 code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
  1183. stroud_test
  1184. subset, a Fortran90 code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems.
  1185. subset_test
  1186. subset_sum, a Fortran90 code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  1187. subset_sum_test
  1188. subset_sum_backtrack, a Fortran90 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.
  1189. subset_sum_backtrack_test
  1190. subset_sum_brute, a Fortran90 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.
  1191. subset_sum_brute_test
  1192. svd_basis, a Fortran90 code which applies the singular value decomposition (SVD) to a collection of data vectors, extracting dominant modes;
  1193. svd_basis_test
  1194. svd_basis_weight, a Fortran90 code which applies the singular value decomposition (SVD) to a collection of weighted data vectors, extracting dominant modes;
  1195. svd_basis_weight_test
  1196. svd_snowfall, a Fortran90 code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD), displaying the results using gnuplot().
  1197. svd_snowfall_test
  1198. svd_test, a Fortran90 code which demonstrates the Singular Value Decomposition (SVD).
  1199. svd_truncated, a Fortran90 code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
  1200. svd_truncated_test
  1201. table_columns, a Fortran90 code which reads a table file of N points in M dimensions and creates a new file by copying various columns, with repetition and shuffling;
  1202. table_columns_test
  1203. table_io, a Fortran90 code which reads and writes data as a table file.
  1204. table_io_test
  1205. table_quality, a Fortran90 code which reads a table file of N points in M dimensions and computes the uniformity of the placement of the points;
  1206. table_quality_test
  1207. tec_to_fem, a Fortran90 code which converts a tecplot ASCII file into an FEM model.
  1208. tec_to_fem_test
  1209. test_approx, a Fortran90 code which implements test problems for approximation, provided as (x,y) data.
  1210. test_approx_test
  1211. test_eigen, a Fortran90 code which implements test matrices for eigenvalue analysis.
  1212. test_eigen_test
  1213. test_int, a Fortran90 code which implements test problems for approximate integration in one dimension.
  1214. test_int_test
  1215. test_int_2d, a Fortran90 code which implements test problems for approximate integration in two dimensions.
  1216. test_int_2d_test
  1217. test_interp, a Fortran90 code which defines test problems for interpolation, provided as (x,y(x)) data.
  1218. test_interp_test
  1219. test_interp_1d, a Fortran90 code which defines test problems for interpolation of data y(x), which depends on a 1D argument.
  1220. test_interp_1d_test
  1221. test_interp_2d, a Fortran90 code which defines test problems for interpolation of data z(x,y), depending on a 2D argument.
  1222. test_interp_2d_test
  1223. test_interp_nd, a Fortran90 code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
  1224. test_interp_nd_test
  1225. test_lls, a Fortran90 code which implements linear least squares (LLS) test problems of the form A*x=b.
  1226. test_lls_test
  1227. test_matrix, a Fortran90 code which defines test matrices for which the condition number, determinant, eigenvalues, eigenvectors, inverse, null vectors, P*L*U factorization or linear system solution are known. Examples include the Fibonacci, Hilbert, Redheffer, Vandermonde, Wathen and Wilkinson matrices.
  1228. test_matrix_test
  1229. test_matrix_exponential, a Fortran90 code which defines test cases for computing the matrix exponential.
  1230. test_matrix_exponential_test
  1231. test_mesh, a Fortran90 code which implements some sample 2D meshes.
  1232. test_mesh_test
  1233. test_min, a Fortran90 code which implements test problems for minimization of a scalar function of a scalar variable.
  1234. test_min_test
  1235. test_nearest, a Fortran90 code which tests the time complexity of various procedures for solving the nearest neighbor problem.
  1236. test_nearest_test
  1237. test_nint, a Fortran90 code which implements test problems for approximate integration (quadrature) in M dimensions.
  1238. test_nint_test
  1239. test_nls, a Fortran90 code which implements nonlinear least squares (NLS) test problems.
  1240. test_nls_test
  1241. test_nonlin, a Fortran90 code which implements test problems for the solution of systems of nonlinear equations.
  1242. test_nonlin_test
  1243. test_ode, a FORTRAN90 code which defines a set of test initial value problems for ordinary differential equations (ODE).
  1244. test_ode_test
  1245. test_opt, a Fortran90 code which implements test problems for optimization of a scalar function of several variables.
  1246. test_opt_test
  1247. test_opt_con, a Fortran90 code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
  1248. test_opt_con_test
  1249. test_optimization, a Fortran90 code which implements test problems for optimization of a scalar function of several variables, as described by Molga and Smutnicki.
  1250. test_optimization_test
  1251. test_partial_digest, a Fortran90 code which generates cases of the partial digest problem.
  1252. test_partial_digest_test
  1253. test_tet_mesh, a Fortran90 code which implements test problems for tetrahedralization or meshing of arbitrary regions in 3 dimensions.
  1254. test_tet_mesh_test
  1255. test_triangulation, a Fortran90 code which implements test problems for triangularization or meshing of arbitrary regions in 2 dimensions.
  1256. test_triangulation_test
  1257. test_values, a Fortran90 code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, 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.
  1258. test_values_test
  1259. test_zero, a Fortran90 code which implements test problems for the solution of a single nonlinear equation in one variable.
  1260. test_zero_test
  1261. tester, a BASH script which runs the test codes.
  1262. tet_mesh, a Fortran90 code which carries out various tasks associated with tetrahedral meshes in 3D;
  1263. tet_mesh_test
  1264. tet_mesh_boundary, a Fortran90 code which determines the triangular mesh that bounds a tet mesh.
  1265. tet_mesh_boundary_test
  1266. tet_mesh_quad, a Fortran90 code which estimates the integral of a function over a region defined by a tetrahedral mesh.
  1267. tet_mesh_quad_test
  1268. tet_mesh_quality, a Fortran90 code which reads information about a tet mesh of points in 3D and computes various quality measures;
  1269. tet_mesh_quality_test
  1270. tet_mesh_to_gmsh, a Fortran90 code which writes a tetrahedral mesh to a gmsh() file.
  1271. tet_mesh_to_gmsh_test
  1272. tet_mesh_to_xml, a Fortran90 code which writes a tetrahedral mesh to an XML file.
  1273. tet_mesh_to_xml_test
  1274. tetrahedron, a Fortran90 code which computes properties, including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume, of a tetrahedron in 3D.
  1275. tetrahedron_test
  1276. tetrahedron_arbq_rule, a Fortran90 code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
  1277. tetrahedron_arbq_rule_test
  1278. tetrahedron_exactness, a Fortran90 code which computes the monomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.
  1279. tetrahedron_exactness_test
  1280. tetrahedron_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of a tetrahedron in 3D.
  1281. tetrahedron_felippa_rule_test
  1282. tetrahedron_grid, a Fortran90 code which computes a grid of points over the interior of a tetrahedron in 3D.
  1283. tetrahedron_grid_test
  1284. tetrahedron_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
  1285. tetrahedron_integrals_test
  1286. tetrahedron_jaskowiec_rule, a Fortran90 code which returns quadrature rules, with exactness up to total degree 20, over the interior of a tetrahedron in 3D, by Jan Jaskowiec, Natarajan Sukumar.
  1287. tetrahedron_jaskowiec_rule_test
  1288. tetrahedron_keast_rule, a Fortran90 code which returns a Keast quadrature rule, with exactness between 0 and 8, over the interior of a tetrahedron in 3D.
  1289. tetrahedron_keast_rule_test
  1290. tetrahedron_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate an integral over the interior of a general tetrahedron in 3D.
  1291. tetrahedron_monte_carlo_test
  1292. tetrahedron_ncc_rule, a Fortran90 code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a tetrahedron in 3D.
  1293. tetrahedron_ncc_rule_test
  1294. tetrahedron_nco_rule, a Fortran90 code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a tetrahedron in 3D.
  1295. tetrahedron_nco_rule_test
  1296. tetrahedron_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the tetrahedron, with exactness up to total degree 10.
  1297. tetrahedron_witherden_rule_test
  1298. tetrahedron01_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate an integral over the interior of the unit tetrahedron in 3D.
  1299. tetrahedron01_monte_carlo_test
  1300. three_body_ode, a Fortran90 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.
  1301. three_body_ode_test
  1302. timer_test, a Fortran90 code which tests various timing functions.
  1303. timestamp, a Fortran90 code which prints the current YMDHMS date as a timestamp.
  1304. timestamp_test
  1305. toeplitz, a Fortran90 code solves a variety of Toeplitz and circulant linear systems.
  1306. toeplitz_test
  1307. toeplitz_cholesky, a Fortran90 code which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.
  1308. toeplitz_cholesky_test
  1309. toms097, a Fortran90 code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using the Floyd algorithm.
  1310. toms097_test
  1311. toms112, a Fortran90 code which determines whether a point is contained in a polygon, by Moshe Shimrat. This is a version of ACM TOMS algorithm 112.
  1312. toms112_test
  1313. toms178, a Fortran90 code which optimizes a scalar functional of multiple variables using the Hooke-Jeeves method, by Arthur Kaupe. This is a version of ACM TOMS algorithm 178.
  1314. toms178_test
  1315. toms179, a Fortran90 code which evaluates the modified Beta function, by Oliver Ludwig. This is a version of ACM TOMS algorithm 179.
  1316. toms179_test
  1317. toms243, a Fortran90 code which evaluates the logarithm of a complex value, by David Collens. This is a version of ACM TOMS algorithm 243.
  1318. toms243_test
  1319. toms291, a Fortran90 code which evaluates the logarithm of the Gamma function, by Malcolm Pike and David Hill. This is a version of ACM TOMS algorithm 291.
  1320. toms291_test
  1321. toms419, a Fortran90 code which seeks all the zeroes of a polynomial with complex coefficients; this is commonly called cpoly(); this is a version of ACM TOMS algorithm 419, by Jenkins and Traub.
  1322. toms419_test
  1323. toms443, a Fortran90 code which evaluates the Lambert W function, by Fritsch, Shafer and Crowley. This is a version of ACM TOMS algorithm 443.
  1324. toms443_test
  1325. toms446, a Fortran90 code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
  1326. toms446_test
  1327. toms453, a Fortran90 code which determines the abscissas and weights for a Gaussian quadrature formula for the Bromwich integral; this is a version of ACM TOMS algorithm 453.
  1328. toms453_test
  1329. toms462, a Fortran90 code which evaluates the upper right tail of the bivariate normal Probability Density Function (PDF); that is, the probability that normal variables X and Y with correlation R will satisfy H <= X and K <= Y; this is a version of ACM TOMS algorithm 462.
  1330. toms462_test
  1331. toms515, a Fortran90 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.
  1332. toms515_test
  1333. toms526, a Fortran90 code which interpolates scattered bivariate data. This is a version of ACM TOMS algorithm 526, by Hiroshi Akima;
  1334. toms526_test
  1335. toms577, a Fortran90 code which evaluates the Carlson elliptic integral functions RC, RD, RF and RJ. This is a version of ACM TOMS algorithm 577;
  1336. toms577_test
  1337. toms611, a Fortran90 code which seeks the minimizer of a scalar functional of multiple variables. This is a version of ACM TOMS algorithm 611, by David Gay.
  1338. toms611_test
  1339. toms647, a Fortran90 code which evaluates Faure, Halton and Sobol Quasi Monte Carlo (QMC) sequences. This is a version of ACM TOMS algorithm 647.
  1340. toms647_test
  1341. toms655, a Fortran90 code which computes the weights for interpolatory quadrature rules; this is commonly called IQPACK, by Sylvan Elhay and Jaroslav Kautsky. This is a version of ACM TOMS algorithm 655.
  1342. toms655_test
  1343. toms659, a Fortran90 code which computes elements of the Sobol Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 659.
  1344. toms659_test
  1345. toms660, a Fortran90 code which takes scattered 2D data and produces an interpolating function F(X,Y). This is a version of ACM TOMS algorithm 660, called qshep2d, by Robert Renka.
  1346. toms660_test
  1347. toms661, a Fortran90 code which takes scattered 3D data and produces an interpolating function F(X,Y,Z). This is a version of ACM TOMS algorithm 661, called qshep3d, by Robert Renka.
  1348. toms661_test
  1349. toms672, a Fortran90 code which generates an interpolatory quadrature rule of highest possible order, given preassigned abscissas. This can be used to generate Gauss-Kronrod and Gauss-Patterson quadrature rules. This is commonly called EXTEND. This is a version of ACM TOMS algorithm 672.
  1350. toms672_test
  1351. toms708, a Fortran90 code which computes the incomplete Beta function ratio Ix(a,b).
  1352. toms708_test
  1353. toms715, a Fortran90 code which evaluates special functions, including the Bessel I, J, K, and Y functions of order 0, of order 1, and of any real order, the Dawson integral, the error function, exponential integrals, the gamma function, the normal distribution function, the psi function. This is a version of ACM TOMS algorithm 715.
  1354. toms715_test
  1355. toms726, a Fortran90 code which computes recursion coefficients for orthogonal polynomials, and the abscissa and weights for related quadrature rules. by Walter Gautschi. This is commonly called ORTHPOL. This is a version of ACM TOMS algorithm 726.
  1356. toms726_test
  1357. toms738, a Fortran90 code which evaluates the Niederreiter Quasi Monte Carlo (QMC) sequence; this is a version of ACM TOMS algorithm 738;
  1358. toms738_test
  1359. toms743, a Fortran90 code which evaluates the Lambert W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
  1360. toms743_test
  1361. toms757, a Fortran90 code which evaluates uncommon special functions, by Allan Mcleod; this is a version of ACM TOMS algorithm 757;
  1362. toms757_test
  1363. toms792, a Fortran90 code which tests functions that interpolate scattered data in the plane; by Robert Renka; this is a version of ACM TOMS algorithm 792.
  1364. toms792_test
  1365. toms886, a Fortran90 code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
  1366. toms886_test
  1367. trapezoidal, a Fortran90 code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and a version of fsolve() to handle the nonlinear equation.
  1368. trapezoidal_test
  1369. treepack, a Fortran90 code which defines, analyzes, and manipulates trees, a simple kind of graph with no circuits. Special cases include rooted and binary trees. Representations include adjacency, arc, Pruefer code, and parent. Operations include center, diameter, eccentricity, enumeration, generation one at a time, random selection, traversal.
  1370. treepack_test
  1371. tri_surface_io, a Fortran90 code which reads and writes the 3D graphics information in a tri_surface file;
  1372. tri_surface_io_test
  1373. triangle, a Fortran90 code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
  1374. triangle_test
  1375. triangle_analyze, a Fortran90 code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
  1376. triangle_analyze_test
  1377. triangle_dunavant_rule, a Fortran90 code which defines Dunavant rules for quadrature over the interior of a triangle in 2D.
  1378. triangle_dunavant_rule_test
  1379. triangle_exactness, a Fortran90 code which computes the monomial exactness quadrature rule over the interior of a triangle in 2D.
  1380. triangle_exactness_test
  1381. triangle_fekete_rule, a Fortran90 code which defines a Fekete rule for interpolation or quadrature over the interior of a triangle in 2D.
  1382. triangle_fekete_rule_test
  1383. triangle_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of a triangle in 2D.
  1384. triangle_felippa_rule_test
  1385. triangle_grid, a Fortran90 code which computes a grid of points over the interior of a triangle in 2D.
  1386. triangle_grid_test
  1387. triangle_histogram, a Fortran90 code which computes histograms of data over the interior of the unit triangle in 2D.
  1388. triangle_histogram_test
  1389. triangle_integrals, a Fortran90 code which returns the exact value of the integral of any polynomial over the interior of an arbitrary triangle in 2D.
  1390. triangle_integrals_test
  1391. triangle_interpolate, a Fortran90 code which shows how vertex data can be interpolated at any point in the interior of a triangle.
  1392. triangle_interpolate_test
  1393. triangle_io, a Fortran90 code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
  1394. triangle_io_test
  1395. triangle_lyness_rule, a Fortran90 code which returns a Lyness-Jespersen quadrature rule over the interior of a triangle in 2D.
  1396. triangle_lyness_rule_test
  1397. triangle_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate an integral over the interior of a general triangle in 2D.
  1398. triangle_monte_carlo_test
  1399. triangle_ncc_rule, a Fortran90 code which defines Newton-Cotes Closed (NCC) quadrature rules over the interior of a triangle in 2D.
  1400. triangle_ncc_rule_test
  1401. triangle_nco_rule, a Fortran90 code which defines Newton-Cotes Open (NCO) quadrature rules over the interior of a triangle in 2D.
  1402. triangle_nco_rule_test
  1403. triangle_svg, a Fortran90 code which uses Scalable Vector Graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
  1404. triangle_svg_test
  1405. triangle_symq_rule, a Fortran90 code which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of an arbitrary triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
  1406. triangle_symq_rule_test
  1407. triangle_to_fem, a Fortran90 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
  1408. triangle_to_fem_test
  1409. triangle_to_medit, a Fortran90 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh, and writes a corresponding medit() MESH file.
  1410. triangle_to_medit_test
  1411. triangle_to_xml, a Fortran90 code which reads the NODE and ELE files created by Jonathan Shewchuk's triangle() program to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by dolfin() or fenics().
  1412. triangle_to_xml_test
  1413. triangle_twb_rule, a Fortran90 code which generates the points and weights of quadrature rules over the interior of a triangle in 2D, determined by Taylor, Wingate, and Bos.
  1414. triangle_twb_rule_test
  1415. triangle_wandzura_rule, a Fortran90 code which returns Wandzura quadrature rules of exactness 5, 10, 15, 20, 25 or 30 over the interior of the triangle in 2D.
  1416. triangle_wandzura_rule_test
  1417. triangle_witherden_rule, a Fortran90 code which returns a symmetric Witherden quadrature rule for the triangle, with exactness up to total degree 20.
  1418. triangle_witherden_rule_test
  1419. triangle01_integrals, a Fortran90 code which returns the integral of any monomial over the interior of the unit triangle in 2D.
  1420. triangle01_integrals_test
  1421. triangle01_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate an integral over the interior of the unit triangle in 2D.
  1422. triangle01_monte_carlo_test
  1423. triangulation, a Fortran90 code which computes the triangulation 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.
  1424. triangulation_test
  1425. triangulation_l2q, a Fortran90 code which reads information about a 3-node (linear) triangulation and creates data defining a corresponding 6-node (quadratic) triangulation;
  1426. triangulation_l2q_test
  1427. triangulation_plot, a Fortran90 code which plots the nodes and elements of a triangulation as a PostScript (PS) file;
  1428. triangulation_plot_test
  1429. triangulation_q2l, a Fortran90 code which reads information about a 6-node triangulation and creates data defining a corresponding 3-node triangulation;
  1430. triangulation_q2l_test
  1431. triangulation_quad, a Fortran90 code which reads information about a triangulation and the value of a function at the nodes and estimates the integral of the function over the triangulated region.
  1432. triangulation_quad_test
  1433. triangulation_quality, a Fortran90 code which reads information about a triangulation and computes various quality measures;
  1434. triangulation_quality_test
  1435. triangulation_svg, a Fortran90 code which creates an SVG image of a triangulation, which can be displayed by a web browser.
  1436. triangulation_svg_test
  1437. truncated_normal, a Fortran90 code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
  1438. truncated_normal_test
  1439. truncated_normal_rule, a Fortran90 code which computes a quadrature rule for a normal probability density function (PDF), also called a Gaussian distribution, that has been truncated to [A,+oo), (-oo,B] or [A,B].
  1440. truncated_normal_rule_test
  1441. tsp_brute, a Fortran90 code which reads a file of city-to-city distances and solves a (small!) traveling salesperson problem (TSP), using brute force.
  1442. tsp_brute_test
  1443. tsp_lau, a Fortran90 code which implements a heuristic algorithm for the solution of the traveling salesperson problem (TSP).
  1444. tsp_lau_test
  1445. ubvec, a Fortran90 code which demonstrates how unsigned binary vectors, strings of 0 and 1, represent nonnegative integers or subsets or other mathematical objects, for which various arithmetic and logical operations can be defined.
  1446. ubvec_test
  1447. unicycle, a Fortran90 code which considers permutations containing a single cycle, sometimes called cyclic permutations.
  1448. unicycle_test
  1449. uniform, a Fortran90 code which implements random number generators (RNG) for a variety of arithmetic types.
  1450. uniform_test
  1451. van_der_corput, a Fortran90 code which computes elements of a 1D van der Corput Quasi Monte Carlo (QMC) sequence using a simple interface.
  1452. van_der_corput_test
  1453. vandermonde, a Fortran90 code which implements the Bjork-Pereyra algorithm for accurate solution of linear systems involving the Vandermonde matrix.
  1454. vandermonde_test
  1455. vandermonde_approx_1d, a Fortran90 code which finds a polynomial approximant to data y(x) of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  1456. vandermonde_approx_1d_test
  1457. vandermonde_approx_2d, a Fortran90 code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  1458. vandermonde_approx_2d_test
  1459. vandermonde_interp_1d, a Fortran90 code which finds a polynomial interpolant to data y(x) of a 1D argument by setting up and solving a linear system for the polynomial coefficients involving the Vandermonde matrix, creating graphics files for processing by gnuplot().
  1460. vandermonde_interp_1d_test
  1461. vandermonde_interp_2d, a Fortran90 code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients involving the Vandermonde matrix.
  1462. vandermonde_interp_2d_test
  1463. walker_sample, a Fortran90 code which efficiently samples a discrete probability vector using Walker sampling.
  1464. walker_sample_test
  1465. walsh_transform, a Fortran90 code which implements the Walsh data transform.
  1466. walsh_transform_test
  1467. wathen_matrix, a Fortran90 code which compares storage schemes (full, banded, sparse triplet ) and solution strategies (Linpack full, Linpack banded, conjugate gradient) for linear systems involving the Wathen matrix, which can arise when solving a problem using the finite element method (FEM).
  1468. wathen_matrix_test
  1469. wave_mpi, a Fortran90 code which uses the finite difference method (FDM) to estimate a solution to the wave equation, using the Message Passing Interface (MPI) for parallel execution.
  1470. wave_mpi_test
  1471. wavelet, a Fortran90 code which does some simple calculations with wavelet transforms;
  1472. wavelet_test
  1473. wedge_exactness, a Fortran90 code which investigates the polynomial exactness of a quadrature rule over the interior of the unit wedge in 3D.
  1474. wedge_exactness_test
  1475. wedge_felippa_rule, a Fortran90 code which returns a Felippa quadrature rule for approximating integrals over the interior of the unit wedge in 3D.
  1476. wedge_felippa_rule_test
  1477. wedge_grid, a Fortran90 code which computes a grid of points over the interior of the unit wedge in 3D.
  1478. wedge_grid_test
  1479. wedge_integrals, a Fortran90 code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
  1480. wedge_integrals_test
  1481. wedge_monte_carlo, a Fortran90 code which uses the Monte Carlo method to estimate an integral over the interior of the unit wedge in 3D.
  1482. wedge_monte_carlo_test
  1483. weekday, a Fortran90 code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, which was a Saturday.
  1484. weekday_test
  1485. wishart_matrix, a Fortran90 code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
  1486. wishart_matrix_test
  1487. wordsnake, a Fortran90 code which tries to find a good solution to the "Wordsnake Puzzle", in which a list of words is reordered, trying to maximize the overlap of successive words.
  1488. wordsnake_test
  1489. wtime, a Fortran90 code which returns a reading of the wall clock time in seconds.
  1490. wtime_test
  1491. xerror, a Fortran90 code which reports and handles errors detected during execution.
  1492. xerror_test
  1493. zero_brent, a Fortran90 code which seeks a solution of a scalar nonlinear equation f(x)=0, by Richard Brent.
  1494. zero_brent_test
  1495. zero_chandrupatla, a Fortran90 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
  1496. zero_chandrupatla_test
  1497. zero_itp, a Fortran90 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
  1498. zero_itp_test
  1499. zero_laguerre, a Fortran90 code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
  1500. zero_laguerre_test
  1501. zero_muller, a Fortran90 code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
  1502. zero_muller_test
  1503. zero_rc, a Fortran90 code which seeks a solution of a scalar nonlinear equation f(x)=0, using reverse communication (RC), by Richard Brent.
  1504. zero_rc_test
  1505. zoomin, a Fortran90 code which seeks the zero of a function.
  1506. zoomin_test


Last revised on 01 April 2024.