爱气象,爱气象家园! 

气象家园

 找回密码
 立即注册

QQ登录

只需一步,快速开始

新浪微博登陆

只需一步, 快速开始

搜索
查看: 45181|回复: 62

[源代码] 介绍弗罗里达州立大学John Burkardt先生搜集的大量FORTRAN77程序

  [复制链接]

新浪微博达人勋

发表于 2014-1-22 17:51:50 | 显示全部楼层 |阅读模式

登录后查看更多精彩内容~

您需要 登录 才可以下载或查看,没有帐号?立即注册 新浪微博登陆

x
本帖最后由 hillside 于 2014-1-22 18:37 编辑

      本帖只是介绍,我未运行过其中的程序。有兴趣的网友可自行淘金。 粗看之下,其中包含在气象领域已有应用的SVD程序等。
        https://www.sc.fsu.edu/people?uid=jburkardt
John Burkard         Research Associate
Contact Info:Email:  jburkardt@fsu.edu
Postal Address:Burkardt, John
Dept. of Scientific Computing
The Florida State University
400 Dirac Science Library
Tallahassee, FL 32306-4120

未命名.JPG
      该网站提供了多种语言的多种程序或软件。里面程序众多,现摘录FORTRAN77程序如下(原目录很长,超过气象家园发帖长度限制,有删简。有兴趣了解详情者,可点击原链接进入):
                                     http://people.sc.fsu.edu/~jburkardt/f77_src/f77_src.html

                                                                        FORTRAN77 Source Codes

  • analemma, a program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, creating data files that can be plotted with gnuplot, based on a C program by Brian Tung.
  • anyplt, a library which was intended as a simple interface to a variety of graphics packages.
  • args, a program which reports the command line arguments of a FORTRAN77 program;
  • asa005, a library which evaluates the lower tail of the noncentral Student's T distribution; this is Applied Statistics Algorithm 5;
  • asa006, a library which computes the Cholesky factor of a positive definite symmetric matrix; this is Applied Statistics Algorithm 6;
  • asa007, a library which computes the inverse of a positive definite symmetric matrix; this is Applied Statistics Algorithm 7;
  • asa032, a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 32;
  • asa047, a library which minimizes a scalar function of several variables using the Nelder-Mead algorithm; this is Applied Statistics Algorithm 47;
  • asa058, a library which carries out clustering of data; this is Applied Statistics Algorithm 58;
  • asa063, a library which evaluates the incomplete Beta function; this is Applied Statistics Algorithm 63;
  • asa066, a library which computes the cumulative density function (CDF) of the standard normal distribution; this is Applied Statistics Algorithm 66;
  • asa076, a library which evaluates Owen's T function; this is Applied Statistics Algorithm 76;
  • asa091, a library which computes the percentage points of the Chi-square distribution; this is Applied Statistics Algorithm 91;
  • asa103, a library which evaluates the digamma or psi function; this is Applied Statistics Algorithm 103;
  • asa109, a library which inverts the incomplete Beta function; this is Applied Statistics Algorithm 109;
  • asa111, a library which evaluates the percentage points of the normal distribution; this is Applied Statistics Algorithm 111;
  • asa113, a library which clusters data using the Banfield and Bassill transfer and swap algorithm; this is Applied Statistics Algorithm 113;
  • asa121, a library which evaluates the trigamma function; this is Applied Statistics Algorithm 121;
  • asa136, a library which clusters data using the Hartigan and Wong K-means algorithm; this is Applied Statistics Algorithm 136;
  • asa144, a library which randomly generates tables with given row and column sums; this is Applied Statistics Algorithm 144;
  • asa147, a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 147;
  • asa152, a library which evaluates point and cumulative probabilities associated with the hypergeometric distribution; this is Applied Statistics Algorithm 152;
  • asa159, a library which generates a table with given row and column sums; this is Applied Statistics Algorithm 159;
  • asa172, a library which simulates the generation of a set of multi-indices by nested DO-Loops; this is Applied Statistics Algorithm 172;
  • asa183, a library which implements the Wichman-Hill random number generator (RNG); this is Applied Statistics Algorithm 183;
  • asa189, a library which estimates the parameters of a beta binomial distribution based on a sample of values generated by the distribution, by D Smith; this is Applied Statistics Algorithm 189;
  • asa205, a library which generates tables with given row and column sums; this is Applied Statistics Algorithm 205;
  • asa226, a library which evaluates the noncentral incomplete Beta function; this is Applied Statistics Algorithm 226;
  • asa239, a library which evaluates the incomplete Gamma function; this is Applied Statistics Algorithm 239;
  • asa241, a library which computes the inverse of the normal cumulative density function (CDF); this is Applied Statistics Algorithm 241;
  • asa243, a library which evaluates the lower tail of the noncentral Student's T distribution; this is Applied Statistics Algorithm 243;
  • asa245, a library which evaluates the logarithm of the Gamma function; this is Applied Statistics Algorithm 245;
  • asa266, a library which evaluates various properties of the Dirichlet probability density function (PDF); this is Applied Statistics Algorithm 266;
  • asa299, a library which computes the lattice points (integer coordinates) in an M-dimensional simplex; this is Applied Statistics Algorithm 299;
  • asa310, a library which evaluates the noncentral incomplete Beta function; this is Applied Statistics Algorithm 310;
  • asa314, a library which computes the inverse of a matrix whose elements are subject to modulo arithmetic, by Roger Payne. This is a FORTRAN77 version of Applied Statistics Algorithm 314.
  • backtrack_binary_rc, a library which carries out a backtrack search for a set of binary decisions, using reverse communication.
  • barycentric_interp_1d, a library which defines and evaluates the barycentric Lagrange polynomial p(x) which interpolates a set of data, so that p(x(i)) = y(i). The barycentric approach means that very high degree polynomials can safely be used.
  • bdmlib, a library which estimates the weights in a Dirichlet mixtured based on sample data;
  • bernstein_polynomial, a library which evaluates the Bernstein polynomials;
  • blas1_d, a library 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.
  • blas1_s, a library 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.
  • blas1_z, a library 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.
  • blas2_c, a library which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using single precision complex arithmetic.
  • blas2_d, a library which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using double precision real arithmetic.
  • blas2_s, a library which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using single precision real arithmetic.
  • blas2_z, a library which constitutes the Level 2 Basic Linear Algebra Subprograms (BLAS), for matrix-vector operations using double precision complex arithmetic.
  • blas3_c, a library which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using single precision complex arithmetic.
  • blas3_d, a library which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using double precision real arithmetic.
  • blas3_s, a library which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using single precision real arithmetic.
  • blas3_z, a library which constitutes the Level 3 Basic Linear Algebra Subprograms (BLAS), for matrix-matrix operations using double precision complex arithmetic.
  • blend, a library which carries out 1D/2D/3D blending interpolation;
  • box_behnken, a library which computes a Box-Behnken design, that is, a set of arguments to sample the behavior of a function of multiple parameters;
  • brent, a library which contains routines for finding zeroes or minima of a scalar function of a scalar variable, without the use of derivative information, by Richard Brent.
  • brownian_motion_simulation, a library which simulates Brownian motion in an M-dimensional region, creating graphics files for processing by gnuplot.
  • bt_serial, a program which is a serial version of the NAS Block Tridiagonal (BT) Parallel Benchmark.
  • burgers_solution, a library which evaluates an exact solution of the time-dependent 1D viscous Burgers equation.
  • bvpsol, a library which solves a highly nonlinear two point boundary value problem (BVP) using a local linear solver (condensing algorithm) or a global sparse linear solver for the solution of the arising linear subproblems, by Peter Deuflhard, Georg Bader, Lutz Weimann.
  • c4lib, a library which implements certain elementary functions for single precision complex variables;
  • c8lib, a library which implements certain elementary functions for double precision complex variables;
  • cell, a library which defines a cell array, a generalization of an array which can compactly store and retrieve vector or matrix data of varying size, such as the rows of a triangular matrix.
  • cellular_automaton, a program which demonstrates the 1D Cellular Automaton known as rule #30.
  • cg_plus, a library which implements the conjugate gradient method for the minimization of a scalar functional;
  • cg_rc, a library which implements the conjugate gradient method for solving a positive definite sparse linear system A*x=b, using reverse communication.
  • cg_serial, a program which is a serial version of the NAS Conjugate Gradient (CG) Parallel Benchmark.
  • channel, a program which uses the finite element method (FEM) to model the time independent viscous incompressible flow in a 2D channel;
  • chebyshev, a library which computes the Chebyshev interpolant/approximant to a given function over an interval.
  • chebyshev_interp_1d, a library which determines the combination of Chebyshev polynomials which interpolates a set of data, so that p(x(i)) = y(i).
  • chebyshev_polynomial, a library which considers the Chebyshev polynomials T(i,x), U(i,x), V(i,x) and W(i,x). Functions are provided to evaluate the polynomials, determine their zeros, produce their polynomial coefficients, produce related quadrature rules, project other functions onto these polynomial bases, and integrate double and triple products of the polynomials.
  • chrpak, a library which can be used to analyze and manipulate character strings;
  • circle_arc_grid, a program which computes grid points along a circular arc.
  • circle_integrals, a library which returns the exact value of the integral of any monomial over the circumference of the unit circle in 2D.
  • circle_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function along the circumference of the unit circle in 2D;
  • circle_segment, a library which carries out computations associated with a circle segment, including height, angle, area, centroid, sampling, and quadrature, creating some graphics images using gnuplot.
  • clean77, a program which can reformat a FORTRAN77 file, using some standard indenting and numbering conventions.
  • clebsch_gordan, a library which evaluates Clebsch-Gordan coefficients involved in angular momentum coupling in quantum mechanics;
  • clenshaw_curtis_rule, a program which implements a Clenshaw Curtis quadrature rule;
  • cnf_io, a library which reads or writes CNF data files, used to store boolean formulas in conjunctive normal form.
  • colnew, a library which solves a system of boundary value problems (BVP's), a mixed-order system of ordinary differential equations (ODE's) subject to separated, multipoint boundary conditions, using collocation at Gaussian points, by Uri Ascher and Georg Bader.
  • colored_noise, a library which generates samples of noise obeying a 1/f^alpha power law.
  • combination_lock, a program which simulates the process of determining the secret combination of a lock.
  • combo, a library which includes routines for ranking, unranking, enumerating and randomly selecting balanced sequences, cycles, graphs, Gray codes, subsets, partitions, permutations, restricted growth functions, Pruefer codes and trees.
  • communicator_mpi, a program which creates new communicators involving a subset of initial set of MPI processes in the default communicator MPI_COMM_WORLD.
  • compass_search, a library which seeks the minimizer of a scalar function of several variables using compass search, a direct search algorithm that does not use derivatives.
  • complex_numbers, a program which demonstrates some simple features involved in the use of complex numbers in FORTRAN77 programming.
  • condition, a library which implements methods of computing or estimating the condition number of a matrix.
  • cordic, a library which computes a few special functions using the CORDIC algorithm.
  • correlation, a library which contains examples of statistical correlation functions.
  • cube_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit cube in 3D.
  • cube_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit cube in 3D.
  • cwg_ode, a library which contains three ODE solvers by William Gear.
  • cycle_brent, a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Brent's method.
  • cycle_floyd, a library which carries out an iterated function evaluation, and seeks to determine the nearest element of a cycle, and the cycle's length, using Floyd's method.
  • cyclic_reduction, a library which solves a tridiagonal linear system using cyclic reduction;
  • dbem, a program which uses the direct boundary element method (BEM) to analyze a problem in 2D elastic stress, by Prasanta Banerjee, Roy Butterfield.
  • diaphony, a program which reads a file of N points in M dimensions and computes its diaphony, a measure of point dispersion.
  • differ, determines the finite difference coefficients necessary in order to combine function values at known locations to compute an approximation of given accuracy to a derivative of a given order.
  • dijkstra, a program which runs a simple example of Dijkstra's minimum distance algorithm for graphs.
  • dijkstra_openmp, a program which uses OpenMP to parallelize a simple example of Dijkstra's minimum distance algorithm for graphs.
  • discrete_pdf_sample_2d, a program 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.
  • disk_grid, a library 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.
  • disk_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit disk in 2D.
  • disk_monte_carlo, a library which applies a Monte Carlo method to estimate integrals of a function over the interior of the unit disk in 2D;
  • dislin, examples which illustrate the use of a scientific plotting package;
  • divdif, a library which interpolates data using divided difference tables;
  • doomsday, a library which is given the year, month and day of a date, and uses John Conway's doomsday algorithm to determine the corresponding day of the week.
  • dqed, a library which solves bounded and constrained least squares problems and systems of nonlinear equations;
  • driv, a library which solves real or complex systems of ordinary differential equations (ODE's);
  • duel_simulation, a program which simulates N repetitions of a duel between two players, each of whom has a known firing accuracy.
  • eispack, a library which carries out eigenvalue computations; superseded by LAPACK;
  • ellipse_grid, a library which computes grid points inside an ellipse.
  • ellipsoid_grid, a library which computes grid points inside a 3D ellipsoid.
  • ep_serial, a program which is a serial version of the NAS Embarassingly Parallel (EP) Parallel Benchmark.
  • expokit, a library which solves various forms of the matrix exponential problem, by Roger Sidje.
  • f77, examples which illustrate features of FORTRAN77;
  • f77_calls_c, a directory of FORTRAN77 examples which illustrate how a FORTRAN77 program can call a C function.
  • f77_calls_c++, a directory of FORTRAN77 examples which illustrate how a FORTRAN77 program can call a C++ function.
  • f77_calls_matlab, programs which illustrate how a FORTRAN77 program can interact with MATLAB;
  • f77_class, a directory of FORTRAN77 examples which were used to illustrate a programming class.
  • f77_condor, programs which illustrate how a FORTRAN77 program can be run in batch mode using the condor queueing system.
  • f77_intrinsics, examples which illustrate the use of some of the intrinsic functions included with the F77 standard language;
  • f77_return, programs which illustrates how a FORTRAN77 program can return a program status value to the calling environment.
  • fair_dice_simulation, a program which simulates N tosses of 2 dice, writing graphics files for processing by gnuplot.
  • fd_predator_prey, a program which solves a pair of predator prey ordinary differential equations (ODE's) using a finite difference approximation.
  • fd1d_advection_ftcs, a program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the FTCS method, forward time difference, centered space difference, writing graphics files for processing by gnuplot.
  • fd1d_advection_lax, a program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax method to approximate the time derivative, writing graphics files for processing by gnuplot.
  • fd1d_advection_lax_wendroff, a program which applies the finite difference method (FDM) to solve the time-dependent advection equation ut = - c * ux in one spatial dimension, with a constant velocity, using the Lax-Wendroff method to approximate the time derivative, writing graphics files for processing by gnuplot.
  • fd1d_burgers_lax, a program 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.
  • fd1d_burgers_leap, a program which applies the finite difference method (FDM) and the leapfrog approach to solve the non-viscous time-dependent Burgers equation in one spatial dimension.
  • fd1d_bvp, a program which applies the finite difference method (FDM) to a two point boundary value problem (BVP) in one spatial dimension.
  • fd1d_heat_explicit, a program which implements a finite difference method (FDM), explicit in time, of the time dependent 1D heat equation;
  • fd1d_heat_implicit, a program which implements a finite difference method (FDM), implicit in time, of the time dependent 1D heat equation;
  • fd1d_heat_steady, a program which implements a finite difference method (FDM) for the steady (time independent) 1D heat equation;
  • fd1d_predator_prey, a program which implements a finite difference method (FDM) for a 1D predator-prey system;
  • fd1d_wave, a program which applies the finite difference method (FDM) to solve the time-dependent wave equation utt = c * uxx in one spatial dimension.
  • fd2d_heat_steady, a program which implements a finite difference method (FDM) for the steady (time independent) 2D heat equation;
  • fem_basis, a library which can define and evaluate 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.)
  • fem1d, a program which applies the finite element method (FEM), with piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  • fem1d_adaptive, a program which uses an adaptive mesh when applying the finite element method (FEM), with piecewise linear basis functions, to a linear two point boundary value problem (BVP) in 1D;
  • fem1d_bvp_linear, a program which applies the finite element method (FEM), with piecewise linear elements, to a two point boundary value problem (BVP) in one spatial dimension.
  • fem1d_heat_steady, a program which implements the finite element method (FEM) for the steady (time independent) 1D heat equation;
  • fem1d_nonlinear, a program which applies the finite element method (FEM), with piecewise linear basis functions, to a nonlinear two point boundary value problem (BVP) in 1D;
  • fem1d_pack, a library which contains utilities for 1D finite element method (FEM) calculations.
  • fem1d_pmethod, a program which applies the p-method version of the finite element method (FEM) to a linear two point boundary value problem (BVP) in 1D;
  • fem1d_project, a program which projects data into a finite element space, including the least squares approximation of data, or the projection of a finite element solution from one mesh to another.
  • fem1d_sample, a program 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.
  • fem2d_pack, a library which implements simple 2D calculations for the finite element method (FEM);
  • fem2d_poisson_rectangle, a program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise quadratic triangular elements.
  • fem2d_poisson_rectangle_linear, a program which solves the 2D Poisson equation on a rectangle, using the finite element method (FEM), and piecewise linear triangular elements.
  • fem2d_sample, a program which samples a finite element function, defined by FEM files, (three text files describing the nodes, triangles, and coefficients); at arbitrary points.
  • feynman_kac_1d, a program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 1D interval by averaging stochastic paths to the boundary.
  • feynman_kac_2d, a program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 2D ellipse by averaging stochastic paths to the boundary.
  • feynman_kac_3d, a program which demonstrates the use of the Feynman-Kac algorithm to solve Poisson's equation in a 3D ellipsoid by averaging stochastic paths to the boundary.
  • fft_openmp, a program which demonstrates the computation of a Fast Fourier Transform (FFT) in parallel, using OpenMP.
  • fft_serial, a program which computes a Fast Fourier Transform (FFT), and is intended as a starting point for implementing an OpenMP parallel version.
  • fftpack5, a library which contains version 5 of the FFTPACK Fast Fourier Transform (FFT) package by Paul Swarztrauber and Dick Valent;
  • fftpack5.1, a library which contains version 5.1 of the FFTPACK Fast Fourier Transform (FFT) package by Paul Swarztrauber and Dick Valent;
  • fftw3, examples which illustrate the use of the FFTW3 Fast Fourier Transform (FFT) package, by Matteo Frigo and Steven Johnson.
  • file_name_sequence, a program which demonstrates ways to generate a sequence of filenames, which can be useful when generating a sequence of still snapshots to be animated later.
  • files_multiple, a program which demonstrates how a program can open multiple output files at one time, and write data to any one specific file it chooses.
  • filum, a library which performs various operations on files;
  • fire_serial, a program which simulates a forest fire over a rectangular array of trees, starting at a single random location. It is intended as a starting point for the development of a parallel version.
  • fishpack, a library which solves the Poisson, Laplace, or Helmholtz equation in 2D or 3D on a variety of geometries, by Paul Swarztrauber and Roland Sweet.
  • floyd, a library which implements Floyd's algorithm for finding the shortest distance between pairs of nodes on a directed graph.
  • fn, a library which evaluates elementary and special functions, by Wayne Fullerton.
  • g77_intrinsics, examples which illustrate the use of some of the "extra" intrinsic functions included with the Gnu G77 compiler for FORTRAN77;
  • geometry, a library which carries out a number of 2D/3D geometric calculations;
  • gfortran, examples which investigate the use of the Gnu GFORTRAN compiler for FORTRAN77.
  • gfortran_intrinsics, a program 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.
  • gfortran_quadmath, a program which illustrates the use of quadruple precision real arithmetic, as provided on some systems by the Gnu GFORTRAN compiler for FORTRAN77.
  • gm_rule, a library which defines Grundmann-Moeller quadrature rules for an M-dimensional simplex.
  • gnufor, a library which provides an interface between a program and the gnuplot graphics library.
  • gnuplot, programs which illustrate how a program can write data and command files so that gnuplot can create plots of the program results.
  • gprof, examples which illustrate the use of the GPROF program performance monitor;
  • graphics_examples, programs which illustrate how various kinds of data can be displayed and analyzed graphically.
  • haar, a library which computes the Haar transform of data.
  • hb_to_st, a program which reads a sparse matrix in a Harwell-Boeing (HB) file and writes an equivalent Sparse Triplet (ST) file.
  • hcell, a program which solves the time-dependent 2D incompressible Navier Stokes equations in an H-shaped region.
  • hcell_steady, a program which solves the time-independent or "steady" 2D incompressible Navier Stokes equations in an H-shaped region, by Hyung-Chun Lee.
  • heat_mpi, a program which solves the 1D time dependent heat equation using MPI.
  • heated_plate, a program 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.
  • heated_plate_openmp, a program which solves the steady (time independent) heat equation in a 2D rectangular region, using OpenMP to run in parallel.
  • hello, a program which prints out "Hello, world!".
  • hello_mpi, a program which prints out "Hello, world!" using MPI for parallel programming.
  • hello_openmp, a program which prints out "Hello, world!" within the OpenMP parallel programming environment.
  • hermite, a library which computes the Hermite interpolant, a polynomial that matches function values and derivatives.
  • hermite_cubic, a library which can compute the value, derivatives or integral of a Hermite cubic polynomial, or manipulate an interpolating function made up of piecewise Hermite cubic polynomials.
  • hermite_polynomial, a library which evaluates the physicist's Hermite polynomial, the probabilist's Hermite polynomial, the Hermite function, and related functions.
  • hyperball_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit hyperball in M dimensions.
  • hyperball_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit ball in M dimensions;
  • hyperball_volume_monte_carlo, a program which applies a Monte Carlo procedure to estimate the volume of the unit ball in M dimensions;
  • hypercube_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit hypercube in M dimensions.
  • hypercube_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit hypercube in M dimensions.
  • hypersphere, a library which carries out various operations for an M dimensional hypersphere, including converting between Cartesian and spherical coordinates, stereographic projection, sampling the surface of the sphere, and computing the surface area and volume.
  • hypersphere_integrals, a library which returns the exact value of the integral of any monomial over the surface of the unit hypersphere in M dimensions.
  • hypersphere_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in M dimensions;
  • i4lib, a library which contains many utility routines, using "I4" or "single precision integer" arithmetic.
  • i8lib, a library which contains many utility routines, using "I8" or "double precision integer" arithmetic.
  • ice_io, a library which reads or writes ICE grid files stored in NETCDF format.
  • ice_to_mesh, a program which reads a NETCDF file containing an ICE dataset and rewrites the information as a MESH file.
  • image_components, a library which seeks the connected nonzero or nonblack components of an image or integer array.
  • image_denoise, a library which applies simple filtering operations to a noisy image.
  • image_edge, a library which demonstrates a simple procedure for edge detection in images.
  • index, a library which converts a multidimensional vector index to a one-dimensional vector index; it can handle zero and one based indexing schemes, as well as column major and row major conventions.
  • inout, a program which solves the time-dependent 2D incompressible Navier Stokes equations in a rectangular region with inflow and outflow, by Hyung-Chun Lee.
  • ising_2d_simulation, a program 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.
  • jacobi, a library which implements the Jacobi iteration for the iterative solution of linear systems.
  • jacobi_eigenvalue, a library which implements the Jacobi iteration for the iterative determination of the eigenvalues and eigenvectors of a real symmetric matrix.
  • jacobi_polynomial, a library which evaluates the Jacobi polynomial and associated functions.
  • kmedian, a program which solves the K-Median problem, by G Cornuejols, M L Fisher, G L Nemhauser.
  • knapsack, a library which solves a variety of knapsack problems, by Silvano Martelo and Paolo Toth.
  • kronrod, a library which can compute a Gauss and Gauss-Kronrod pair of quadrature rules of arbitrary order, by Robert Piessens, Maria Branders.
  • lagrange_approx_1d, a library which defines and evaluates the Lagrange polynomial p(x) of degree m which approximates a set of nd data points (x(i),y(i)).
  • lagrange_interp_1d, a library 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).
  • lagrange_interp_2d, a library which defines and evaluates the Lagrange polynomial p(x,y) which interpolates a set of data depending on a 2D argument that was evaluated on a product grid, so that p(x(i),y(j)) = z(i,j).
  • lagrange_interp_nd, a library 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).
  • laguerre_polynomial, a library which evaluates the Laguerre polynomial, the generalized Laguerre polynomials, and the Laguerre function.
  • lamp, a library which solves linear assignment and matching problems, by Rainer Burkard, Ulrich Derigs.
  • lapack_examples, a program which demonstrates the use of the LAPACK linear algebra library.
  • lapack_examples_osx, a program which demonstrates the use of the precompiled LAPACK linear algebra library available on Macintosh OSX systems, using the "-framework veclib" compiler option.
  • laplacian, a library which carries out computations related to the discrete Laplacian operator, including full or sparse evaluation, evaluation for unequally spaced data sampling points, application to a set of data samples, solution of associated linear systems, eigenvalues and eigenvectors, and extension to 2D and 3D geometry.
  • latin_cover, a library which produces N Latin squares which cover an NxN square, or NxN Latin cubes which cover an NxNxN cube.
  • latinize, a library which adjusts N points in M dimensions to form a Latin hypercube.
  • lawson, a library which contains routines for solving least squares problems and the singular value decomposition (SVD), by Lawson and Hanson.
  • legendre_polynomial, a library which evaluates the Legendre polynomial and associated functions.
  • legendre_rule, a program which writes out a Gauss-Legendre quadrature rule of given order.
  • legendre_rule_fast, a program which uses a fast (order N) algorithm to compute a Gauss-Legendre quadrature rule of given order.
  • life_serial, a program which computes a few steps of the evolution of John Conway's Game of Life, intended as a starting point for implementing a parallel version.
  • line_integrals, a library which returns the exact value of the integral of any monomial over the length of the unit line in 1D.
  • line_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function over the length of the unit line in 1D.
  • linpack, a library which solves linear systems for a variety of matrix storage schemes, real or complex arithmetic, and single or double precision. It includes a routine for computing the singular value decomposition (SVD) of a rectangular matrix. The original version of this library is by Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart.
  • linpack_bench, a program which carries out the LINPACK benchmark;
  • linpack_c, a library 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.
  • linpack_d, a library 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.
  • linpack_s, a library 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.
  • linpack_z, a library 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.
  • linplus, a library 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.
  • llsq, a library 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.
  • lorenz_ode, a program which approximates solutions to the Lorenz system, creating output files that can be displayed by Gnuplot.
  • machar, a library which computes the values of various machine characteristic constants;
  • machine, a library which returns tabulated values of machine constants;
  • makefiles, examples which illustrate the use of MAKEFILES for maintaining a software project;
  • mandelbrot, a program which generates an ASCII PPM image of the Mandelbrot set;
  • mandelbrot_openmp, a program which generates an ASCII Portable Pixel Map (PPM) image of the Mandelbrot fractal set, using OpenMP for parallel execution;
  • matman, a program which manipulates matrices;
  • matmul, a program which carries out a matrix multiplication benchmark;
  • matrix_exponential, a library which demonstrates some simple approaches to the problem of computing the exponential of a matrix.
  • md, a program which carries out a molecular dynamics simulation, and is intended as a starting point for implementing an OpenMP parallel version.
  • md_openmp, a program which carries out a molecular dynamics simulation in parallel using OpenMP.
  • mdbnch, a program which is a molecular dynamics benchmark;
  • mesh_bandwidth, a program which returns the geometric bandwidth associated with a mesh of elements of any order and in a space of M dimensions.
  • mesh_io, a library which can read or write MESH files, which can be used to define the geometry of a finite element mesh in 2D or 3D, using triangles, quadrilaterals, tetrahedrons or hexahedrons.
  • mesh_to_ice, a program which reads the ICE dataset information from a MESH files and rewrites it to a NETCDF file.
  • mg_serial, a program which a serial version of the NAS MultiGrid (MG) Parallel Benchmark.
  • mgmres, a library which applies the restarted GMRES algorithm to a sparse linear system, by Lili Ju;
  • mgs, a library which is an example of "legacy code", which the student is encouraged to study, understand, and document. This example is due to Diane O'Leary.
  • minpack, a library which solves linear and nonlinear least squares problems.
  • mixed, examples which illustrate the use of mixed language programming in which the main program is written in FORTRAN77;
  • monomial, a library which enumerates, lists, ranks, unranks and randomizes multivariate monomials in a space of M dimensions, with total degree less than N, equal to N, or lying within a given range.
  • monte_carlo_rule, a program 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.
  • mpi, examples which illustrate the use of the MPI library for the parallel execution of programs;
  • mpi_stubs, a library which may be used if a parallel program is to be compiled, loaded and run in a serial machine.
  • multigrid_poisson_1d, a library which applies the multigrid method to a discretized version of the 1D Poisson equation.
  • multitask_mpi, a program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using MPI for parallel execution.
  • multitask_openmp, a program which demonstrates how to multitask, that is, to execute several unrelated and distinct tasks simultaneously, using OpenMP for parallel execution.
  • mus, a library which implements the multiple shooting method for two point boundary value problems (BVP's), for linear or nonlinear cases, by Robert Mattheij and G Staarink.
  • mxm, a program which sets up a matrix multiplication problem A=B*C of arbitrary size, and compares the time required for IJK, IKJ, JIK, JKI, KIJ and KJI orderings of the loops.
  • mxm_openmp, a program which computes a dense matrix product C=A*B, using OpenMP for parallel execution.
  • mxm_serial, a program which sets up a matrix multiplication problem A=B*C, intended as a starting point for implementing a parallel version.
  • mxv, a program which compares the performance of (DO I, DO J) loops and (DO J, DO I ) loops for computing the product of an MxN matrix A and an N vector X.
  • mxv_openmp, a program which measures the performance of the matrix multiplication problem y=A*x, with and without parallelization by OpenMP.
  • napack, a library which includes many routines for applied numerical linear algebra, by William Hager.
  • nas, a program which runs the NASA kernel benchmark.
  • nearest_interp_1d, a library which interpolates a set of data using a piecewise constant interpolant defined by the nearest neighbor criterion, creating graphics files for processing by gnuplot.
  • netcdf, a directory of example programs which read and write NETCDF files.
  • netode, a program which models the time-dependent behavior of a two-phase fluid in an abstract network of nodes and links.
  • newton_rc, a program which demonstrates the use of Newton's method to solve a system of nonlinear equations, using reverse communication.
  • nintlib, a library which applies approximate integration (quadrature) in M dimensions;
  • nl2sol, a library which implements an adaptive nonlinear least squares algorithm, by John Dennis, David Gay, Roy Welsch.
  • nms, a library 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's), optimization and nonlinear least squares, simulation and random numbers, trigonometric approximation and Fast Fourier Transforms (FFT).
  • normal, a library which generates normally distributed pseudorandom numbers.
  • nspcg, a library which carries out the iterative solution of large nonsymmetric systems of linear equations. The package includes a variety of matrix storage formats, preconditioners, and solvers.
  • ode, a library which handles ordinary differential equations (ODE's), by Shampine and Gordon;
  • odepack, a library which contains nine ODE solvers, including LSODE, LSODES, LSODA, LSODAR, LSODPK, LSODKR, LSODI, LSOIBT, and LSODIS, by Alan Hindmarsh.
  • openmp, examples which illustrate the use of the use of the OpenMP interface for parallel processing on shared memory systems;
  • openmp_stubs, a library which is a dummy implementation of the OpenMP routines, and can be used to compile, load, and run a program using OpenMP on a system which does not have OpenMP installed.
  • optimize, a program which looks at the use of automatic optimization by the compiler to make the executable code run faster.
  • ornstein_uhlenbeck, a library 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.
  • owens, a library which evaluates Owen's T function;
  • paranoia, a program which checks the accuracy of floating point arithmetic on a given computer.
  • partition_problem, a library which seeks solutions of the partition problem, splitting a set of integers into two subsets with equal sum.
  • pbma_io, a library which reads or writes ASCII PBM 2D bit map graphics files;
  • pce_burgers, a program which defines and solves a version of the time-dependent viscous Burgers equation, with uncertain viscosity, using a polynomial chaos expansion in terms of Hermite polynomials, by Gianluca Iaccarino.
  • pce_ode_hermite, a program which sets up a simple scalar ordinary differential equation (ODE) for exponential decay with an uncertain decay rate, using a polynomial chaos expansion in terms of Hermite polynomials.
  • pdflib, a library which evaluates Probability Density Functions (PDF's) and produces random samples from them, including beta, binomial, chi, exponential, gamma, inverse chi, inverse gamma, multinomial, normal, scaled inverse chi, and uniform.
  • pgma_io, a library which reads or writes ASCII PGM 2D grayscale graphics files;
  • piecewise_linear_product_integral, a library which calculates the exact value of the integral of the product of two piecewise linear functions F(X) and G(X).
  • pink_noise, a library which computes a pink noise signal obeying a 1/f power law.
  • pitcon66, a library which seeks to produce a sequence of points that satisfy a set of nonlinear equations with one degree of freedom; this is version 6.6 of ACM TOMS algorithm 596.
  • pltmg, a library which carries out Piecewise Linear Triangle MultiGrid (PLTMG) calculations using the finite element method (FEM), by Randy Bank;
  • point_merge, a library which considers N points in M dimensional space, and counts or indexes the unique or "tolerably unique" items.
  • poisson_openmp, a program which computes an approximate solution to the Poisson equation in a rectangle, using the Jacobi iteration to solve the linear system, and OpenMP to carry out the Jacobi iteration in parallel.
  • poisson_serial, a program 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.
  • poisson_simulation, a library which simulates a Poisson process in which events randomly occur with an average waiting time of Lambda, creating graphics files for processing by gnuplot.
  • polpak, a library which evaluates special functions, recursive polynomials, and so on.
  • polygon_moments, a library which computes arbitrary moments of a polygon.
  • polynomial, a library which adds, multiplies, differentiates, evaluates and prints multivariate polynomials in a space of M dimensions.
  • power_method, a library which carries out the power method for finding a dominant eigenvalue and its eigenvector.
  • ppma_io, a library which reads or writes ASCII Portable Pixel Map (PPM) 2D color graphics files;
  • pppack, a library which computes piecewise polynomial interpolants and approximants, in particular, cubic splines, by Carl DeBoor.
  • praxis, a library which minimizes a scalar function of several variables, without requiring derivative information, by Richard Brent.
  • prime_mpi, a program which counts the number of primes between 1 and N, using MPI for parallel execution.
  • prime_openmp, a program which counts the number of primes between 1 and N, using OpenMP for parallel execution.
  • prime_serial, a program which counts the number of primes between 1 and N, and is intended as a starting point for a parallel version.
  • prob, a library which evaluates, samples, inverts, and characterizes a number of Probability Density Functions (PDF's) and Cumulative Density Functions (CDF's), including anglit, arcsin, benford, birthday, bernoulli, beta_binomial, beta, binomial, bradford, burr, cardiod, cauchy, chi, chi squared, circular, cosine, deranged, dipole, dirichlet mixture, discrete, empirical, english sentence and word length, error, exponential, extreme values, f, fisk, folded normal, frechet, gamma, generalized logistic, geometric, gompertz, gumbel, half normal, hypergeometric, inverse gaussian, laplace, levy, logistic, log normal, log series, log uniform, lorentz, maxwell, multinomial, nakagami, negative binomial, normal, pareto, planck, poisson, power, quasigeometric, rayleigh, reciprocal, runs, sech, semicircular, student t, triangle, uniform, von mises, weibull, zipf.
  • pwl_approx_1d, a library which approximates a set of data using a piecewise linear function.
  • pwl_interp_1d, a library which interpolates a set of data using a piecewise linear function.
  • pwl_interp_2d, a library which evaluates a piecewise linear interpolant to data defined on a regular 2D grid.
  • pwl_interp_2d_scattered, a library which evaluates a piecewise linear interpolant to data which is available at an irregularly arranged set of points.
  • qr_solve, a library which computes the least squares solution of a linear system A*x=b.
  • quad_mpi, a program which applies a quadrature rule to estimate an integral, using MPI;
  • quad_openmp, a program which applies a quadrature rule to estimate an integral over a 1D interval, using OpenMP for parallel execution;
  • quad_serial, a program which applies a quadrature rule to estimate an integral, intended as a starting point for parallelization exercises.
  • quad2d_openmp, a program which applies a product quadrature rule to estimate an integral over a 2D rectangle, using OpenMP for parallel execution;
  • quad2d_serial, a program which applies a product quadrature rule to estimate an integral over a 2D rectangle, intended as a starting point for parallelization exercises.
  • quadmom, a library which computes a Gaussian quadrature rule for a weight function rho(x) based on the Golub-Welsch procedure that only requires knowledge of the moments of rho(x).
  • quadpack, a library which approximates integrals of various types over finite, semi-infinite and infinite one dimensional intervals;
  • quadrule, a library which implements rules for approximate integration (quadrature) in one dimension;
  • r4lib, a library which contains many utility routines, using "R4" or "single precision real" arithmetic.
  • r8lib, a library which contains many utility routines, using "R8" or "double precision real" arithmetic.
  • randlc, a library which is a random number generator (RNG) used by the NAS Benchmark programs.
  • random_data, a library 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.
  • random_mpi, a program 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.
  • random_openmp, a program which illustrates how a parallel program using OpenMP can generate multiple distinct streams of random numbers.
  • ranlib, a library which produces random samples from a variety of probabilistic distributions, by Brown and Lovato.
  • rbf_interp_1d, a library which defines and evaluates radial basis function (RBF) interpolants to 1D data.
  • rbf_interp_2d, a library which defines and evaluates radial basis function (RBF) interpolants to 2D data.
  • rbf_interp_nd, a library which defines and evaluates radial basis function (RBF) interpolants to multidimensional data.
  • reactor simulation, a program which is a simple Monte Carlo simulation of the shielding effect of a slab of a certain thickness in front of a neutron source. This program was provided as an example with the book "Numerical Methods and Software."
  • read_align, a program which extracts data from a multiple alignment file for sequences and writes the data to a file suitable for input to DISTANCES.
  • ring_mpi, a program which uses the MPI parallel programming environment, and measures the time necessary to copy a set of data around a ring of processes.
  • rk4, a library which applies the fourth order Runge-Kutta (RK) algorithm to estimate the solution of an ordinary differential equation (ODE) at the next time step.
  • rkf45, a library which solves a system of ordinary differential equations (ODE's) by the Runge-Kutta-Fehlberg method.
  • rnglib, a library which implements a random number generator (RNG) with splitting facilities, allowing multiple independent streams to be computed, by L'Ecuyer and Cote.
  • sandia_cvt, a program which positions a given number of points in an arbitrary region, using probabilistic centroidal Voronoi tessellation (CVT) techniques to achieve good coverage and separation; developed for Sandia National Laboratories;
  • satisfy, a program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem.
  • satisfy_mpi, a program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using MPI to perform the calculation in parallel.
  • satisfy_openmp, a program which demonstrates, for a particular circuit, an exhaustive search for solutions of the circuit satisfiability problem, using OpenMP for parallel execution.
  • schedule_openmp, a program which demonstrates the default, static, and dynamic methods of "scheduling" loop iterations in OpenMP to avoid work imbalance.
  • scpack, a library which performs the numerical computation of Schwarz-Christoffel conformal mappings, by Nick Trefethen.
  • sde, a library which illustrates properties of stochastic ordinary differential equations (SODE's), and common algorithms for their analysis, including the Euler method, the Euler-Maruyama method, and the Milstein method, making graphics files for processing and display by gnuplot, by Desmond Higham;
  • search_mpi, a program which searches integers between A and B for a solution J such that F(J)=C, carried out in parallel using MPI.
  • search_serial, a program 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.
  • select, a library which carries out Nijenhuis and Wilf's generalized combinatorial selection algorithm;
  • serba, a program which applies the boundary element method (BEM) to solve the elasticity equation in a 2D region, by Federico Paris and Jose Canas.
  • set_theory, a library which demonstrates various set theoretic operations using several models of a set.
  • sftpack, a library which implements the "slow" Fourier transform, intended as a teaching tool and comparison with the fast Fourier transform (FFT).
  • sgefa_openmp, a program which compares a standard linear algebra solver against a revised version which can be run in parallel with OpenMP.
  • shepard_interp_1d, a library which defines and evaluates Shepard interpolants to 1D data, based on inverse distance weighting.
  • shepard_interp_2d, a library which defines and evaluates Shepard interpolants to 2D data, based on inverse distance weighting.
  • shepard_interp_nd, a library which defines and evaluates Shepard interpolants to multidimensional data, based on inverse distance weighting.
  • simpack, a library which estimates an integral over a region that is the union of multidimensional simplexes, by Alan Genz.
  • simplex_coordinates, a library which computes the Cartesian coordinates of the vertices of a regular simplex in M dimensions.
  • simplex_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit simplex in M dimensions.
  • simplex_monte_carlo, a library which uses the Monte Carlo method to estimate an integral over the interior of the unit simplex in M dimensions.
  • sine_transform, a library which demonstrates some simple properties of the discrete sine transform.
  • spacer, a program which reads a file containing a distance matrix and performs a principal component analysis, by Des Higgins.
  • spacer_data_convert, a program which reads a text file of distances, and reformats it for use with the spacer program, by Des Higgins.
  • sparse_grid_cc, a library which creates sparse grids based on Clenshaw-Curtis rules.
  • sparse_grid_cc_dataset, a program which creates a sparse grid dataset based on Clenshaw-Curtis rules.
  • sparse_grid_hw, a library which creates sparse grids based on Gauss-Legendre, Gauss-Hermite, Gauss-Patterson, or a nested variation of Gauss-Hermite rules, by Florian Heiss and Viktor Winschel.
  • sparse_interp_nd a library which can be used to define a sparse interpolant to a function f(x) of a M-dimensional argument.
  • sparsekit, a library which performs sparse matrix operations, by Yousef Saad;
  • sparsekit2, a library which implements operations on sparse matrices, including conversion between various formats; this is version 2 of the library, by Yousef Saad.
  • sparsepak, a library which forms an obsolete version of the Waterloo Sparse Matrix Package;
  • specfun, a library which computes special functions, including Bessel I, J, K and Y functions, and the Dawson, E1, EI, Erf, Gamma, Psi/Digamma functions, by William Cody and Laura Stoltz;
  • special_functions, a library which computes special functions, by Shanjie Zhang, Jianming Jin;
  • sphere_grid, a library which provides a number of ways of generating grids of points, or of points and lines, or of points and lines and faces, on the surface of the unit sphere in 3D.
  • sphere_integrals, a library which returns the exact value of the integral of any monomial over the surface of the unit sphere in 3D.
  • sphere_lebedev_rule, a library which computes Lebedev quadrature rules on the surface of the unit sphere in 3D
  • sphere_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function on the surface of the unit sphere in 3D.
  • sphere_quad, a library which uses triangulation to approximate an integral on the surface of the unit sphere in 3D;
  • sphere_stereograph, a library which computes the stereographic mapping between points on the surface of the unit sphere in 3D and points on the plane Z = 1; a generalized mapping is also available.
  • spiral_data, a program which computes a velocity vector field that satisfies the continuity equation, writing the data to a file that can be plotted by gnuplot.
  • spline, a library which interpolates and approximates via splines;
  • spread, a program which reads a SWISS-PROT file and identifies the tyrosine residues.
  • spring_ode, a program which shows how line printer graphics can be used to make a crude illustration of a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
  • spring_ode2, a program which shows how gnuplot graphics can be used to illustrate a solution of the ordinary differential equation (ODE) that describes the motion of a weight attached to a spring.
  • square_integrals, a library which returns the exact value of the integral of any monomial over the interior of the unit square in 2D.
  • square_monte_carlo, a library which applies a Monte Carlo method to estimate the integral of a function over the interior of the unit square in 2D.
  • starpac, a library which carries out statistical data analysis.
  • steam_nbs, a library which is based on the National Bureau of Standards (NBS) steam tables;
  • steam_nbs_interact, a program which queries the National Bureau of Standards (NBS) steam table package;
  • stochastic_diffusion, functions which implement several versions of a stochastic diffusivity coefficient.
  • stochastic_heat2d, a program 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.
  • toms178, a library which seeks the minimizer of a scalar function of several variables using the Hooke-Jeeves method; this is a FORTRAN77 version of ACM TOMS algorithm 178.
  • toms179, a library which calculates the incomplete Beta ratio; this is a FORTRAN77 version of ACM TOMS algorithm 179.
  • toms291, a library which approximates the logarithm of the Gamma function; this is a FORTRAN77 version of ACM TOMS algorithm 291.
  • toms322, a library which evaluates the normal, Student's T, F and chi-square cumulative density functions (CDF's); this is a FORTRAN77 version of ACM TOMS algorithm 322.
  • toms332, a library which evaluates Jacobi polynomials; this is a FORTRAN77 version of ACM TOMS algorithm 332.
  • toms343, a library which computes the eigenvalues and eigenvectors of a general real matrix; this is a FORTRAN77 version of ACM TOMS algorithm 343.
  • toms344, a library which calculates the Student T distribution; this is a FORTRAN77 version of ACM TOMS algorithm 344.
  • toms347, a library which sorts an integer vector; this is a FORTRAN77 version of ACM TOMS algorithm 347.
  • toms351, a library which estimates an integral using Romberg integration; this is a FORTRAN77 version of ACM TOMS algorithm 351.
  • toms352, a library which computes the characteristic values and associated solutions of Mattieu's differential equation; this is a FORTRAN77 version of ACM TOMS algorithm 352.
  • toms353, a library which estimates an integral involving a cosine or sine factor using Filon quadrature; this is a FORTRAN77 version of ACM TOMS algorithm 353.
  • toms358, a library which computes the singular value decomposition (SVD) of a complex matrix; this is a FORTRAN77 version of ACM TOMS algorithm 358.
  • ……



         现选摘一个气象领域已有应用的SVD(奇异值分解)类计算程序(原程序很长,仅摘录少许)。
     subroutine grsvd ( nu, nv, nb, m, n, w, matu, u, matv, v, b, irhs,     & ierr, rv1 )c*********************************************************************72ccc GRSVD determines the singular value decomposition of a matrix with N <= M.c

        John Burkard先生除了fortran77之外,在自己的主页上还提供了其他多种语言的各种应用程序等。                                                                 http://people.sc.fsu.edu/~jburkardt/
I have collected the following information:


Last revised on 15 October 2013.

本帖被以下淘专辑推荐:

密码修改失败请联系微信:mofangbao

新浪微博达人勋

发表于 2014-1-22 18:19:01 | 显示全部楼层
大体看了下,挺不错。
多谢分享啊~!
密码修改失败请联系微信:mofangbao

新浪微博达人勋

发表于 2014-1-23 08:34:15 | 显示全部楼层
收藏咯,谢谢哦~
密码修改失败请联系微信:mofangbao

新浪微博达人勋

0
早起挑战累计收入
发表于 2014-1-23 08:34:31 | 显示全部楼层
真不错 收下了
密码修改失败请联系微信:mofangbao

新浪微博达人勋

发表于 2014-1-23 19:51:09 | 显示全部楼层
很多程序,照片里的大师好像发现了什么好东西
密码修改失败请联系微信:mofangbao

新浪微博达人勋

发表于 2014-1-23 20:32:53 | 显示全部楼层
感谢老师分享。期待老师分享一些关于matlab方面的呵呵
密码修改失败请联系微信:mofangbao

新浪微博达人勋

发表于 2014-1-24 06:37:34 | 显示全部楼层
收藏咯,谢谢哦~
密码修改失败请联系微信:mofangbao

新浪微博达人勋

发表于 2014-1-24 11:17:16 | 显示全部楼层
好东西,必须顶!
密码修改失败请联系微信:mofangbao

新浪微博达人勋

 楼主| 发表于 2014-1-24 18:49:24 | 显示全部楼层

http://people.sc.fsu.edu/~jburkardt/m_src/m_src.html目录中有大量MATLAB程序:
                                                                                MATLAB Source Codes

  • algorithm8, a library which attempts to cluster N samples of M dimensional data X into approximately K clusters. The procedure is iterative, and uses the means and covariances of the current clusters to improve the cluster distributions on the next step.
  • algorithm8_original, a library which attempts to cluster N samples of M dimensional data X into approximately K clusters. The procedure is iterative, and uses the means and covariances of the current clusters to improve the cluster distributions on the next step. This directory contains the "original" versions of the MATLAB codes, and is intended for reference.
  • algorithm8_plot1dclusters, a library which plots the clusters produced by Algorithm 8 when it has processed 1D data.
  • algorithm8_plot2dclusters, a library which plots the clusters produced by Algorithm 8 when it has processed 2D data.
  • analemma, a program which evaluates the equation of time, a formula for the difference between the uniform 24 hour day and the actual position of the sun, based on a C program by Brian Tung.
  • area_under_curve, a function which displays the area under a curve, that is, the points (x,y) between the x axis and the curve y=f(x).
  • args, a program which shows how to count and report command line arguments;
  • arpack, a library which computes eigenvalues and eigenvectors of large sparse matrices, accessible via MATLAB's built-in eigs() command;
  • asa005, a library which evaluates the lower tail of the noncentral Student's T distribution, by BE Cooper. This is a Matlab version of Applied Statistics Algorithm 5;
  • asa006, a library which computes the Cholesky factor of a positive definite symmetric matrix, by Michael Healy; This is a Matlab version of Applied Statistics Algorithm 6;
  • asa007, a library which computes the inverse of a positive definite symmetric matrix, by Michael Healy; This is a Matlab version of Applied Statistics Algorithm 7.
  • asa032, a library which evaluates the incomplete Gamma function, by G Bhattacharjee. This is a Matlab version of Applied Statistics Algorithm 32;
  • asa047, a library which minimizes a scalar function of several variables using the Nelder-Mead algorithm, by R ONeill. This is a Matlab version of Applied Statistics Algorithm 47;
  • asa058, a library which carries out clustering of data, by David Sparks. This is a Matlab version of Applied Statistics Algorithm 58;
  • asa063, a library which evaluates the incomplete Beta function, by KL Majumder and G Bhattacharjee. This is a Matlab version of Applied Statistics Algorithm 63;
  • asa066, a library which computes the cumulative density function (CDF) of the standard normal distribution, by David Hill. This is a Matlab version of Applied Statistics Algorithm 66;
    …………


密码修改失败请联系微信:mofangbao

新浪微博达人勋

发表于 2014-1-27 15:03:34 | 显示全部楼层
看眼花了。。。如果有中文说明就更好了,先 马克!
密码修改失败请联系微信:mofangbao
您需要登录后才可以回帖 登录 | 立即注册 新浪微博登陆

本版积分规则

Copyright ©2011-2014 bbs.06climate.com All Rights Reserved.  Powered by Discuz! (京ICP-10201084)

本站信息均由会员发表,不代表气象家园立场,禁止在本站发表与国家法律相抵触言论

快速回复 返回顶部 返回列表