Fortran77 Source Codes


  1. analemma, a Fortran77 code which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data files that can be plotted with gnuplot(), based on a C program by Brian Tung.
  2. analemma_test
  3. args, a Fortran77 code which reports the command line arguments of a Fortran77 program;
  4. args_test
  5. asa005, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the noncentral T Probability Density Function (PDF), by BE Cooper. This is a version of Applied Statistics Algorithm 5;
  6. asa005_test
  7. asa006, a Fortran77 code which computes the Cholesky factorization of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 6;
  8. asa006_test
  9. asa007, a Fortran77 code which computes the inverse of a symmetric positive definite (SPD) matrix, by Michael Healy. This is a version of Applied Statistics Algorithm 7.
  10. asa007_test
  11. asa032, a Fortran77 code which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a version of Applied Statistics Algorithm 32.
  12. asa032_test
  13. asa047, a Fortran77 code which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a version of Applied Statistics Algorithm 47.
  14. asa047_test
  15. asa053, a Fortran77 code which produces sample matrices from the Wishart distribution, by William Smith and Ronald Hocking. This is a version of Applied Statistics Algorithm 53.
  16. asa053_test
  17. asa058, a Fortran77 code which implements the K-means data clustering algorithm, by David Sparks. This is a version of Applied Statistics Algorithm 58.
  18. asa058_test
  19. asa063, a Fortran77 code which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a version of Applied Statistics Algorithm 63.
  20. asa063_test
  21. asa066, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the normal probability distribution, by David Hill. This is a version of Applied Statistics Algorithm 66.
  22. asa066_test
  23. asa076, a Fortran77 code which evaluates the Owen T function, needed to compute the Cumulative Density Function (CDF) of the noncentral T distribution, by Young and Minder. This is a version of Applied Statistics Algorithm 76.
  24. asa076_test
  25. asa082, a Fortran77 code which computes the determinant of an orthogonal matrix; this is a version of Applied Statistics Algorithm 82, by J C Gower.
  26. asa082_test
  27. asa091, a Fortran77 code which evaluates the percentage points of the Chi-Squared distribution, by Best and Roberts. This is a version of Applied Statistics Algorithm 91.
  28. asa091_test
  29. asa103, a Fortran77 code which evaluates the digamma or psi function, by Jose Bernardo. This is a version of Applied Statistics Algorithm 103.
  30. asa103_test
  31. asa109, a Fortran77 code which inverts the incomplete Beta function, by Cran, Martin and Thomas. This is a version of Applied Statistics Algorithm 109.
  32. asa109_test
  33. asa111, a Fortran77 code which evaluates the percentage points of the normal distribution, by Beasley and Springer. This is a version of Applied Statistics Algorithm 111.
  34. asa111_test
  35. asa113, a Fortran77 code which implements a clustering algorithm using transfers and swaps, by Banfield and Bassill. This is a version of Applied Statistics Algorithm 113.
  36. asa113_test
  37. asa121, a Fortran77 code which evaluates the trigamma function, by BE Schneider. This is a version of Applied Statistics Algorithm 121.
  38. asa121_test
  39. asa136, a Fortran77 code which implements a clustering algorithm, by Hartigan and Wong. This is a version of Applied Statistics Algorithm 136.
  40. asa136_test
  41. asa144, a Fortran77 code which randomly generates an RxC contingency table, by James Boyett. This is a version of Applied Statistics Algorithm 144.
  42. asa144_test
  43. asa147, a Fortran77 code which evaluates the incomplete Gamma function, by Chi Leung Lau. This is a version of Applied Statistics Algorithm 147.
  44. asa147_test
  45. asa152, a Fortran77 code which evaluates the Probability Density Function (PDF) and Cumulative Density Function (CDF) associated with the hypergeometric distribution, by Richard Lund; this is a version of Applied Statistics Algorithm 152.
  46. asa152_test
  47. asa159, a Fortran77 code which randomly generates an RxC contingency table, by Michael Patefield; This is a version of Applied Statistics Algorithm 159.
  48. asa159_test
  49. asa172, a Fortran77 code which generates all M-dimensional indices in a given range, simulating the behavior of an arbitrary number of nested loops, by OFlaherty and MacKenzie. this is a version of Applied Statistics Algorithm 172;
  50. asa172_test
  51. asa183, a Fortran77 code which implements a random number generator (RNG), by Wichman and Hill. This is a version of Applied Statistics Algorithm 183.
  52. asa183_test
  53. asa189, a Fortran77 code which estimates the parameters of a beta binomial distribution based on a sample of values generated by the distribution, by D Smith; this is a version of Applied Statistics Algorithm 189;
  54. asa189_test
  55. asa205, a Fortran77 code which generates all the contingency tables corresponding to a given set of row and column sums. This is a version of Applied Statistics Algorithm 205;
  56. asa205_test
  57. asa226, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Russell Lenth. This is a version of Applied Statistics Algorithm 226.
  58. asa226_test
  59. asa239, a Fortran77 code which evaluates the incomplete Gamma function, by Shea. This is a version of Applied Statistics Algorithm 239.
  60. asa239_test
  61. asa241, a Fortran77 code which evaluates the percentage points of the normal distribution, by Michael Wichura. This is a version of Applied Statistics Algorithm 241.
  62. asa241_test
  63. asa243, a Fortran77 code which evaluates the Cumulative Density Function (CDF) of the noncentral T distribution, by Russell Lenth; this is a version of Applied Statistics Algorithm 243.
  64. asa243_test
  65. asa245, a Fortran77 code which evaluates the logarithm of the Gamma function, by Allan Mcleod; this is a version of Applied Statistics Algorithm 245.
  66. asa245_test
  67. asa266, a Fortran77 code which evaluates various properties of the Dirichlet Probability Density Function (PDF); This is a version of Applied Statistics Algorithm 266.
  68. asa266_test
  69. asa299, a Fortran77 code which computes the lattice points in an M-dimensional simplex, by Chasalow and Brand; this is a version of Applied Statistics Algorithm 299;
  70. asa299_test
  71. asa310, a Fortran77 code which computes the Cumulative Density Function (CDF) of the noncentral Beta distribution, by Chattamvelli and Shanmugam; this is a version of Applied Statistics Algorithm 310.
  72. asa310_test
  73. asa314, a Fortran77 code which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a version of Applied Statistics Algorithm 314;
  74. asa314_test
  75. atkinson, a Fortran77 code which contains examples from Atkinson's Elementary Numerical Analysis text.
  76. atkinson_test
  77. backtrack_binary_rc, a Fortran77 code which carries out a backtrack search for a set of binary decisions, using reverse communication (RC).
  78. backtrack_binary_rc_test
  79. backward_euler, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward Euler method, using a version of fsolve() for the implicit equation.
  80. backward_euler_test
  81. ball_grid, a Fortran77 code which computes grid points inside a 3D ball.
  82. ball_grid_test
  83. ball_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit ball in 3D.
  84. ball_integrals_test
  85. ball_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit ball in 3D;
  86. ball_monte_carlo_test
  87. band_qr, a Fortran77 code which computes the QR factorization of a banded matrix, and can solve related linear systems, by Alfredo Remon, Enrique Quintana-Orti, Gregorio Quintana-Orti.
  88. band_qr_test
  89. barycentric_interp_1d, a Fortran77 code which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.
  90. barycentric_interp_1d_test
  91. bdf2, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) backward difference formula of order 2 (BDF2), using fsolve() to solve the implicit equation.
  92. bdf2_test
  93. bdmlib, a Fortran77 code which estimates the weights in a Dirichlet mixtured based on sample data;
  94. bdmlib_test
  95. bellman_ford, a Fortran77 code which implements the Bellman-Ford algorithm for finding the shortest distance from a given node to all other nodes in a directed graph whose edges have been assigned real-valued lengths.
  96. bellman_ford_test
  97. bernstein_polynomial, a Fortran77 code which evaluates the Bernstein polynomials;
  98. bernstein_polynomial_test
  99. beta_nc, a Fortran77 code which evaluates the cumulative density function (CDF) of the noncentral Beta distribution;
  100. beta_nc_test
  101. biharmonic_fd2d, a Fortran77 library which solves a version of the biharmonic equation in two dimensions, by Petter Bjorstad. I could not get this code to run a simple test case!
  102. biharmonic_fd2d_test
  103. bins, a Fortran77 code which orders, sorts and searches data using bins;
  104. bins_test
  105. bisection_integer, a Fortran77 code which seeks an integer solution to the equation F(X)=0, using bisection within a user-supplied change of sign interval [A,B].
  106. bisection_integer_test
  107. bisection_rc, a Fortran77 code which seeks a solution to the equation F(X)=0 using bisection within a user-supplied change of sign interval [A,B]. The procedure is written using reverse communication.
  108. bisection_rc_test
  109. black_scholes, a Fortran77 code which implements some simple approaches to the Black-Scholes option valuation theory, creating graphics files for processing by gnuplot(), by Desmond Higham.
  110. black_scholes_test
  111. blas, a Fortran77 code which contains the Basic Linear Algebra Subprograms (BLAS) for level 1, 2 and 3, for single and double precision, and for real and complex arithmetic.
  112. blas_test
  113. blas1_c, a Fortran77 code which constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS), for vector-vector operations using single precision complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
  114. blas1_c_test
  115. blas1_d, a Fortran77 code which constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS), for vector-vector operations using double precision real arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
  116. blas1_d_test
  117. blas1_s, a Fortran77 code which constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS), for vector-vector operations using single precision real arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
  118. blas1_s_test
  119. blas1_z, a Fortran77 code which constitutes the Level 1 Basic Linear Algebra Subprograms (BLAS), for vector-vector operations using double precision complex arithmetic, by Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh.
  120. blas1_z_test
  121. blas2_c, a Fortran77 code which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using single precision complex arithmetic.
  122. blas2_c_test
  123. blas2_d, a Fortran77 code which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using double precision real arithmetic.
  124. blas2_d_test
  125. blas2_s, a Fortran77 code which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using single precision real arithmetic.
  126. blas2_s_test
  127. blas2_z, a Fortran77 code which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using double precision complex arithmetic.
  128. blas2_z_test
  129. blas3_c, a Fortran77 code which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using single precision complex arithmetic.
  130. blas3_c_test
  131. blas3_d, a Fortran77 code which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using double precision real arithmetic.
  132. blas3_d_test
  133. blas3_s, a Fortran77 code which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using single precision real arithmetic.
  134. blas3_s_test
  135. blas3_z, a Fortran77 code which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using double precision complex arithmetic.
  136. blas3_z_test
  137. blend, a Fortran77 code which carries out 1D/2D/3D blending interpolation;
  138. blend_test
  139. box_behnken, a Fortran77 code which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;
  140. box_behnken_test
  141. brent, a Fortran77 code which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, in the original format, by Richard Brent.
  142. brent_test
  143. brownian_motion_simulation, a Fortran77 code which simulates Brownian motion in an M-dimensional region, creating graphics files for processing by gnuplot().
  144. brownian_motion_simulation_test
  145. bt_serial, a Fortran77 code which a serial version of the nas Block Tridiagonal (BT) Parallel Benchmark.
  146. bt_serial_test
  147. bufpak, a Fortran77 code which reads and writes data to an unformatted, direct access file.
  148. bufpak_test
  149. burgers_exact, a Fortran77 code which evaluates an exact solution of the time-dependent 1D viscous Burgers equation.
  150. burgers_exact_test
  151. bvec, a Fortran77 code which demonstrates how signed integers can be stored as binary vectors, and arithmetic can be performed on them.
  152. bvec_test
  153. bvls, a Fortran77 code which applies least squares methods to solve a linear system for which lower and upper constraints may have been placed on every variable, by Charles Lawson and Richard Hanson.
  154. bvls_test
  155. bvpsol, a Fortran77 code which solves a highly nonlinear two point boundary value problem (BVP) using a local linear solver condensing algorithm or a global sparse linear solver for the solution of the arising linear subproblems, by Peter Deuflhard, Georg Bader, Lutz Weimann.
  156. bvpsol_test
  157. c4lib, a Fortran77 code which implements certain elementary functions for single precision complex variables;
  158. c4lib_test
  159. c8lib, a Fortran77 code which implements certain elementary functions for double precision complex variables;
  160. c8lib_test
  161. calcomp, a Fortran77 code which accepts several calls to Calcomp pen plotter routines, and tries to create a PostScript file corresponding to the desired image.
  162. calcomp_test
  163. cauchy_principal_value, a Fortran77 code which uses Gauss-Legendre quadrature to estimate the Cauchy Principal Value (CPV) of certain singular integrals.
  164. cauchy_principal_value_test
  165. ccn_rule, a Fortran77 code which defines a one of a sequence of nested Clenshaw Curtis quadrature rules of any order.
  166. ccn_rule_test
  167. ccs_io, a Fortran77 code which reads and writes sparse linear systems stored in the Compressed Column Storage (CCS) format.
  168. ccs_io_test
  169. ccs_to_st, a Fortran77 code which converts a sparse matrix from Compressed Column Storage (CCS) to sparse triplet (ST) format.
  170. ccs_to_st_test
  171. cell, a Fortran77 code which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.
  172. cell_test
  173. cellular_automaton, a Fortran77 code which demonstrates the 1D Cellular Automaton known as rule #30.
  174. cellular_automaton_test
  175. cg, a Fortran77 code which implements a simple version of the conjugate gradient (CG) method for solving a system of linear equations of the form A*x=b, suitable for situations in which the matrix A is positive definite, only real, positive eigenvalues and symmetric.
  176. cg_test
  177. cg_plus, a Fortran77 code which implements the conjugate gradient method for the minimization of a scalar functional;
  178. cg_plus_test
  179. cg_rc, a Fortran77 code which implements the conjugate gradient method for solving a positive definite sparse linear system A*x=b, using reverse communication.
  180. cg_rc_test
  181. change_dynamic, a Fortran77 code which uses dynamic programming to solve the change making problem, in which a given sum is to be formed using coins of various denominations.
  182. change_dynamic_test
  183. chebyshev, a Fortran77 code which computes the Chebyshev interpolant/approximant to a given function over an interval.
  184. chebyshev_test
  185. chebyshev_interp_1d, a Fortran77 code which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).
  186. chebyshev_interp_1d_test
  187. chebyshev_polynomial, a Fortran77 code which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
  188. chebyshev_polynomial_test
  189. chebyshev_series, a Fortran77 code which can evaluate a Chebyshev series approximating a function f(x), while efficiently computing one, two or three derivatives of the series, which approximate f'(x), f''(x), and f'''(x), by Manfred Zimmer.
  190. chebyshev_series_test
  191. chrpak, a Fortran77 code which analyzes and manipulates character strings;
  192. chrpak_test
  193. circle_arc_grid, a Fortran77 code which computes grid points along a circular arc.
  194. circle_arc_grid_test
  195. circle_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
  196. circle_integrals_test
  197. circle_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
  198. circle_monte_carlo_test
  199. circle_rule, a Fortran77 code which computes quadrature rules for the unit circle in 2D, that is, the circumference of the circle of radius 1 and center (0,0).
  200. circle_rule_test
  201. circle_segment, a Fortran77 code which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature, creating some graphics images using gnuplot().
  202. circle_segment_test
  203. clebsch_gordan, a Fortran77 code which evaluates Clebsch-Gordan coefficients involved in angular momentum coupling in quantum mechanics;
  204. clebsch_gordan_test
  205. clenshaw_curtis_rule, a Fortran77 code which implements a Clenshaw Curtis quadrature rule;
  206. clenshaw_curtis_rule_test
  207. cnf_io, a Fortran77 code which reads or writes DIMACS Conjunctive Normal Form (CNF) files defining satisfiability problems in terms of a boolean formula.
  208. cnf_io_test
  209. colnew, a Fortran77 code which solves a system of boundary value problems (BVP), a mixed-order system of ordinary differential equations (ODE) subject to separated, multipoint boundary conditions, using collocation at Gaussian points, by Uri Ascher and Georg Bader.
  210. colnew_test
  211. colored_noise, a Fortran77 code which generates samples of noise obeying a 1/f^alpha power law.
  212. colored_noise_test
  213. combination_lock, a Fortran77 code which simulates the process of determining the secret combination of a lock.
  214. combination_lock_test
  215. combo, a Fortran77 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.
  216. combo_test
  217. communicator_mpi, a Fortran77 code which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.
  218. communicator_mpi_test
  219. compass_search, a Fortran77 code which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
  220. compass_search_test
  221. complex_numbers_test, a Fortran77 code which demonstrates some simple features involved in the use of complex numbers in Fortran77 programming.
  222. components, a Fortran77 code which organizes contiguous cells into labeled clusters, for a 1D, 2D, or 3D array. This code has uses in image analysis and percolation simulation.
  223. components_test
  224. condition, a Fortran77 code which implements methods of computing or estimating the condition number of a matrix.
  225. condition_test
  226. conte_deboor, a Fortran77 code which contains examples from Conte and deBoor's Elementary Numerical Analysis text.
  227. conte_deboor_test
  228. cordic, a Fortran77 code which computes a few special functions using the CORDIC algorithm.
  229. cordic_test
  230. correlation, a Fortran77 code which contains examples of statistical correlation functions.
  231. correlation_test
  232. cube_arbq_rule, a Fortran77 code which returns quadrature rules, with exactness up to total degree 15, over the interior of the symmetric cube in 3D, by Hong Xiao and Zydrunas Gimbutas.
  233. cube_arbq_rule_test
  234. cube_exactness, a Fortran77 code which investigates the polynomial exactness of quadrature rules over the interior of a cube in 3D.
  235. cube_exactness_test
  236. cube_felippa_rule, a Fortran77 code which returns Felippa's quadratures rules for approximating integrals over the interior of a cube in 3D.
  237. cube_felippa_rule_test
  238. cube_grid, a Fortran77 code which computes a grid of points over the interior of a cube in 3D.
  239. cube_grid_test
  240. cube_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
  241. cube_integrals_test
  242. cube_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
  243. cube_monte_carlo_test
  244. cwg_ode, a Fortran77 code which contains three ODE solvers by William Gear.
  245. cwg_ode_test
  246. cycle_brent, a Fortran77 code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.
  247. cycle_brent_test
  248. cycle_floyd, a Fortran77 code which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.
  249. cycle_floyd_test
  250. cyclic_reduction, a Fortran77 code which solves a tridiagonal linear system using cyclic reduction;
  251. cyclic_reduction_test
  252. diaphony, a Fortran77 code which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
  253. diaphony_test
  254. differ, a Fortran77 code which determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.
  255. differ_test
  256. dijkstra, a Fortran77 code which implements a simple version of Dijkstra's minimum distance algorithm for graphs.
  257. dijkstra_test
  258. dijkstra_openmp, a Fortran77 code which uses OpenMP to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.
  259. dijkstra_openmp_test
  260. discrete_pdf_sample_2d, a Fortran77 code which demonstrates how to construct a Probability Density Function (PDF) from a table of sample data, and then to use that PDF to create new samples.
  261. discrete_pdf_sample_2d_test
  262. disk_grid, a Fortran77 code which computes grid points within the interior of a disk of user specified radius and center in 2D, using gnuplot() to create an image of the grid.
  263. disk_grid_test
  264. disk_rule, a Fortran77 code which computes quadrature rules over the interior of a disk of radius R centered at the origin.
  265. disk_rule_test
  266. disk01_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
  267. disk01_integrals_test
  268. disk01_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
  269. disk01_monte_carlo_test
  270. disk01_rule, a Fortran77 code which computes quadrature rules for the unit disk in 2D, that is, the interior of the circle of radius 1 and center (0,0).
  271. disk01_rule_test
  272. dislin_test, a Fortran77 code which calls dislin(), which is an extensive scientific graphics package.
  273. divdif, a Fortran77 code which interpolates data using divided difference tables;
  274. divdif_test
  275. doomsday, a Fortran77 code which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.
  276. doomsday_test
  277. driv, a Fortran77 code which includes solvers for systems of real or complex ordinary differential equations (ODE), by Kahaner and Sutherland.
  278. driv_test
  279. duel_simulation, a Fortran77 code which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  280. duel_simulation_test
  281. edge, a Fortran77 code which defines some test functions in 1D, 2D and 3D for the detection of edges or discontinuities, and using gnuplot() to display the curves or surfaces.
  282. edge_test
  283. eispack, a Fortran77 code which carries out eigenvalue computations; superseded by LAPACK;
  284. eispack_test
  285. element_data, a Fortran77 code which preprocesses simple element-based data on a grid into a form that the display4() code can handle.
  286. element_data_test
  287. ellipse_grid, a Fortran77 code which computes a grid of points over the interior of an ellipse in 2D.
  288. ellipse_grid_test
  289. ellipse_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipse in 2D.
  290. ellipse_monte_carlo_test
  291. ellipsoid_grid, a Fortran77 code which computes a grid points over the interior of an ellipsoid in 3D.
  292. ellipsoid_grid_test
  293. ellipsoid_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate the value of integrals over the interior of an ellipsoid in M dimensions.
  294. ellipsoid_monte_carlo_test
  295. elliptic_integral, a Fortran77 code which evaluates complete elliptic integrals of first, second and third kind, using Carlson's elliptic integral functions.
  296. elliptic_integral_test
  297. euler, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the forward Euler method.
  298. euler_test
  299. exactness, a Fortran77 code which investigates the exactness of quadrature rules that estimate the integral of a function with a density, such as 1, exp(-x) or exp(-x^2), over an interval such as [-1,+1], [0,+oo) or (-oo,+oo).
  300. exactness_test
  301. expokit, a Fortran77 code which solves various forms of the matrix exponential problem, by Roger Sidje.
  302. expokit_test
  303. f77, a Fortran77 code which illustrates features of Fortran77;
  304. f77_test
  305. f77_calls_c, a Fortran77 code which illustrates how a Fortran77 program calls a C function.
  306. f77_calls_c++, a Fortran77 code which illustrates how a Fortran77 program calls a C++ function.
  307. f77_calls_matlab, a Fortran77 code which illustrates how a Fortran77 program interacts with MATLAB;
  308. f77_condor, a Fortran77 code which illustrates how a Fortran77 program runs in batch mode using the condor queueing system.
  309. f77_exact, a Fortran77 code which evaluates exact solutions to a few selected examples of ordinary differential equations (ODE) and partial differential equations (PDE).
  310. f77_intrinsics, a Fortran77 code which illustrates the use of some of the intrinsic functions included with the F77 standard language;
  311. f77_mistake, a Fortran77 code which illustrates some simple but devious programming mistakes in Fortran77.
  312. f77_return, a Fortran77 code which illustrates how a Fortran77 program returns a program status value to the calling environment.
  313. fair_dice_simulation, a Fortran77 code which simulates N tosses of 2 dice, writing graphics files for processing by gnuplot().
  314. fair_dice_simulation_test
  315. fd_predator_prey, a Fortran77 code which solves a pair of predator prey ordinary differential equations (ODE) using a finite difference approximation.
  316. fd_predator_prey_test
  317. fd1d_advection_diffusion_steady, a Fortran77 code which applies the finite difference method (FDM) to solve the steady advection diffusion equation v*ux-k*uxx=0 in one spatial dimension, with constant velocity v and diffusivity k, writing graphics files for processing by gnuplot().
  318. fd1d_advection_diffusion_steady_test
  319. fd1d_advection_ftcs, a Fortran77 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the FTCS method, forward time difference, centered space difference, writing graphics files for processing by gnuplot().
  320. fd1d_advection_ftcs_test
  321. fd1d_advection_lax, a Fortran77 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to approximate the time derivative, writing graphics files for processing by gnuplot().
  322. fd1d_advection_lax_test
  323. fd1d_advection_lax_wendroff, a Fortran77 code which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to approximate the time derivative, writing graphics files for processing by gnuplot().
  324. fd1d_advection_lax_wendroff_test
  325. fd1d_burgers_lax, a Fortran77 code which applies the finite difference method (FDM) and the Lax Wendroff method to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  326. fd1d_burgers_lax_test
  327. fd1d_burgers_leap, a Fortran77 code which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  328. fd1d_burgers_leap_test
  329. fd1d_bvp, a Fortran77 code which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
  330. fd1d_bvp_test
  331. fd1d_heat_explicit, a Fortran77 code which implements a finite difference method (FDM), explicit in time, of the time dependent 1D heat equation;
  332. fd1d_heat_explicit_test
  333. fd1d_heat_implicit, a Fortran77 code which implements a finite difference method (FDM), implicit in time, of the time dependent 1D heat equation;
  334. fd1d_heat_implicit_test
  335. fd1d_heat_steady, a Fortran77 code which implements a finite difference method (FDM) for the steady time-independent 1D heat equation;
  336. fd1d_heat_steady_test
  337. fd1d_predator_prey, a Fortran77 code which implements the finite difference method (FDM) for a predator-prey system with time and 1D spatial dependence, by Marcus Garvie.
  338. fd1d_predator_prey_test
  339. fd1d_wave, a Fortran77 code which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.
  340. fd1d_wave_test
  341. fd2d_heat_steady, a Fortran77 code which implements a finite difference method (FDM) for the steady time-independent 2D heat equation;
  342. fd2d_heat_steady_test
  343. fem_basis, a Fortran77 code which defines and evaluates basis functions associated with the finite element method (FEM) for any degree in an M-dimensional simplex: 1D interval, 2D triangle, 3D tetrahedron, and higher dimensional generalizations.
  344. fem_basis_test
  345. fem_io, a Fortran77 code which reads or writes FEM files, which describe the nodes, elements, and function values associated with a finite element method (FEM) model;
  346. fem_io_test
  347. fem_to_gmsh, a Fortran77 code which reads a pair of FEM files defining node coordinates and elements, of a 1D, 2D or 3D mesh, namely a file of node coordinates and a file of elements defined by node indices, and creates a gmsh() mesh file.
  348. fem_to_gmsh_test
  349. fem_to_triangle, a Fortran77 code which reads FEM files defining a 2D mesh of triangles, namely a file of node coordinates and a file of elements defined by node indices, and creates a corresponding pair of node and element files for use by Jonathan Shewchuk's triangle() program.
  350. fem_to_triangle_test
  351. 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().
  352. fem_to_xml_test
  353. fem1d, a Fortran77 code which applies the finite element method (FEM), with piecewise linear (PWL) basis functions, to a linear two point boundary value problem (BVP) in 1D;
  354. fem1d_test
  355. fem1d_adaptive, a Fortran77 code which uses an adaptive mesh when applying the finite element method (FEM), with piecewise linear (PWL) basis functions, to a linear two point boundary value problem (BVP) in 1D;
  356. fem1d_adaptive_test
  357. fem1d_bvp_linear, a Fortran77 code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a two point boundary value problem (BVP) in one spatial dimension.
  358. fem1d_bvp_linear_test
  359. fem1d_bvp_quadratic, a Fortran77 code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a two point boundary value problem (BVP) in one spatial dimension, and compares the computed and exact solutions with the L2 and seminorm errors.
  360. fem1d_bvp_quadratic_test
  361. fem1d_heat_steady, a Fortran77 code which implements the finite element method (FEM) for the steady time-independent 1D heat equation;
  362. fem1d_heat_steady_test
  363. fem1d_lagrange, a Fortran77 code which sets up the matrices and vectors associated with the finite element method (FEM) solution of a boundary value problem (BVP) -u''+u=f(x), using Lagrange basis polynomials.
  364. fem1d_lagrange_test
  365. fem1d_nonlinear, a Fortran77 code which applies the finite element method (FEM), with piecewise linear (PWL) basis functions, to a nonlinear two point boundary value problem (BVP) in 1D;
  366. fem1d_nonlinear_test
  367. fem1d_oden, a Fortran77 code which applies the finite element method (FEM) to a linear two point boundary value problem (BVP) in one spatial dimension; this code is an example for the Texas Finite Element Series, by Eric Becker, Graham Carey and J Tinsley Oden.
  368. fem1d_oden_test
  369. fem1d_pack, a Fortran77 code which contains utilities for 1D finite element method (FEM) calculations.
  370. fem1d_pack_test
  371. fem1d_pmethod, a Fortran77 code which applies the p-method version of the finite element method (FEM) to a linear two point boundary value problem (BVP) in 1D;
  372. fem1d_pmethod_test
  373. fem1d_project, a Fortran77 code which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.
  374. fem1d_project_test
  375. fem1d_sample, a Fortran77 code which samples a scalar or vector finite element function of one variable, defined by a set of files in FEM format, returning interpolated values at the sample points.
  376. fem1d_sample_test
  377. fem2d_bvp_linear, a Fortran77 code which applies the finite element method (FEM), with piecewise linear (PWL) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  378. fem2d_bvp_linear_test
  379. fem2d_bvp_quadratic, a Fortran77 code which applies the finite element method (FEM), with piecewise quadratic (PWQ) elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  380. fem2d_bvp_quadratic_test
  381. fem2d_bvp_serene, a Fortran77 code which applies the finite element method (FEM), with serendipity elements, to a 2D boundary value problem (BVP) in a rectangle, and compares the computed and exact solutions with the L2 and seminorm errors.
  382. fem2d_bvp_serene_test
  383. fem2d_oden, a Fortran77 code which implements a 2D calculations for the finite element method (FEM);
  384. fem2d_oden_test
  385. fem2d_pack, a Fortran77 code which implements simple 2D calculations for the finite element method (FEM);
  386. fem2d_pack_test
  387. fem2d_poisson_rectangle, a Fortran77 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic (PWQ) triangular elements.
  388. fem2d_poisson_rectangle_test
  389. fem2d_poisson_rectangle_linear, a Fortran77 code which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear (PWL) triangular elements.
  390. fem2d_poisson_rectangle_linear_test
  391. fem2d_sample, a Fortran77 code which samples a finite element function, defined by FEM files, three text files describing the nodes, triangles, and coefficients, at arbitrary points.
  392. fem2d_sample_test
  393. feynman_kac_1d, a Fortran77 code which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.
  394. feynman_kac_1d_test
  395. feynman_kac_2d, a Fortran77 code which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.
  396. feynman_kac_2d_test
  397. feynman_kac_3d, a Fortran77 code which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
  398. feynman_kac_3d_test
  399. fft_openmp, a Fortran77 code which demonstrates the computation of a Fast Fourier Transform (FFT) in parallel, using OpenMP.
  400. fft_openmp_test
  401. fft_serial, a Fortran77 code which computes a Fast Fourier Transform (FFT), and is intended as a starting point for implementing an OpenMP parallel version.
  402. fft_serial_test
  403. fftpack5.1, a Fortran77 code which contains version 5.1 of the FFTPACK Fast Fourier Transform (FFT) package by Paul Swarztrauber and Dick Valent;
  404. fftpack5.1_test
  405. fftw_test, a Fortran77 code which uses the fftw() Fast Fourier Transform (FFT) package, by Matteo Frigo and Steven Johnson.
  406. file_name_sequence, a Fortran77 code which demonstrates ways to generate a sequence of filenames, which can be useful when generating a sequence of still snapshots to be animated later.
  407. file_name_sequence_test
  408. files_multiple, a Fortran77 code which demonstrates how a program opens multiple output files at one time, and write data to any one specific file it chooses.
  409. files_multiple_test
  410. filon_rule, a Fortran77 code which uses Filon's method to approximate integrals with an oscillatory factor of sin(k*x) or cos(k*x).
  411. filon_rule_test
  412. filum, a Fortran77 code which performs various operations on files;
  413. filum_test
  414. fire_simulation, a Fortran77 code which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.
  415. fire_simulation_test
  416. fishpack, a Fortran77 code which solves the Poisson, Laplace, or Helmholtz equation in 2D or 3D on a variety of geometries, by Paul Swarztrauber and Roland Sweet.
  417. fishpack_test
  418. floyd, a Fortran77 code which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  419. floyd_test
  420. fn, a Fortran77 code which evaluates elementary and special functions, by Wayne Fullerton.
  421. fn_test
  422. freefem++_msh_io, a Fortran77 code which reads and writes files used by the FreeFem++ finite element program to store mesh information.
  423. freefem++_msh_io_test
  424. fsolve, a Fortran77 code which solves systems of nonlinear equations, inspired by the fsolve() function in minpack(), with special interfaces fsolve_bdf2(), fsolve_be() and fsolve_tr() for handling systems associated with implicit ODE solvers of type bdf2, backward Euler, midpoint, or trapezoidal.
  425. fsolve_test
  426. gdb_test, a Fortran77 code which calls gdb(), which is the gnu debugger;
  427. geometry, a Fortran77 code which carries out a number of 2D/3D geometric calculations;
  428. geometry_test
  429. geompack, a Fortran77 code which computes the Delaunay triangulation of a set of points in the plane, by Barry Joe.
  430. geompack_test
  431. geqp3, a Fortran77 code which contains the portion of the lapack() library that carries out the QR factorization, with column pivoting, of an M by N rectangular matrix, with N <= M.
  432. geqp3_test
  433. gfortran_test, a Fortran77 code which calls gfortran(), which is the gnu compiler for Fortran77.
  434. gfortran_intrinsics_test, a Fortran77 code which illustrates the use of some of the intrinsic functions included by the Gnu gfortran() compiler, above and beyond those specified in the Fortran77 language standards.
  435. gfortran_quadmath_test, a Fortran77 code which illustrates the use of quadruple precision real arithmetic, as provided on some systems by the Gnu gfortran() compiler for Fortran77.
  436. glomin, a Fortran77 code which finds a global minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  437. glomin_test
  438. gmsh_io, a Fortran77 code which reads or writes some of the files created by the gmsh() program for 1D, 2D or 3D meshes used by the finite element method (FEM).
  439. gmsh_io_test
  440. gmsh_to_fem, a Fortran77 code which reads a mesh data file created by the gmsh() program and writes a pair of node and element files that correspond to the FEM format.
  441. gmsh_to_fem_test
  442. gnuplot_test, Fortran77 codes which use gnuplot() to create various kinds of plots.
  443. gprof_test, Fortran77 codes which illustrate the use of the GPROF program performance monitor;
  444. graphics_test, a Fortran77 code which displays data graphically.
  445. haar_transform, a Fortran77 code which computes the Haar transform of 1d or 2d data.
  446. haar_transform_test
  447. hb_read, a Fortran77 code which reads files in the Harwell Boeing (HB) sparse matrix format; This is a simplified interface intended to handle only the most common format, complex unsymmetric assembled (CUA) or real unsymmetric assembled (RUA).
  448. hb_read_test
  449. hb_to_st, a Fortran77 code which reads a sparse matrix in a Harwell-Boeing (HB) file and writes an equivalent Sparse Triplet (ST) file.
  450. hb_to_st_test
  451. heat_mpi, a Fortran77 code which solves the 1D time dependent heat equation using MPI.
  452. heat_mpi_test
  453. heated_plate, a Fortran77 code which solves the steady state heat equation in a 2D rectangular region, and is intended as a starting point for implementing an OpenMP parallel version.
  454. heated_plate_test
  455. heated_plate_openmp, a Fortran77 code which solves the steady time-independent heat equation in a 2D rectangular region, using OpenMP to run in parallel.
  456. heated_plate_openmp_test
  457. hello, a Fortran77 code which prints out "Hello, world!".
  458. hello_test
  459. hello_mpi, a Fortran77 code which prints out "Hello, world!" using MPI for parallel programming.
  460. hello_mpi_test
  461. hello_openmp, a Fortran77 code which prints out "Hello, world!" within the OpenMP parallel programming environment.
  462. hello_openmp_test
  463. hermite_cubic, a Fortran77 code which computes the value, derivatives or integral of a Hermite cubic polynomial, or manipulates an interpolating function made up of piecewise cubic Hermite (PWH) polynomials.
  464. hermite_cubic_test
  465. hermite_exactness, a Fortran77 code which tests the polynomial exactness of Gauss-Hermite quadrature rules to estimate the integral of f(x) with density exp(-x^2) over the interval (-oo,+oo).
  466. hermite_exactness_test
  467. hermite_integrands, a Fortran77 code which defines test integrands for Hermite integrals with density exp(-x^2) over the interval (-oo,+oo).
  468. hermite_integrands_test
  469. hermite_interpolant, a Fortran77 code which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
  470. hermite_interpolant_test
  471. hermite_polynomial, a Fortran77 code which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
  472. hermite_polynomial_test
  473. hermite_product_polynomial, a Fortran77 code which defines Hermite product polynomials, creating a multivariate polynomial as the product of univariate Hermite polynomials.
  474. hermite_product_polynomial_test
  475. hermite_rule, a Fortran77 code which computes and writes out a Gauss-Hermite quadrature rule of given order.
  476. hermite_rule_test
  477. high_card_simulation, a Fortran77 code which simulates a situation in which you see the cards in a deck one by one, and must select the one you think is the highest and stop; the program uses gnuplot() to create a graph of the results.
  478. high_card_simulation_test
  479. histogram_data_2d_sample, a Fortran77 code which demonstrates how to construct a Probability Density Function (PDF) from sample data over a 2D domain, and then to use that PDF to create new samples.
  480. histogram_data_2d_sample_test
  481. hyper_2f1, a Fortran77 code which evaluates the hypergeometric functions 2F1(a,b,c;x) for real parameters a, b, c, and real or complex argument x, by Shanjie Zhang, Jianming Jin;
  482. hyper_2f1_test
  483. hyperball_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.
  484. hyperball_integrals_test
  485. hyperball_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
  486. hyperball_monte_carlo_test
  487. hypercube_exactness, a Fortran77 code which tests the polynomial exactness of a quadrature rule over the interior of the unit hypercube in M dimensions.
  488. hypercube_exactness_test
  489. hypercube_grid, a Fortran77 code which computes a grid of points over the interior of a hypercube in M dimensions.
  490. hypercube_grid_test
  491. hypercube_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.
  492. hypercube_integrals_test
  493. hypercube_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.
  494. hypercube_monte_carlo_test
  495. hypersphere, a Fortran77 code which carries out various operations for an M dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
  496. hypersphere_test
  497. hypersphere_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.
  498. hypersphere_integrals_test
  499. hypersphere_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
  500. hypersphere_monte_carlo_test
  501. i4lib, a Fortran77 code which contains many utility routines, using I4 or single precision integer arithmetic.
  502. i4lib_test
  503. i8lib, a Fortran77 code which contains many utility routines, using I8 or double precision integer arithmetic.
  504. i8lib_test
  505. image_denoise, a Fortran77 code which applies simple filtering operations to a noisy image.
  506. image_denoise_test
  507. image_edge, a Fortran77 code which demonstrates a simple procedure for edge detection in images.
  508. image_edge_test
  509. index, a Fortran77 code which converts a multidimensional vector index to a one-dimensional vector index; it handles zero and one based indexing schemes, as well as column major and row major conventions.
  510. index_test
  511. inout, a Fortran77 code which computes the pressure and velocity for a flow governed by the time-dependent Navier Stokes Equations (NSE) in a square 1D region with an inlet and an outlet, by Hyung-Chun Lee.
  512. inout_test
  513. interp, a Fortran77 code which parameterizes and interpolates data;
  514. interp_test
  515. ising_2d_simulation, a Fortran77 code which simulates the evolution of a 2D array of positive and negative charges, each of which is likely to "flip" to be in agreement with neighbors.
  516. ising_2d_simulation_test
  517. jacobi, a Fortran77 code which implements the Jacobi iteration for the iterative solution of linear systems.
  518. jacobi_test
  519. jacobi_eigenvalue, a Fortran77 code which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.
  520. jacobi_eigenvalue_test
  521. jacobi_polynomial, a Fortran77 code which evaluates the Jacobi polynomial and associated functions.
  522. jacobi_polynomial_test
  523. knapsack, a Fortran77 code which implements algorithms for a variety of combinatorial problems, including bin packing, the subset sum problem, the generalized assignment problem, the change making problem, the 01 knapsack problem, and the multiple knapsack problem. by Silvano Martelo and Paolo Toth.
  524. knapsack_test
  525. knapsack_01_brute, a Fortran77 code which uses brute force to solve small versions of the 0/1 knapsack problem;
  526. knapsack_01_brute_test
  527. kronrod_rule, a Fortran77 code which computes a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  528. kronrod_rule_test
  529. lagrange_approx_1d, a Fortran77 code which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).
  530. lagrange_approx_1d_test
  531. lagrange_interp_1d, a Fortran77 code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on a 1D argument, so that p(x(i)) = y(i).
  532. lagrange_interp_1d_test
  533. lagrange_interp_2d, a Fortran77 code which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).
  534. lagrange_interp_2d_test
  535. lagrange_interp_nd, a Fortran77 code which defines and evaluates the Lagrange polynomial p(x) which interpolates a set of data depending on a multidimensional argument that was evaluated on a product grid, so that p(x(i)) = z(i).
  536. lagrange_interp_nd_test
  537. laguerre_exactness, a Fortran77 code which tests the polynomial exactness of Gauss-Hermite quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
  538. laguerre_exactness_test
  539. laguerre_integrands, a Fortran77 code which implements test problems for quadrature rules for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
  540. laguerre_integrands_test
  541. laguerre_polynomial, a Fortran77 code which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
  542. laguerre_polynomial_test
  543. laguerre_rule, a Fortran77 code which computes and writes out a Gauss-Laguerre quadrature rule for estimating the integral of a function with density exp(-x) over the interval [0,+oo).
  544. laguerre_rule_test
  545. lamp, a Fortran77 code which implements algorithms for linear assignment and matching problems, including the linear sum assignment problem, the linear bottleneck assignment problem, the cardinality matching problem, the sum matching problem, the bottleneck matching problem, the Chinese postman problem, and the quadratic assignment problem, by Rainer Burkard, Ulrich Derigs.
  546. lamp_test
  547. lapack, a Fortran77 code which is a linear algebra library.
  548. lapack_test
  549. lapack_eigen_test, a Fortran77 code which calls eigenvalue functions in lapack(), which is a linear algebra library.
  550. laplacian, a Fortran77 code which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
  551. laplacian_test
  552. latin_cover, a Fortran77 code which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
  553. latin_cover_test
  554. latin_random, a Fortran77 code which produces N points in an M-dimensional Latin Random Hypercube.
  555. latin_random_test
  556. latinize, a Fortran77 code which adjusts N points in M dimensions to form a Latin hypercube.
  557. latinize_test
  558. lawson, a Fortran77 code which contains routines for solving least squares problems and the singular value decomposition (SVD), by Lawson and Hanson.
  559. lawson_test
  560. lebesgue, a Fortran77 code which is given a set of nodes in 1D, and plots the Lebesgue function, and estimates the Lebesgue constant, which measures the maximum magnitude of the potential error of Lagrange polynomial interpolation.
  561. lebesgue_test
  562. legendre_exactness, a Fortran77 code which tests the monomial exactness of quadrature rules for the Legendre problem of integrating a function with density 1 over the interval [-1,+1].
  563. legendre_exactness_test
  564. legendre_fast_rule, a Fortran77 code which uses a fast order N algorithm to compute a Gauss-Legendre quadrature rule of given order.
  565. legendre_fast_rule_test
  566. legendre_polynomial, a Fortran77 code which evaluates the Legendre polynomial and associated functions.
  567. legendre_polynomial_test
  568. legendre_product_polynomial, a Fortran77 code which defines Legendre product polynomials, creating a multivariate polynomial as the product of univariate Legendre polynomials.
  569. legendre_product_polynomial_test
  570. legendre_rule, a Fortran77 code which writes out a Gauss-Legendre quadrature rule of given order.
  571. legendre_rule_test
  572. life_serial, a Fortran77 code which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.
  573. life_serial_test
  574. line_cvt_lloyd, a Fortran77 code which applies Lloyd's iteration repeatedly to a set of N points, to compute a Centroidal Voronoi Tessellation (CVT) over the interior of a line segment in 1D.
  575. line_cvt_lloyd_test
  576. line_fekete_rule, a Fortran77 code which estimates the location of N Fekete points, for polynomial interpolation or quadrature, over the interior of a line segment in 1D.
  577. line_fekete_rule_test
  578. line_felippa_rule, a Fortran77 code which returns Felippa's quadratures rules for approximating integrals over the interior of a line segment in 1D.
  579. line_felippa_rule_test
  580. line_grid, a Fortran77 code which computes a grid of points over the interior of a line segment in 1D.
  581. line_grid_test
  582. line_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the length of the unit line in 1D.
  583. line_integrals_test
  584. line_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line in 1D.
  585. line_monte_carlo_test
  586. line_ncc_rule, a Fortran77 code which computes a Newton Cotes Closed (NCC) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  587. line_ncc_rule_test
  588. line_nco_rule, a Fortran77 code which computes a Newton Cotes Open (NCO) quadrature rule, using equally spaced points, over the interior of a line segment in 1D.
  589. line_nco_rule_test
  590. linpack_bench, a Fortran77 code which carries out the linpack() benchmark;
  591. linpack_bench_test
  592. linpack_c, a Fortran77 code which constitutes a linear algebra library for single precision complex arithmetic; it includes a function for the singular value decomposition (SVD) of a rectangular matrix. The original version of this library is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
  593. linpack_c_test
  594. linpack_d, a Fortran77 code which constitutes a linear algebra library for double precision real arithmetic; it includes a function for the singular value decomposition (SVD) of a rectangular matrix. The original version of this library is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
  595. linpack_d_test
  596. linpack_s, a Fortran77 code which constitutes a linear algebra library; for single precision real arithmetic; it includes a function for the singular value decomposition (SVD) of a rectangular matrix. The original version of this library is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
  597. linpack_s_test
  598. linpack_z, a Fortran77 code which constitutes a linear algebra library for double precision complex arithmetic; it includes a function for the singular value decomposition (SVD) of a rectangular matrix. The original version of this library is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
  599. linpack_z_test
  600. linplus, a Fortran77 code which carries out operations such as matrix-vector products, matrix factorization, direct and iterative linear solvers for matrices in a variety of formats, including banded, border-banded, circulant, lower triangular, pentadiagonal, sparse, symmetric, toeplitz, tridiagonal, upper triangular and vandermonde formats.
  601. linplus_test
  602. llsq, a Fortran77 code which solves the simple linear least squares problem of finding the formula of a straight line y=a*x+b which minimizes the root-mean-square error to a set of N data points.
  603. llsq_test
  604. lobatto_polynomial, a Fortran77 code which evaluates Lobatto polynomials similar to Legendre polynomials except that they are 0 at both endpoints.
  605. lobatto_polynomial_test
  606. local_min, a Fortran77 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  607. local_min_test
  608. local_min_rc, a Fortran77 code which finds a local minimum of a scalar function of a scalar variable, without the use of derivative information, using reverse communication (RC), by Richard Brent.
  609. local_min_rc_test
  610. lorenz_ode, a Fortran77 code which approximates solutions to the Lorenz system, creating output files to be displayed by gnuplot().
  611. lorenz_ode_test
  612. machar, a Fortran77 code which computes the values of various machine characteristic constants;
  613. machar_test
  614. machine, a Fortran77 code which returns tabulated values of machine constants;
  615. machine_test
  616. mandelbrot, a Fortran77 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot set;
  617. mandelbrot_test
  618. mandelbrot_openmp, a Fortran77 code which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution;
  619. mandelbrot_openmp_test
  620. matman, a Fortran77 code which allows a user to interactively define and manipulate matrices using integer, real, or rational arithmetic, and to perform various operations in linear algebra or linear programming modes.
  621. matman_test
  622. matmul, a Fortran77 code which carries out a matrix multiplication benchmark;
  623. matmul_test
  624. matrix_exponential, a Fortran77 code which computes the exponential function of a matrix.
  625. matrix_exponential_test
  626. md, a Fortran77 code which carries out a molecular dynamics simulation, and is intended as a starting point for implementing an OpenMP parallel version.
  627. md_test
  628. md_openmp, a Fortran77 code which carries out a molecular dynamics simulation in parallel using OpenMP.
  629. md_openmp_test
  630. medit_mesh_io, a Fortran77 code which reads or writes files used by the MEDIT program, which define a mesh associated with the finite element method (FEM) in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.
  631. medit_mesh_io_test
  632. medit_to_fem, a Fortran77 code which reads a mesh file created by the MEDIT program and writes a corresponding pair of node and element files that correspond to the FEM format.
  633. medit_to_fem_test
  634. mesh_bandwidth, a Fortran77 code which returns the geometric bandwidth associated with a mesh of elements of any order and in a space of M dimensions.
  635. mesh_bandwidth_test
  636. mg_serial, a Fortran77 code which a serial version of the nas Multigrid (MG) Parallel Benchmark.
  637. mg_serial_test
  638. mgmres, a Fortran77 code which applies the restarted Generalized Minimum Residual (GMRES) algorithm to solve a sparse linear system, using Compressed Row Storage (CRS) or sparse triplet (ST) format, by Lili Ju.
  639. mgmres_test
  640. mgs, a Fortran77 code which is an example of "legacy code", which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
  641. mgs_test
  642. midpoint, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, with a version of fsolve() handling the associated nonlinear equation, and using a fixed time step.
  643. midpoint_test
  644. midpoint_explicit, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (explicit) midpoint method, also called the modified Euler method.
  645. midpoint_explicit_test
  646. midpoint_fixed, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) midpoint method, using a fixed point iteration for the nonlinear equation.
  647. midpoint_fixed_test
  648. minpack, a Fortran77 code which solves linear and nonlinear least squares problems, by Jorge More, Danny Sorenson, Burton Garbow, Kenneth Hillstrom.
  649. minpack_test
  650. mixed, a Fortran77 code which uses mixed language programming in which the main program is written in Fortran77;
  651. mixed_test
  652. mm_io, a Fortran77 code which reads or writes sparse matrices that use the Matrix Market (MM) sparse matrix file format.
  653. mm_io_test
  654. monomial, a Fortran77 code which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
  655. monomial_test
  656. monomial_value, a Fortran77 code which evaluates a monomial in M dimensions.
  657. monomial_value_test
  658. monte_carlo_rule, a Fortran77 code which generates a dataset of N random M-dimensional points, regards it as a quadrature rule for the unit hypercube, and writes out three files of information.
  659. monte_carlo_rule_test
  660. mpi, Fortran77 codes which use MPI for the parallel execution of programs;
  661. mpi_test
  662. multitask_mpi, a Fortran77 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using MPI for parallel execution.
  663. multitask_mpi_test
  664. multitask_openmp, a Fortran77 code which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.
  665. multitask_openmp_test
  666. mumps_test, a Fortran77 code which uses mumps() to solve a large linear algebraic system.
  667. mus, a Fortran77 code which implements the multiple shooting method for two point boundary value problems (BVP), for linear or nonlinear cases, by Robert Mattheij and G Staarink.
  668. mus_test
  669. mxm, a Fortran77 code which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
  670. mxm_test
  671. mxm_openmp, a Fortran77 code which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
  672. mxm_openmp_test
  673. naca, a Fortran77 code which takes the parameters of certain NACA airfoils and return the coordinates of a sequence of points that outline the wing shape. The points are plotted with gnuplot().
  674. naca_test
  675. napack, a Fortran77 code which includes many routines for applied numerical linear algebra, by William Hager.
  676. napack_test
  677. nas, a Fortran77 code which runs the NASA kernel benchmark.
  678. nas_test
  679. navier_stokes_2d_exact, a Fortran77 code which evaluates an exact solution to the incompressible time-dependent Navier Stokes Equations (NSE) over an arbitrary domain in 2D.
  680. navier_stokes_2d_exact_test
  681. navier_stokes_3d_exact, a Fortran77 code which evaluates an exact solution to the incompressible time-dependent Navier Stokes Equations (NSE) over an arbitrary domain in 3D.
  682. navier_stokes_3d_exact_test
  683. nearest_interp_1d, a Fortran77 code which interpolates a set of data using a piecewise constant (PWC) interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot().
  684. nearest_interp_1d_test
  685. newton_rc, a Fortran77 code which demonstrates the use of Newton's method to solve a system of nonlinear equations, using reverse communication (RC).
  686. newton_rc_test
  687. nintlib, a Fortran77 code which applies approximate integration/quadrature in M dimensions;
  688. nintlib_test
  689. nl2sol, a Fortran77 code which implements an adaptive nonlinear least squares algorithm, by John Dennis, David Gay, Roy Welsch.
  690. nl2sol_test
  691. nms, a Fortran77 code which includes a wide variety of numerical software, including solvers for linear systems of equations, interpolation of data, numerical quadrature, linear least squares data fitting, the solution of nonlinear equations, ordinary differential equations (ODE), optimization and nonlinear least squares, simulation and random numbers, trigonometric approximation and Fast Fourier Transforms (FFT).
  692. nms_test
  693. normal, a Fortran77 code which generates normally distributed pseudorandom numbers.
  694. normal_test
  695. nspcg, a Fortran77 code which carries out the iterative solution of large nonsymmetric systems of linear equations. The package includes a variety of matrix storage formats, preconditioners, and solvers.
  696. ode, a Fortran77 code which handles ordinary differential equations (ODE), by Shampine and Gordon;
  697. ode_test
  698. odepack, a Fortran77 code which contains nine ODE solvers, including LSODE, LSODES, LSODA, LSODAR, LSODPK, LSODKR, LSODI, LSOIBT, and LSODIS, by Alan Hindmarsh.
  699. odepack_test
  700. openmp_test, a Fortran77 code which uses the OpenMP interface for parallel processing on shared memory systems;
  701. optimize_test, a Fortran77 code which looks at the use of automatic optimization by the compiler to make the executable code run faster.
  702. ornstein_uhlenbeck, a Fortran77 code which approximates solutions of the Ornstein-Uhlenbeck stochastic ordinary differential equation (SODE) using the Euler method, the Euler-Maruyama method, and the Milstein method, and creating graphics files for processing by gnuplot().
  703. ornstein_uhlenbeck_test
  704. owen, a Fortran77 code which evaluates Owen's T function;
  705. owen_test
  706. padua, a Fortran77 code which returns the points and weights for Padu sets, useful for interpolation in 2D. gnuplot() is used to make plots of the points.
  707. padua_test
  708. paranoia, a Fortran77 code which checks properties of a computer's arithmetic, by William Kahan.
  709. paranoia_test
  710. partition_brute, a Fortran77 code which uses a brute force algorithm to seek solutions of the partition problem, splitting a set of integers into two subsets with equal sum.
  711. partition_brute_test
  712. patterson_rule, a Fortran77 code which returns the points and weights of a 1D Gauss-Patterson quadrature rule of order 1, 3, 7, 15, 31, 63, 127, 255 or 511.
  713. patterson_rule_test
  714. pbma_io, a Fortran77 code which reads or writes ASCII Portable Bit Map (PBM) 2D bit map graphics files;
  715. pbma_io_test
  716. pce_burgers, a Fortran77 code which defines and solves a version of the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials, by Gianluca Iaccarino.
  717. pce_burgers_test
  718. pce_ode_hermite, a Fortran77 code which sets up a simple scalar ordinary differential equation (ODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion (PCE) in terms of Hermite polynomials.
  719. pce_ode_hermite_test
  720. pchip, a Fortran77 code which constructs a piecewise cubic Hermite (PWH) interpolant to data, and carry out various related operations, by Fred Fritsch.
  721. pchip_test
  722. pdflib, a Fortran77 code which evaluates Probability Density Functions (PDF) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
  723. pdflib_test
  724. pgma_io, a Fortran77 code which reads or writes ASCII Portable Gray Map (PGM) 2D grayscale graphics files;
  725. pgma_io_test
  726. pink_noise, a Fortran77 code which computes a pink noise signal obeying a 1/f power law.
  727. pink_noise_test
  728. point_merge, a Fortran77 code which considers N points in M dimensional space, and counts or indexes the unique or "tolerably unique" items.
  729. point_merge_test
  730. poisson_1d_multigrid, a Fortran77 code which applies the multigrid method to a discretized version of the 1D Poisson equation.
  731. poisson_1d_multigrid_test
  732. poisson_openmp, a Fortran77 code which computes an approximate solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
  733. poisson_openmp_test
  734. poisson_serial, a Fortran77 code which computes an approximate solution to the Poisson equation in a rectangle, and is intended as the starting point for the creation of a parallel version.
  735. poisson_serial_test
  736. poisson_simulation, a Fortran77 code which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating graphics files for processing by gnuplot().
  737. poisson_simulation_test
  738. polpak, a Fortran77 code which evaluates a variety of mathematical functions, polynomials, and sequences, including Bell, Benford, Bernoulli, Bernstein, Cardan, Catalan, Charlier, Chebyshev, Collatz, Delannoy, Euler, Fibonacci, Gegenbauer, Gudermannian, Harmonic, Hermite, Hofstadter, Jacobi, Krawtchouk, Laguerre, Lambert, Legendre, Lerch, Meixner, Mertens, Moebius, Motzkin, Phi, Stirling, Tau, Tribonacci, Zernike.
  739. polpak_test
  740. polygon, a Fortran77 code which computes properties of an arbitrary polygon in the plane, defined by a sequence of vertices, including interior angles, area, centroid, containment of a point, convexity, diameter, distance to a point, inradius, lattice area, nearest point in set, outradius, uniform sampling.
  741. polygon_test
  742. polygon_grid, a Fortran77 code which generates a grid of points over the interior of a polygon in 2D.
  743. polygon_grid_test
  744. polygon_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of a polygon in 2D.
  745. polygon_integrals_test
  746. polygon_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of a polygon in 2D.
  747. polygon_monte_carlo_test
  748. polygon_triangulate, a Fortran77 code which triangulates a possibly nonconvex polygon in 2D, and which uses gnuplot() to display the external edges and internal diagonals of the triangulation.
  749. polygon_triangulate_test
  750. polynomial, a Fortran77 code which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  751. polynomial_test
  752. polynomial_conversion, a Fortran77 code which converts representations of a polynomial between monomial, Bernstein, Chebyshev, Gegenbauer, Hermite, Laguerre and Legendre forms.
  753. polynomial_conversion_test
  754. power_method, a Fortran77 code which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  755. power_method_test
  756. power_rule, a Fortran77 code which constructs a power rule, that is, a product quadrature rule from identical 1D factor rules.
  757. power_rule_test
  758. ppma_io, a Fortran77 code which reads or writes ASCII Portable Pixel Map (PPM) 2D color graphics files;
  759. ppma_io_test
  760. pppack, a Fortran77 code which computes piecewise polynomial (PWP) interpolants and approximants, in particular, cubic splines, by Carl DeBoor.
  761. pppack_test
  762. praxis, a Fortran77 code which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
  763. praxis_test
  764. prime_mpi, a Fortran77 code which counts the number of primes between 1 and N, using MPI for parallel execution.
  765. prime_mpi_test
  766. prime_openmp, a Fortran77 code which counts the number of primes between 1 and N, using OpenMP for parallel execution.
  767. prime_openmp_test
  768. prime_serial, a Fortran77 code which counts the number of primes between 1 and N, and is intended as a starting point for a parallel version.
  769. prime_serial_test
  770. prob, a Fortran77 code which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF) and Cumulative Density Functions (CDF), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
  771. prob_test
  772. product_rule, a Fortran77 code which creates an M-dimensional quadrature rule from a product of distinct 1d quadrature rules;
  773. product_rule_test
  774. pwl_approx_1d, a Fortran77 code which approximates a set of data using a piecewise linear (PWL) function.
  775. pwl_approx_1d_test
  776. pwl_interp_1d, a Fortran77 code which interpolates a set of data using a piecewise linear (PWL) function.
  777. pwl_interp_1d_test
  778. pwl_interp_2d, a Fortran77 code which evaluates a piecewise linear (PWL) interpolant to data defined on a regular 2D grid.
  779. pwl_interp_2d_test
  780. pwl_interp_2d_scattered, a Fortran77 code which evaluates a piecewise linear (PWL) interpolant to data which is available at an irregularly arranged set of points.
  781. pwl_interp_2d_scattered_test
  782. pwl_product_integral, a Fortran77 code which calculates the exact value of the integral of the product of two piecewise linear (PWL) functions F(X) and G(X).
  783. pwl_product_integral_test
  784. pyramid_exactness, a Fortran77 code which investigates the polynomial exactness of a quadrature rule over the interior of the unit pyramid in 3D.
  785. pyramid_exactness_test
  786. pyramid_felippa_rule, a Fortran77 code which returns Felippa's quadratures rules for approximating integrals over the interior of a pyramid in 3D.
  787. pyramid_felippa_rule_test
  788. pyramid_grid, a Fortran77 code which computes a grid of points over the interior of the unit pyramid in 3D;
  789. pyramid_grid_test
  790. pyramid_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit pyramid in 3D.
  791. pyramid_integrals_test
  792. pyramid_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit pyramid in 3D;
  793. pyramid_monte_carlo_test
  794. pyramid_rule, a Fortran77 code which computes a quadrature rule over the interior of the unit pyramid in 3D.
  795. pyramid_rule_test
  796. qr_solve, a Fortran77 code which computes the least squares solution of a linear system A*x=b.
  797. qr_solve_test
  798. quad, a Fortran77 code which applies a quadrature rule to estimate an integral, intended as a starting point for parallelization exercises.
  799. quad_test
  800. quad_mpi, a Fortran77 code which applies a quadrature rule to estimate an integral, using MPI;
  801. quad_mpi_test
  802. quad_openmp, a Fortran77 code which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution;
  803. quad_openmp_test
  804. quad_rule, a Fortran77 code which implements rules for approximate integration/quadrature in one dimension;
  805. quad_rule_test
  806. quad2d, a Fortran77 code which applies a product quadrature rule to estimate an integral over a 2D rectangle, intended as a starting point for parallelization exercises.
  807. quad2d_test
  808. quad2d_openmp, a Fortran77 code which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution;
  809. quad2d_openmp_test
  810. quadmom, a Fortran77 code which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
  811. quadmom_test
  812. quadpack, a Fortran77 code which estimates integrals using numerical quadrature, by Piessens, deDoncker-Kapenga, Ueberhuber, and Kahaner.
  813. quadpack_test
  814. quadrature_golub_welsch, a Fortran77 code which computes the points and weights of a Gaussian quadrature rule using the Golub-Welsch procedure.
  815. quadrature_golub_welsch_test
  816. quadrature_least_squares, a Fortran77 code which computes weights for sub-interpolatory quadrature rules, that is, it estimates integrals by integrating a polynomial that approximates the function data in a least squares sense.
  817. quadrature_least_squares_test
  818. quadrature_weights_vandermonde, a Fortran77 code which computes the weights of a quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  819. quadrature_weights_vandermonde_test
  820. quadrature_weights_vandermonde_2d, a Fortran77 code which computes the weights of a 2D quadrature rule using the Vandermonde matrix, assuming that the points have been specified.
  821. quadrature_weights_vandermonde_2d_test
  822. r4lib, a Fortran77 code which contains many utility routines, using "R4" or "single precision real" arithmetic.
  823. r4lib_test
  824. r8lib, a Fortran77 code which contains many utility routines, using "R8" or "double precision real" arithmetic.
  825. r8lib_test
  826. randlc, a Fortran77 code which is a random number generator (RNG) used by the NAS Benchmark programs.
  827. randlc_test
  828. random_data, a Fortran77 code which uses a random number generator (RNG) to sample points for various probability distributions, spatial dimensions, and geometries, including the M-dimensional cube, ellipsoid, simplex and sphere.
  829. random_data_test
  830. random_mpi, a Fortran77 code which demonstrates one way to use a random number generator (RNG) to generate the same sequence of values for both sequential execution and parallel execution under MPI.
  831. random_mpi_test
  832. random_openmp, a Fortran77 code which is a parallel program using OpenMP to generate multiple distinct streams of random numbers.
  833. random_openmp_test
  834. ranlib, a Fortran77 code which is a library of random number generators which produces random samples from Probability Density Functions (PDF), including Beta, Chi-square Exponential, F, Gamma, Multivariate normal, Noncentral chi-square, Noncentral F, Univariate normal, random permutations, Real uniform, Binomial, Negative Binomial, Multinomial, Poisson and Integer uniform, by Barry Brown and James Lovato.
  835. ranlib_test
  836. rbf_interp_1d, a Fortran77 code which defines and evaluates radial basis function (RBF) interpolants to 1D data.
  837. rbf_interp_1d_test
  838. rbf_interp_2d, a Fortran77 code which defines and evaluates radial basis function (RBF) interpolants to 2D data.
  839. rbf_interp_2d_test
  840. rbf_interp_nd, a Fortran77 code which defines and evaluates radial basis function (RBF) interpolants to multidimensional data.
  841. rbf_interp_nd_test
  842. reactor simulation, a Fortran77 code which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."
  843. reactor simulation_test
  844. ring_mpi, a Fortran77 code which uses the MPI parallel programming environment, and measures the time necessary to copy a set of data around a ring of processes.
  845. ring_mpi_test
  846. rk4, a Fortran77 code which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.
  847. rk4_test
  848. rkf45, a Fortran77 code which solves a system of ordinary differential equations (ODE) by the Runge-Kutta-Fehlberg method.
  849. rkf45_test
  850. rnglib, a Fortran77 code which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
  851. rnglib_test
  852. satisfy_brute, a Fortran77 code which uses brute force to find all assignments of values to a set of logical variables which make a complicated logical statement true.
  853. satisfy_brute_test
  854. satisfy_mpi, a Fortran77 code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using MPI to perform the calculation in parallel.
  855. satisfy_mpi_test
  856. satisfy_openmp, a Fortran77 code which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using OpenMP for parallel execution.
  857. satisfy_openmp_test
  858. schedule_openmp, a Fortran77 code which demonstrates the default, static, and dynamic methods of "scheduling" loop iterations in OpenMP to avoid work imbalance.
  859. schedule_openmp_test
  860. scotch_test, a Fortran77 program which tests the scotch sparse matrix package.
  861. sde, a Fortran77 code which illustrates properties of stochastic ordinary differential equations (SODE), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, making graphics files for processing and display by gnuplot(), by Desmond Higham;
  862. sde_test
  863. search_mpi, a Fortran77 code which searches integers between A and B for a solution J such that F(J)=C, carried out in parallel using MPI.
  864. search_mpi_test
  865. search_serial, a Fortran77 code which searches the integers from A to B for a value J such that F(J) = C. this version of the program is intended as a starting point for a parallel approach.
  866. search_serial_test
  867. select, a Fortran77 code which carries out Nijenhuis and Wilf's generalized combinatorial selection algorithm;
  868. select_test
  869. serba, a Fortran77 code which applies the boundary element method to solve the elasticify equation in a 2D region, by Federico Paris and Jose Canas.
  870. serba_test
  871. set_theory, a Fortran77 code which demonstrates various set theoretic operations using several models of a set.
  872. set_theory_test
  873. setmat, a Fortran77 code which sets and gets matrix entries using a variety of matrix storage formats.
  874. setmat_test
  875. sftpack, a Fortran77 code which implements the "slow" Fourier transform, intended as a teaching tool and comparison with the fast Fourier transform (FFT).
  876. sftpack_test
  877. sgefa_openmp, a Fortran77 code which compares a standard linear algebra solver against a revised version which runs in parallel with OpenMP.
  878. sgefa_openmp_test
  879. shepard_interp_1d, a Fortran77 code which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
  880. shepard_interp_1d_test
  881. shepard_interp_2d, a Fortran77 code which defines and evaluates Shepard interpolants to 2D data, based on inverse distance weighting.
  882. shepard_interp_2d_test
  883. shepard_interp_nd, a Fortran77 code which defines and evaluates Shepard interpolants to multidimensional data, based on inverse distance weighting.
  884. shepard_interp_nd_test
  885. simpack, a Fortran77 code which estimates an integral over a region that is the union of multidimensional simplexes, by Alan Genz.
  886. simpack_test
  887. simplex_coordinates, a Fortran77 code which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  888. simplex_coordinates_test
  889. simplex_gm_rule, a Fortran77 code which defines Grundmann-Moeller quadrature rules over the interior of a triangle in 2D, a tetrahedron in 3D, or over the interior of the simplex in M dimensions.
  890. simplex_gm_rule_test
  891. simplex_grid, a Fortran77 code which generates a regular grid of points over the interior of an arbitrary simplex in M dimensions.
  892. simplex_grid_test
  893. simplex_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.
  894. simplex_integrals_test
  895. simplex_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate an integral over the interior of the unit simplex in M dimensions.
  896. simplex_monte_carlo_test
  897. sine_transform, a Fortran77 code which demonstrates some simple properties of the discrete sine transform.
  898. sine_transform_test
  899. slap_io, a Fortran77 code which reads and writes SLAP sparse matrix files;
  900. slap_io_test
  901. snakes_and_ladders, a Fortran77 code which provides tools for the study of the game of Snakes and Ladders.
  902. snakes_and_ladders_test
  903. solve, a Fortran77 code which demonstrates how Gauss elimination solves a linear system A*x=b.
  904. solve_test
  905. sort_rc, a Fortran77 code which sorts a list of any kind of objects, using reverse communication (RC).
  906. sort_rc_test
  907. spaeth2, a Fortran77 code which performs the cluster analysis of data, by Helmut Spaeth;
  908. spaeth2_test
  909. sparse_display, a Fortran77 code which reads information defining a matrix of numbers and display the sparsity pattern or location of the nonzero elements using gnuplot(). This operation is already available in the built-in MATLAB spy() function.
  910. sparse_display_test
  911. sparse_grid_cc, a Fortran77 code which creates sparse grids based on Clenshaw-Curtis rules.
  912. sparse_grid_cc_test
  913. sparse_grid_hw, a Fortran77 code which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
  914. sparse_grid_hw_test
  915. sparse_interp_nd, a Fortran77 code which defines a sparse interpolant to a function f(x) of a M-dimensional argument.
  916. sparse_interp_nd_test
  917. sparsekit, a Fortran77 code which performs sparse matrix operations, by Yousef Saad;
  918. sparsekit_test
  919. sparsepak, a Fortran77 code which is a version of the Waterloo Sparse Matrix Package;
  920. sparsepak_test
  921. specfun, a Fortran77 code which computes special functions, including Bessel I, J, K and Y functions, Dawson Integral, Error (Erf), Exponential Integral (E1 and EI), Gamma, log Gamma, and Psi/Digamma, by William Cody and Laura Stoltz;
  922. specfun_test
  923. special_functions, a Fortran77 code which evaluates special functions, including Airy, Associated Legendre, Bernoulli Numbers, Bessel, Beta, Complete Elliptic Integral, Cosine Integral, Elliptic Integral, Error, Euler Numbers, Exponential Integral, Fresnel Integral, Gamma, Hankel, Hermite polynomials, Hypergeometric 2F1, Incomplete Beta, Incomplete Gamma, Jacobian Elliptic, Kelvin, Kummer Confluent Hypergeometric, Laguerre polynomials, Lambda, Legendre functions, Legendre polynomials, Mathieu, Modified Spherical Bessel, Parabolic Cylinder, Psi, Riccati-Bessel, Sine Integral, Spheroidal Angular, Spheroidal Wave, Struve, Tricomi Confluent Hypergeometric, Whittaker, by Shanjie Zhang, Jianming Jin;
  924. special_functions_test
  925. sphere_exactness, a Fortran77 code which tests the polynomial exactness of a quadrature rule on the surface of the unit sphere in 3D.
  926. sphere_exactness_test
  927. sphere_fibonacci_grid, a Fortran77 code which uses a Fibonacci spiral to create a grid of points on the surface of the unit sphere in 3D.
  928. sphere_fibonacci_grid_test
  929. sphere_grid, a Fortran77 code which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.
  930. sphere_grid_test
  931. sphere_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
  932. sphere_integrals_test
  933. sphere_lebedev_rule, a Fortran77 code which computes Lebedev quadrature rules on the surface of the unit sphere in 3D.
  934. sphere_lebedev_rule_test
  935. sphere_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.
  936. sphere_monte_carlo_test
  937. sphere_quad, a Fortran77 code which uses triangulation to approximate an integral on the surface of the unit sphere in 3D;
  938. sphere_quad_test
  939. sphere_stereograph, a Fortran77 code which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
  940. sphere_stereograph_test
  941. sphere_triangle_monte_carlo, a Fortran77 code which used the Monte Carlo method to estimate the integral of a function defined in a triangle on the surface of the unit sphere in 3D.
  942. sphere_triangle_monte_carlo_test
  943. sphere_triangle_quad, a Fortran77 code which uses quadrature to estimate the integral of a function in a spherical triangle on the surface of the unit sphere in 3D.
  944. sphere_triangle_quad_test
  945. spiral_exact, a Fortran77 code which computes a 2D velocity vector field that is an exact solution of the continuity equation.
  946. spiral_exact_test
  947. spline, a Fortran77 code which interpolates and approximates via splines;
  948. spline_test
  949. square_arbq_rule, a Fortran77 code which returns quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  950. square_arbq_rule_test
  951. square_exactness, a Fortran77 code which investigates the polynomial exactness of quadrature rules for f(x,y) over the interior of a rectangle in 2D.
  952. square_exactness_test
  953. square_felippa_rule, a Fortran77 code which returns Felippa's quadratures rules for approximating integrals over the interior of a square in 2D.
  954. square_felippa_rule_test
  955. square_grid, a Fortran77 code which computes a grid of points over the interior of a square in 2D.
  956. square_grid_test
  957. square_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit square in 2D.
  958. square_integrals_test
  959. square_monte_carlo, a Fortran77 code which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.
  960. square_monte_carlo_test
  961. square_symq_rule, a Fortran77 code which returns symmetric quadrature rules, with exactness up to total degree 20, over the interior of the symmetric square in 2D, by Hong Xiao and Zydrunas Gimbutas.
  962. square_symq_rule_test
  963. st_io, a Fortran77 code which reads and writes sparse linear systems stored in the Sparse Triplet (ST) format.
  964. st_io_test
  965. st_to_ccs, a Fortran77 code which converts sparse matrix data from Sparse Triplet (ST) format to Compressed Column Storage (CCS) format;
  966. st_to_ccs_test
  967. starpac, a Fortran77 code which carries out statistical data analysis, by Janet Donaldson.
  968. starpac_test
  969. stochastic_diffusion, functions which implement several versions of a stochastic diffusivity coefficient.
  970. stochastic_diffusion_test
  971. stochastic_heat2d, a Fortran77 code which implements a finite difference method (FDM) for the steady time-independent 2D heat equation, with a stochastic heat diffusivity coefficient, using gnuplot() to illustrate the results.
  972. stochastic_heat2d_test
  973. stochastic_rk, a Fortran77 code which applies a Runge-Kutta scheme to a stochastic ordinary differential equation (SODE).
  974. stochastic_rk_test
  975. stokes_2d_exact, a Fortran77 code which evaluates exact solutions to the incompressible steady Stokes equations over the unit square in 2D.
  976. stokes_2d_exact_test
  977. string_pde, a Fortran77 code which simulates the behavior of a vibrating string by solving the corresponding initial boundary value problem (IBVP), creating files to be displayed by gnuplot().
  978. string_pde_test
  979. stroud, a Fortran77 code which defines quadrature rules for a variety of M-dimensional regions, including the interior of the square, cube and hypercube, the pyramid, cone and ellipse, the hexagon, the M-dimensional octahedron, the circle, sphere and hypersphere, the triangle, tetrahedron and simplex, and the surface of the circle, sphere and hypersphere.
  980. stroud_test
  981. subpak, a Fortran77 code which implements a wide variety of operations on real and integer vectors and matrices;
  982. subpak_test
  983. subset, a Fortran77 code which enumerates, generates, randomizes, ranks and unranks combinatorial objects including combinations, compositions, Gray codes, index sets, partitions, permutations, polynomials, subsets, and Young tables. Backtracking routines are included to solve some combinatorial problems.
  984. subset_test
  985. subset_sum, a Fortran77 code which seeks solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  986. subset_sum_test
  987. subset_sum_brute, a Fortran77 code which uses brute force to find solutions of the subset sum problem, in which it is desired to find a subset of integers which has a given sum.
  988. subset_sum_brute_test
  989. svd_snowfall, a Fortran77 code which reads a file containing historical snowfall data and analyzes the data with the Singular Value Decomposition (SVD), displaying the results using gnuplot().
  990. svd_snowfall_test
  991. svd_test, a Fortran77 code which demonstrates the calculation of the singular value decomposition (SVD) and some of its properties;
  992. svd_truncated, a Fortran77 code which demonstrates the computation of the reduced or truncated Singular Value Decomposition (SVD) that is useful for cases when one dimension of the matrix is much smaller than the other.
  993. svd_truncated_test
  994. table_io, a Fortran77 code which reads and writes a set of data as a table file.
  995. table_io_test
  996. task_division, a Fortran77 code which implements a simple procedure for smoothly dividing T tasks among P processors; such a method is suitable for MPI and other parallel environments, particularly when T is not an exact multiple of P, and when the processors are indexed starting from 0 or from 1.
  997. task_division_test
  998. tcell, a Fortran77 code which solves the time-dependent 2D incompressible Navier Stokes equations in a T-shaped region, by Hyung-Chun Lee.
  999. tcell_test
  1000. tcell_mass, a Fortran77 code which creates and saves the mass matrix associated with a finite element method (FEM) solution of the time dependent 2D incompressible Navier Stokes equations in the TCELL region, by Hyung-Chun Lee.
  1001. tcell_mass_test
  1002. templated, a Fortran77 code which forms basic implementations of iterative methods for solving large sparse linear systems, using double precision arithmetic.
  1003. templated_test
  1004. templates, a Fortran77 code which forms basic implementations of iterative methods for solving large sparse linear systems;
  1005. templates_test
  1006. test_approx, a Fortran77 code which implements test problems for approximation, provided as a set of (x,y) data.
  1007. test_approx_test
  1008. test_con, a Fortran77 code which implements test problems for numerical continuation.
  1009. test_con_test
  1010. test_eigen, a Fortran77 code which implements test matrices for eigenvalue analysis.
  1011. test_eigen_test
  1012. test_int, a Fortran77 code which implements test problems for approximate integration/quadrature in one dimension.
  1013. test_int_test
  1014. test_int_circle, a Fortran77 code which defines several test integrals over the unit circle, making it possible to check the accuracy of quadrature rules.
  1015. test_int_circle_test
  1016. test_int_2d, a Fortran77 code which implements test problems for approximate integration/quadrature in two dimensions.
  1017. test_int_2d_test
  1018. test_interp, a Fortran77 code which defines test problems for interpolation, provided as a set of (x,y(x)) data.
  1019. test_interp_test
  1020. test_interp_1d, a Fortran77 code which defines test problems for interpolation of data y(x), which depends on a 1D argument.
  1021. test_interp_1d_test
  1022. test_interp_2d, a Fortran77 code which defines test problems for interpolation of data z(x,y), depending on a 2D argument.
  1023. test_interp_2d_test
  1024. test_interp_fun, a Fortran77 code which defines functions whose sampled data can be used in testing interpolation algorithms.
  1025. test_interp_fun_test
  1026. test_interp_nd, a Fortran77 code which defines test problems for interpolation of data z(x), depending on an M-dimensional argument.
  1027. test_interp_nd_test
  1028. test_laplace, a Fortran77 code which returns examples of a forward function f(t) and its corresponding Laplace transform L(f,z).
  1029. test_laplace_test
  1030. test_lls, a Fortran77 code which implements linear least squares test problems of the form A*x=b.
  1031. test_lls_test
  1032. test_matrix, a Fortran77 code which defines test matrices for which some of the determinant, eigenvalues, inverse, null vectors, P*L*U factorization or linear system solution are already known, including the Vandermonde matrix.
  1033. test_matrix_test
  1034. test_matrix_exponential, a Fortran77 code which defines tests for computing the matrix exponential function.
  1035. test_matrix_exponential_test
  1036. test_min, a Fortran77 code which implements test problems for minimization of a scalar function of a scalar variable.
  1037. test_min_test
  1038. test_nearest, a Fortran77 code which tests the time complexity of various procedures for solving the nearest neighbor problem.
  1039. test_nearest_test
  1040. test_nonlin, a Fortran77 code which implements test problems for the solution of systems of nonlinear equations.
  1041. test_nonlin_test
  1042. test_opt_con, a Fortran77 code which defines test problems for the minimization of a scalar function of several variables, with the search constrained to lie within a specified hyper-rectangle.
  1043. test_opt_con_test
  1044. test_optimization, a Fortran77 code which implements test problems for optimization of a scalar function of several variables, as described by Molga and Smutnicki.
  1045. test_optimization_test
  1046. test_values, a Fortran77 code which supplies test values of various mathematical functions, including Abramowitz, AGM, Airy, Bell, Bernoulli, Bessel, Beta, Binomial, Bivariate Normal, Catalan, Cauchy, Chebyshev, Chi Square, Clausen, Clebsch Gordan, Collatz, Cosine integral, Dawson, Debye, Dedekind, dilogarithm, 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.
  1047. test_values_test
  1048. test_zero, a Fortran77 code which implements test problems for the solution of a single nonlinear equation in one variable.
  1049. test_zero_test
  1050. tester, a BASH script which runs the test programs.
  1051. testpack, a Fortran77 code which contains a set of test integrand functions, by Alan Genz.
  1052. testpack_test
  1053. tet_mesh, a Fortran77 code which carries out various tasks associated with tetrahedral meshes in 3D;
  1054. tet_mesh_test
  1055. tet_mesh_to_gmsh, a Fortran77 code which writes a tetrahedral mesh to a gmsh() file.
  1056. tet_mesh_to_gmsh_test
  1057. tet_mesh_to_xml, a Fortran77 code which writes a tetrahedral mesh to an XML file.
  1058. tet_mesh_to_xml_test
  1059. tetrahedron, a Fortran77 code which computes properties, including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume, of a tetrahedron in 3D.
  1060. tetrahedron_test
  1061. tetrahedron_analyze, a Fortran77 code which computes properties, including the centroid, circumsphere, dihedral angles, edge lengths, face angles, face areas, insphere, quality, solid angles, and volume, of a tetrahedron in 3D,
  1062. tetrahedron_analyze_test
  1063. tetrahedron_arbq_rule, a Fortran77 code which returns quadrature rules, with exactness up to total degree 15, over the interior of a tetrahedron in 3D, by Hong Xiao and Zydrunas Gimbutas.
  1064. tetrahedron_arbq_rule_test
  1065. tetrahedron_exactness, a Fortran77 code which tests the polynomial exactness of a quadrature rule over the interior of a tetrahedron in 3D.
  1066. tetrahedron_exactness_test
  1067. tetrahedron_felippa_rule, a Fortran77 code which returns Felippa's quadratures rules for approximating integrals over the interior of a tetrahedron in 3D.
  1068. tetrahedron_felippa_rule_test
  1069. tetrahedron_grid, a Fortran77 code which computes a grid of points over the interior of a tetrahedron in 3D.
  1070. tetrahedron_grid_test
  1071. tetrahedron_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit tetrahedron in 3D.
  1072. tetrahedron_integrals_test
  1073. tetrahedron_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate an integral over the interior of a general tetrahedron in 3D.
  1074. tetrahedron_monte_carlo_test
  1075. tetrahedron01_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate an integral over the interior of the unit tetrahedron in 3D.
  1076. tetrahedron01_monte_carlo_test
  1077. timer_test, a Fortran77 code which illustrates how executing code may be timed.
  1078. timestamp, a Fortran77 code which prints out the YMDHMS date as a timestamp.
  1079. timestamp_test
  1080. toeplitz, a Fortran77 code which implements Toeplitz matrix system solvers.
  1081. toeplitz_test
  1082. toeplitz_cholesky, a Fortran77 code which computes the Cholesky factorization of a nonnegative definite symmetric Toeplitz matrix.
  1083. toeplitz_cholesky_test
  1084. toms097, a Fortran77 code which computes the distance between all pairs of nodes in a directed graph with weighted edges, using Floyd's algorithm. This is a version of ACM TOMS algorithm 097.
  1085. toms097_test
  1086. toms178, a Fortran77 code which seeks the minimizer of a scalar function of several variables using the Hooke-Jeeves method; this is a version of ACM TOMS algorithm 178.
  1087. toms178_test
  1088. toms179, a Fortran77 code which calculates the incomplete Beta ratio; this is a version of ACM TOMS algorithm 179.
  1089. toms179_test
  1090. toms291, a Fortran77 code which approximates the logarithm of the Gamma function; this is a version of ACM TOMS algorithm 291.
  1091. toms291_test
  1092. toms322, a Fortran77 code which evaluates the normal, Student's T, F and chi-square cumulative density functions (CDF); this is a version of ACM TOMS algorithm 322.
  1093. toms322_test
  1094. toms332, a Fortran77 code which evaluates Jacobi polynomials; this is a version of ACM TOMS algorithm 332.
  1095. toms332_test
  1096. toms343, a Fortran77 code which computes the eigenvalues and eigenvectors of a general real matrix; this is a version of ACM TOMS algorithm 343.
  1097. toms343_test
  1098. toms344, a Fortran77 code which calculates the Student T distribution; this is a version of ACM TOMS algorithm 344.
  1099. toms344_test
  1100. toms347, a Fortran77 code which sorts an integer vector; this is a version of ACM TOMS algorithm 347.
  1101. toms347_test
  1102. toms351, a Fortran77 code which estimates an integral using Romberg integration; this is a version of ACM TOMS algorithm 351.
  1103. toms351_test
  1104. toms352, a Fortran77 code which computes the characteristic values and associated solutions of Mattieu's differential equation; this is a version of ACM TOMS algorithm 352.
  1105. toms352_test
  1106. toms353, a Fortran77 code which estimates an integral involving a cosine or sine factor using Filon quadrature; this is a version of ACM TOMS algorithm 353.
  1107. toms353_test
  1108. toms358, a Fortran77 code which computes the singular value decomposition (SVD) of a complex matrix; this is a version of ACM TOMS algorithm 358.
  1109. toms358_test
  1110. toms359, a Fortran77 code which computes the factorial analysis of variance; this is a version of ACM TOMS algorithm 359.
  1111. toms359_test
  1112. toms365, a Fortran77 code which finds a root of an analytic complex function by the downhill method; this is a version of ACM TOMS algorithm 365.
  1113. toms365_test
  1114. toms370, a Fortran77 code which produces random numbers sampled from an arbitrary probability density function (PDF); this is a version of ACM TOMS algorithm 370.
  1115. toms370_test
  1116. toms379, a Fortran77 code which approximates the integral of a function, by James Lyness. this is a version of ACM TOMS algorithm 379.
  1117. toms379_test
  1118. toms384, a Fortran77 code which computes the eigenvalues and eigenvectors of a symmetric matrix; this is a version of ACM TOMS algorithm 384.
  1119. toms384_test
  1120. toms385, a Fortran77 code which evaluates the exponential integral function; this is a version of ACM TOMS algorithm 385.
  1121. toms385_test
  1122. toms392, a Fortran77 code which approximates the time evolution of a hyperbolic partial differential equation (PDE); this is a version of ACM TOMS algorithm 392.
  1123. toms392_test
  1124. toms418, a Fortran77 code which estimates Fourier integrals of the form integral ( a<=x<=b ) f(x) * cos(wx) dx, or integral ( a<=x<=b ) f(x) * sin(wx) dx, by Bo Einarsson. This is a version of ACM TOMS algorithm 418.
  1125. toms418_test
  1126. toms419, a Fortran77 code which seeks the zeroes of a polynomial with complex coefficients; this code is commonly called cpoly(); this is a version of ACM TOMS algorithm 419.
  1127. toms419_test
  1128. toms423, a Fortran77 code which implements Gaussian elimination, revised versions of decomp() and solve(); this is a version of ACM TOMS algorithm 423.
  1129. toms423_test
  1130. toms424, a Fortran77 code which implements Clenshaw-Curtis integration; this is a version of ACM TOMS algorithm 424.
  1131. toms424_test
  1132. toms425, a Fortran77 code which generates a sequence of vectors from a multivariate normal distribution with given covariance; this is a version of ACM TOMS algorithm 425.
  1133. toms425_test
  1134. toms427, a Fortran77 code which estimates the value of a Fourier cosine integral of the form integral ( 0 <= x < +oo ) f(t) cos ( w * t ) dt, by Peter Linz. This is a version of ACM TOMS algorithm 427.
  1135. toms427_test
  1136. toms429, a Fortran77 code which reports information about the estimated location of roots of a polynomial; this is a version of ACM TOMS algorithm 429.
  1137. toms429_test
  1138. toms431, a Fortran77 code which solves quadratic and linear programming problems; this is a version of ACM TOMS algorithm 431.
  1139. toms431_test
  1140. toms434, a Fortran77 code which computes the probability of a given RxC contingency table; this is a version of ACM TOMS algorithm 434.
  1141. toms434_test
  1142. toms435, a Fortran77 code which computes the modified incomplete gamma function; this is a version of ACM TOMS algorithm 435.
  1143. toms435_test
  1144. toms436, a Fortran77 code which carries out product-type trapezoidal integration; this is a version of ACM TOMS algorithm 436.
  1145. toms436_test
  1146. toms437, a Fortran77 code which carries out product-type Simpson's integration; this is a version of ACM TOMS algorithm 437.
  1147. toms437_test
  1148. toms438, a Fortran77 code which carries out product-type two point Gauss-Legendre-Simpson integration; this is a version of ACM TOMS algorithm 438.
  1149. toms438_test
  1150. toms439, a Fortran77 code which carries out product-type three point Gauss-Legendre-Simpson integration; this is a version of ACM TOMS algorithm 439.
  1151. toms439_test
  1152. toms441, a Fortran77 code which samples the dipole distribution; this is a version of ACM TOMS algorithm 441.
  1153. toms441_test
  1154. toms443, a Fortran77 code which evaluates Lambert's W function; this is a version of ACM TOMS algorithm 443.
  1155. toms443_test
  1156. toms446, a Fortran77 code which manipulates Chebyshev series for interpolation and approximation; this is a version of ACM TOMS algorithm 446, by Roger Broucke.
  1157. toms446_test
  1158. toms448, a Fortran77 code which counts the number of partitions of an integer into a given set of integers; this is a version of ACM TOMS algorithm 448.
  1159. toms448_test
  1160. toms449, a Fortran77 code which solves linear programming problems with variables restricted to 0 and 1 values; this is a version of ACM TOMS algorithm 449.
  1161. toms449_test
  1162. toms450, a Fortran77 code which minimizes a scalar function of N variables using the method of Rosenbrock; this is a version of ACM TOMS algorithm 450.
  1163. toms450_test
  1164. toms451, a Fortran77 code which determines quantiles of the Chi-Square distribution; this is a version of ACM TOMS algorithm 451.
  1165. toms451_test
  1166. toms452, a Fortran77 code which generates a sequence of combinations of M things out of N; this is a version of ACM TOMS algorithm 452.
  1167. toms452_test
  1168. toms453, a Fortran77 code which determines the abscissas and weights for a Gaussian quadrature formula for Bromwich's integral; this is a version of ACM TOMS algorithm 453.
  1169. toms453_test
  1170. toms454, a Fortran77 code which implements the complex method of constrained optimization; this is a version of ACM TOMS algorithm 454.
  1171. toms454_test
  1172. toms456, a Fortran77 code which implements the routing algorithm; this is a version of ACM TOMS algorithm 456.
  1173. toms456_test
  1174. toms460, a Fortran77 code which determines the optimal parameters for an alternating direction implicit (ADI) iteration; this is a version of ACM TOMS algorithm 460.
  1175. toms460_test
  1176. toms461, a Fortran77 code which applies cubic spline solutions to a class of functional differential equations; this is a version of ACM TOMS algorithm 461.
  1177. toms461_test
  1178. toms462, a Fortran77 code which evaluates the bivariate normal distribution; this is a version of ACM TOMS algorithm 462.
  1179. toms462_test
  1180. toms463, a Fortran77 code which chooses "nice" ranges for a graph of computer-generated data; this is a version of ACM TOMS algorithm 463.
  1181. toms463_test
  1182. toms467, a Fortran77 code which transposes a matrix in place; this is a version of ACM TOMS algorithm 467.
  1183. toms467_test
  1184. toms468, a Fortran77 code which carries out automatic numerical integration; this is a version of ACM TOMS algorithm 468.
  1185. toms468_test
  1186. toms470, a Fortran77 code which solves an almost tridiagonal system of linear equations; this is a version of ACM TOMS algorithm 470.
  1187. toms470_test
  1188. toms493, a Fortran77 code which seeks the roots of a real polynomial, commonly called rpoly(); this is a version of ACM TOMS algorithm 493, by Michael Jenkins.
  1189. toms493_test
  1190. toms494, a Fortran77 code which approximates a 1D partial differential equation (PDE) as a system of ordinary differential equation (ODE); this library is commonly called pdeone(); this is a version of ACM TOMS algorithm 494.
  1191. toms494_test
  1192. toms502, a Fortran77 code which computes a sequence of solutions of a parameterized system of equations; this is a version of ACM TOMS algorithm 502.
  1193. toms502_test
  1194. toms511, a Fortran77 code which evaluates Bessel I or J functions of real, non integer, order, This is a version of ACM TOMS Algorithm 511;
  1195. toms511_test
  1196. toms515, a Fortran77 code which selects random subsets of size K from a set of size N, This is a version of ACM TOMS Algorithm 515, by Bill Buckles, Matthew Lybanon.
  1197. toms515_test
  1198. toms526, a Fortran77 code which interpolates scattered bivariate data, by Hiroshi Akima; this is a version of ACM TOMS algorithm 526.
  1199. toms526_test
  1200. toms550, a Fortran77 code which evaluates certain measures of a solid polyhedron, including surface area, centroid, volume, weight, moments and products of inertia; this is a version of ACM TOMS algorithm 550.
  1201. toms550_test
  1202. toms552, a Fortran77 code which solves an overdetermined constrained linear system; this is a version of ACM TOMS algorithm 552.
  1203. toms552_test
  1204. toms563, a Fortran77 code which solves a linearly constrained L1 minimization problem, by Richard Bartels, Andrew Conn. This is a version of ACM TOMS algorithm 563.
  1205. toms563_test
  1206. toms565, a Fortran77 code which approximates the solution of a system of time-dependent partial differential equations (PDE) over a 2D domain; this library is commonly called pdetwo(); this is a version of ACM TOMS algorithm 565;
  1207. toms565_test
  1208. toms571, a Fortran77 code which evaluates or inverts the von Mises and Fisher distributions of directions on a circle or sphere; this is a version of ACM TOMS algorithm 571.
  1209. toms571_test
  1210. toms577, a Fortran77 code which evaluates Carlson's elliptic integral functions rc(), rd(), rf() and rj(). This is a version of ACM TOMS algorithm 577.
  1211. toms577_test
  1212. toms581, a Fortran77 code which implements an improved algorithm for the singular value decomposition (SVD) of a rectangular matrix, by Tony Chan. this is a version of ACM TOMS algorithm 581.
  1213. toms581_test
  1214. toms596, a Fortran77 code which seeks to produce a sequence of points that satisfy a set of nonlinear equations with one degree of freedom; this library is commonly called pitcon(); this is a version of ACM TOMS algorithm 596.
  1215. toms596_test
  1216. toms597, a Fortran77 code which evaluates Bessel functions I of real, non-integer order, by William Cody. This is a version of ACM TOMS Algorithm 597;
  1217. toms597_test
  1218. toms599, a Fortran77 code which produces samples from the exponential, gamma, normal, Poisson, and uniform distributions, by Ahrens, Dieter, and Kohrt. This is a version of ACM TOMS algorithm 599.
  1219. toms599_test
  1220. toms611, a Fortran77 code which performs unconstrained optimization of a scalar function; this library is commonly called uncmin(); this is a version of ACM TOMS algorithm 611.
  1221. toms611_test
  1222. toms612, a Fortran77 code which approximates the integral of a function over a triangle; the code is commonly known as triex(); this is a version of ACM TOMS algorithm 612.
  1223. toms612_test
  1224. toms614, a Fortran77 code which computes the integral of functions which may have singularities at one or both ends of a interval, which may be finite, semi-infinite, or infinite, by Sikorski, Sprenger, Schwing. This is a version of ACM TOMS algorithm 614.
  1225. toms614_test
  1226. toms626, a Fortran77 code which creates a contour plot of data associated with a triangulated set of points. This is a version of ACM TOMS algorithm 626.
  1227. toms626_test
  1228. toms632, a Fortran77 code which solves the multiple knapsack problem, by Silvano Martello and Paolo Toth. This is a version of ACM TOMS algorithm 632.
  1229. toms632_test
  1230. toms641, a Fortran77 code which computes the exact solution of a system of linear equations, by John Springer. This is a version of ACM TOMS algorithm 641.
  1231. toms641_test
  1232. toms644, a Fortran77 code which evaluates the Bessel I, J, K, Y functions, the Airy functions Ai and Bi, and the Hankel function, for complex argument and real order. This is a version of ACM TOMS algorithm 644.
  1233. toms644_test
  1234. toms647, a Fortran77 code which evaluates the Faure, Halton, and Sobol quasirandom sequences, this is a version of ACM TOMS algorithm 647;
  1235. toms647_test
  1236. toms648, a Fortran77 code which defines non-stiff test problems for solvers of ordinary differential equations (ODE); this is a version of one part of ACM TOMS algorithm 648.
  1237. toms648_test
  1238. toms655, a Fortran77 code which computes the weights for interpolatory quadrature rule; this library is commonly called iqpack(), and is by Sylvan Elhay and Jaroslav Kautsky. this version of ACM TOMS algorithm 655 has been extensively modified.
  1239. toms655_test
  1240. toms659, a Fortran77 code which computes elements of the Sobol quasirandom sequence; this is a version of ACM TOMS algorithm 659.
  1241. toms659_test
  1242. toms660, a Fortran77 code which takes scattered data in 2D and creates an interpolating function F(X,Y); this program is often called qshep2d(); this is a version of ACM TOMS algorithm 660, by Robert Renka.
  1243. toms660_test
  1244. toms661, a Fortran77 code which takes scattered data in 3D and creates an interpolating function F(X,Y,Z), called qshep3d(); this is a version of ACM TOMS algorithm 661, by Robert Renka.
  1245. toms661_test
  1246. toms664, a Fortran77 code which uses Gauss elimination to solve linear systems involving large banded matrices. Disk storage is used when there is not enough memory for the working data; this library is commonly called gbsol(); this is a version of ACM TOMS algorithm 664.
  1247. toms664_test
  1248. toms666, a Fortran77 code which locates and evaluates roots of systems of nonlinear equations, by Michael Vrahatis. This is a version of ACM TOMS algorithm 666.
  1249. toms666_test
  1250. toms672, a Fortran77 code which generates an interpolatory quadrature rule of highest possible order, given a set of preassigned abscissas; this library is commonly called extend(); this is a version of ACM TOMS algorithm 672.
  1251. toms672_test
  1252. toms699, a Fortran77 code which implements a new representation of Patterson's quadrature formula; this is a version of ACM TOMS algorithm 699.
  1253. toms699_test
  1254. toms706, a Fortran77 code which estimates the integral of a function over a triangulated region; this library is commonly called dcutri(); this is a version of ACM TOMS algorithm 706.
  1255. toms706_test
  1256. toms707, a Fortran77 code which evaluates the confluent hypergeometric function for complex arguments of large magnitude, by Warren Perger, Atul Bhalla, and Mark Nardin. This is a version of ACM TOMS algorithm 707.
  1257. toms707_test
  1258. toms708, a Fortran77 code which evaluates the incomplete beta function; this is a version of ACM TOMS algorithm 708.
  1259. toms708_test
  1260. toms715, a Fortran77 code which evaluates special functions, including the Bessel I, J, K, and Y functions of order 0, of order 1, and of any real order, Dawson's integral, the error function, exponential integrals, the gamma function, the normal distribution function, the psi function. This is a version of ACM TOMS algorithm 715.
  1261. toms715_test
  1262. toms723, a Fortran77 code which computes the Fresnel sine and cosine integrals, by W van Snyder. This is a version of ACM TOMS algorithm 723.
  1263. toms723_test
  1264. toms724, a Fortran77 code which computes the inverse Cumulative Density Function (CDF) or percentiles of the F distribution, by Roger Abernathy and Robert Smith. This is a version of ACM TOMS algorithm 724.
  1265. toms724_test
  1266. toms725, a Fortran77 code which evaluates multivariate normal integrals associated with the computation of the cumulative probability density function (CDF) associated with a multidimensional variable governed by a normal probability density function (PDF) with a known correlation matrix, by Zvi Drezner. This is a version of ACM TOMS algorithm 725.
  1267. toms725_test
  1268. toms726, a Fortran77 code which computes recursion coefficients for orthogonal polynomials, and the abscissa and weights for related quadrature rules; this code is commonly called orthpol(), and is by Walter Gautschi. This is a version of ACM TOMS algorithm 726.
  1269. toms726_test
  1270. toms738, a Fortran77 code which evaluates Niederreiter's quasirandom sequence; this is a version of ACM TOMS algorithm 738;
  1271. toms738_test
  1272. toms743, a Fortran77 code which evaluates Lambert's W function. This is a version of ACM TOMS algorithm 743, by Barry, Barry and Culligan-Hensley.
  1273. toms743_test
  1274. toms757, a Fortran77 code which evaluates uncommon special functions, by Allan Mcleod. This is a version of ACM TOMS algorithm 757;
  1275. toms757_test
  1276. toms772, a Fortran77 code which carries out computational geometry on the unit sphere; this library is commonly called stripack(), by Robert Renka. This is a version of ACM TOMS algorithm 772.
  1277. toms772_test
  1278. toms790, a Fortran77 code which computes an interpolating function to scattered data in the plane; this library is commonly called cshep2d(); by Robert Renka. This is a version of ACM TOMS algorithm 790.
  1279. toms790_test
  1280. toms792, a Fortran77 code which tests functions that interpolate scattered data in the plane; by Robert Renka. This is a version of ACM TOMS algorithm 792.
  1281. toms792_test
  1282. toms793, a Fortran77 code which carries out Gauss quadrature for rational functions, by Walter Gautschi. This library is commonly called gqrat(). This is a version of ACM TOMS algorithm 793.
  1283. toms793_test
  1284. toms886, a Fortran77 code which defines the Padua points for interpolation in a 2D region, including the rectangle, triangle, and ellipse, by Marco Caliari, Stefano de Marchi, Marco Vianello. This is a version of ACM TOMS algorithm 886.
  1285. toms886_test
  1286. trapezoidal, a Fortran77 code which solves one or more ordinary differential equations (ODE) using the (implicit) trapezoidal method, and a version of fsolve() to handle the nonlinear equation.
  1287. trapezoidal_test
  1288. treepack, a Fortran77 code which carries out computations on trees, a simple kind of graph that is minimally connected.
  1289. treepack_test
  1290. triangle, a Fortran77 code which computes properties, including angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality, of a triangle in 2D.
  1291. triangle_test
  1292. triangle_analyze, a Fortran77 code which reads a triangle defined in a file, and computes angles, area, centroid, circumcircle, edge lengths, incircle, orientation, orthocenter, and quality.
  1293. triangle_analyze_test
  1294. triangle_exactness, a Fortran77 code which tests the polynomial exactness of a quadrature rule over the interior of a triangle in 2D.
  1295. triangle_exactness_test
  1296. triangle_felippa_rule, a Fortran77 code which returns Felippa's quadratures rules for approximating integrals over the interior of a triangle in 2D.
  1297. triangle_felippa_rule_test
  1298. triangle_grid, a Fortran77 code which computes a grid of points over the interior of a triangle in 2D.
  1299. triangle_grid_test
  1300. triangle_integrals, a Fortran77 code which returns the exact value of the integral of any polynomial over the interior of an arbitrary triangle in 2D.
  1301. triangle_integrals_test
  1302. triangle_io, a Fortran77 code which reads or writes some of the files created by Jonathan Shewchuk's triangle() program.
  1303. triangle_io_test
  1304. triangle_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate an integral over the interior of a general triangle in 2D.
  1305. triangle_monte_carlo_test
  1306. triangle_svg, a Fortran77 code which uses Scalable Vector Graphics (SVG) to plot a triangle and any number of points, to illustrate quadrature rules and sampling techniques.
  1307. triangle_svg_test
  1308. triangle_symq_rule, a Fortran77 code which returns efficient symmetric quadrature rules, with exactness up to total degree 50, over the interior of a triangle in 2D, by Hong Xiao and Zydrunas Gimbutas.
  1309. triangle_symq_rule_test
  1310. triangle_to_fem, a Fortran77 code which reads the NODE and ELE files created by the triangle program to describe a triangular mesh, and writes a corresponding pair of node and element files in the 2D FEM format.
  1311. triangle_to_fem_test
  1312. triangle_to_medit, a Fortran77 code which reads the NODE and ELE files created by the triangle() program to describe a triangular mesh, and writes a corresponding MESH file for input to medit().
  1313. triangle_to_medit_test
  1314. triangle_to_xml, a Fortran77 code which reads the NODE and ELE files created by triangle() to describe a triangular mesh in 2D, and writes out a corresponding XML mesh file for use by dolfin() or fenics().
  1315. triangle_to_xml_test
  1316. triangle01_integrals, a Fortran77 code which returns the integral of any monomial over the interior of the unit triangle in 2D.
  1317. triangle01_integrals_test
  1318. triangle01_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate an integral over the interior of the unit triangle in 2D.
  1319. triangle01_monte_carlo_test
  1320. triangulation, a Fortran77 code which computes the triangulation of a set of points in the plane, and performs various operations using a triangulation, including searching a Delaunay triangulation to find which triangle contains a given point.
  1321. triangulation_test
  1322. triangulation_node_to_element, a Fortran77 code which reads files describing a set of nodes, their triangulation, and the value of one or more quantities at each node, and outputs a file that averages the quantities for each element. This operation in effect creates an "order1" finite element model of the data.
  1323. triangulation_node_to_element_test
  1324. triangulation_svg, a Fortran77 code which creates an SVG image of a triangulation, to be displayed by a web browser.
  1325. triangulation_svg_test
  1326. tripack, a Fortran77 code which computes constrained Delaunay triangulation in the plane, ACM TOMS algorithm 751, by Robert Renka.
  1327. tripack_test
  1328. truncated_normal, a Fortran77 code which works with the truncated normal distribution over [A,B], or [A,+oo) or (-oo,B], returning the probability density function (PDF), the cumulative density function (CDF), the inverse CDF, the mean, the variance, and sample values.
  1329. truncated_normal_test
  1330. truncated_normal_rule, a Fortran77 code which computes a quadrature rule for a normal distribution that has been truncated to [A,+oo), (-oo,B] or [A,B].
  1331. truncated_normal_rule_test
  1332. tsp_brute, a Fortran77 code which reads a file of city-to-city distances and solves a small traveling salesperson problem, using brute force.
  1333. tsp_brute_test
  1334. ttyplt, a Fortran77 code which produces simple typewriter graphics plots.
  1335. ttyplt_test
  1336. umfpack, a Fortran77 code which solve a large sparse linear system, by Timothy Davis.
  1337. umfpack_test
  1338. umfpack_2.0, a Fortran77 code which solve a large sparse linear system, by Timothy Davis.
  1339. umfpack_2.0_test
  1340. uncmin, a Fortran77 code which performs unconstrained optimization of a scalar function; this is a version of ACM TOMS algorithm 611.
  1341. uncmin_test
  1342. unicycle, a Fortran77 code which considers permutations containing a single cycle, sometimes called cyclic permutations.
  1343. unicycle_test
  1344. uniform, a Fortran77 code which generates uniform random numbers.
  1345. uniform_test
  1346. valgrind_test, a Fortran77 code which uses valgrind() to detect memory leaks.
  1347. vandermonde, a Fortran77 code which carries out certain operations associated with the Vandermonde matrix.
  1348. vandermonde_test
  1349. vandermonde_approx_1d, a Fortran77 code which finds a polynomial approximant to data y(x) of a 1D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix.
  1350. vandermonde_approx_1d_test
  1351. vandermonde_approx_2d, a Fortran77 code which finds a polynomial approximant p(x,y) to data z(x,y) of a 2D argument by setting up and solving an overdetermined linear system for the polynomial coefficients involving the Vandermonde matrix
  1352. vandermonde_interp_1d, a Fortran77 code which finds a polynomial interpolant to data y(x) of a 1D argument by setting up and solving a linear system for the polynomial coefficients involving the Vandermonde matrix, creating graphics files for processing by gnuplot().
  1353. vandermonde_interp_2d, a Fortran77 code which finds a polynomial interpolant to data z(x,y) of a 2D argument by setting up and solving a linear system for the polynomial coefficients involving the Vandermonde matrix.
  1354. walsh_transform, a Fortran77 code which implements the Walsh data transform.
  1355. walsh_transform_test
  1356. wathen_matrix, a Fortran77 code which compares storage schemes: full, banded, sparse triplet, and solution strategies: Linpack full, Linpack banded, conjugate gradient, for linear systems involving the Wathen matrix, which arises when solving a problem using the finite element method (FEM).
  1357. wathen_matrix_test
  1358. wave_mpi, a Fortran77 code which uses finite differences and MPI to estimate a solution to the wave equation.
  1359. wave_mpi_test
  1360. wavelet, a Fortran77 code which does some simple wavelet calculations;
  1361. wavelet_test
  1362. wedge_exactness, a Fortran77 code which investigates the polynomial exactness of a quadrature rule over the interior of the unit wedge in 3D.
  1363. wedge_exactness_test
  1364. wedge_felippa_rule, a Fortran77 code which returns quadrature rules for approximating integrals over the interior of the unit wedge in 3D.
  1365. wedge_felippa_rule_test
  1366. wedge_grid, a Fortran77 code which computes a grid of points over the interior of the unit wedge in 3D.
  1367. wedge_grid_test
  1368. wedge_integrals, a Fortran77 code which returns the exact value of the integral of any monomial over the interior of the unit wedge in 3D.
  1369. wedge_integrals_test
  1370. wedge_monte_carlo, a Fortran77 code which uses the Monte Carlo method to estimate an integral over the interior of the unit wedge in 3D.
  1371. wedge_monte_carlo_test
  1372. weekday, a Fortran77 code which determines the day of the week corresponding to a given date, such as 14 October 1066, Julian calendar, ... which was a Saturday.
  1373. weekday_test
  1374. wishart_matrix, a Fortran77 code which produces sample matrices from the Wishart or Bartlett distributions, useful for sampling random covariance matrices.
  1375. wishart_matrix_test
  1376. wtime, a Fortran77 code which returns a reading of the wall clock time in seconds.
  1377. wtime_test
  1378. xerror, a Fortran77 code which reports and handles errors detected during program execution.
  1379. xerror_test
  1380. zero_brent, a Fortran77 code which seeks a solution of a scalar nonlinear equation f(x)=0, by Richard Brent.
  1381. zero_brent_test
  1382. zero_chandrupatla, a Fortran77 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Chandrupatla method, which can converge faster than bisection, regula falsi, or Brent's method, by Tirupathi Chandrapatla.
  1383. zero_chandrupatla_test
  1384. zero_itp, a Fortran77 code which finds a zero of a scalar function of a scalar variable, starting from a change of sign interval, using the Interpolate/Truncate/Project (ITP) method, which has faster convergence than the bisection method.
  1385. zero_itp_test
  1386. zero_laguerre, a Fortran77 code which uses Laguerre's method to find the zero of a function. The method needs first and second derivative information. The method almost always works when the function is a polynomial.
  1387. zero_laguerre_test
  1388. zero_muller, a Fortran77 code which seeks a root of a nonlinear equation using the Muller method, with complex arithmetic.
  1389. zero_muller_test
  1390. zero_rc, a Fortran77 code which seeks solutions of a scalar nonlinear equation f(x)=0, using reverse communication.
  1391. zero_rc_test
  1392. ziggurat, a Fortran77 code which works as a random number generator (RNG) for the uniform, normal or exponential distributions, using the ziggurat method.
  1393. ziggurat_test
  1394. ziggurat_openmp, a Fortran77 code which demonstrates the ziggurat() a random number generator (RNG) used in an OpenMP parallel program.
  1395. ziggurat_openmp_test


Last revised on 27 March 2024.