From:	SMTP%"netlibd@netlib1.EPM.ORNL.GOV" 14-DEC-1993 09:11:33.10
To:	EVERHART
CC:	
Subj:	

Date: Tue, 14 Dec 1993 09:09:58 -0500
From: Netlib Reply Daemon <netlibd@netlib1.EPM.ORNL.GOV>
Message-Id: <199312141409.JAA21959@netlib1.EPM.ORNL.GOV>
To: EVERHART@arisia.gce.com

To: EVERHART@arisia.gce.com
Subject: Re: SEND INDEX  1

#!/bin/sh
# Caveat receptor.  Jack Dongarra - dongarra@cs.utk.edu, 
#                   Eric Grosse   - ehg@research.att.com
# 8/12/93
#
# We are running a new version of netlib which allows
# setting of chunk size used for reply. Try: send index
# for a list of new features.
#
# There is an improved system called Xnetlib for people 
# connected to the Internet and have access via an X-interface.
# To receive a copy, send email to netlib@ornl.gov and in the 
# message type: send xnetlib.shar from xnetlib
#
# If you have trouble accessing netlib files please
# send mail to netlib_maintainers@netlib.ornl.gov
#
# Netlib files are also available via anonymous rcp (from most UNIX boxes).
# For more information, finger anon@netlib2.cs.utk.edu.
#
# In addition, anonymous ftp can be used to retrieve netlib files.
# Ftp to netlib2.cs.utk.edu and log in as anonymous.  Use your 
# complete e-mail address as the password.
#
# For a request returned in multiple mail messages, remove the
# mail header and "sh" resulting files in any order.
# to unpack, sh this message
PATH=/bin:/usr/bin
cat > readme <<'CUT HERE............'

 ===== How to use netlib =====

 This file is the reply you'll get to:
 	mail netlib@ornl.gov
 	send index
 Here are examples of the various kinds of requests.
 *  get the full index for a library
 	send index from eispack
 *  get a particular routine and all it depends on
 	send dgeco from linpack
 *  get just the one routine, not subsidiaries
 	send only dgeco from linpack
 *  get dependency tree, but excluding a subtree
 	send dgeco but not dgefa from linpack
 *  just tell how large a reply would be, don't actually send the file
 	send list of dgeco from linpack
 *  get a list of sizes and times of all files in a library
 	send directory for benchmark
 *  search for somebody in the SIAM membership list:
 	who is gene golub
 *  keyword search for netlib software
 	find cubic spline
 *  bibliographic search
 	find schumaker from approximation
 	find aasen from linalg
 *  set the chunk size used for reply
 	mailsize 100k
 *  (optional) end of request
 	quit

 The Internet address "netlib@ornl.gov" refers to a gateway
 machine, at Oak Ridge National Laboratory in Oak Ridge, Tennessee.
 This address should be understood on all the major networks.  

 For access from Europe, try the duplicate collection in Oslo:
 	Internet:       netlib@nac.no
 	EARN/BITNET:    netlib%nac.no@norunix.bitnet
 	X.400:          s=netlib; o=nac; c=no;
 	EUNET/uucp:     nac!netlib
 For the Pacific, try    netlib@draci.cs.uow.edu.au
 located at the University of Wollongong, NSW, Australia.
The former netlib/matlab directory is now maintained at
	  matlib@mathworks.com.
A collection of statistical software is available from
	  statlib@temper.stat.cmu.edu.
 The TeX User Group distributes TeX-related software from
	  tuglib@math.utah.edu .
 The symbolic algebra system REDUCE is supported by
	  reduce-netlib@rand.org.

 An excellent guide to the mysteries of networks and address syntax is:
 Donnalyn Frey and Rick Adams (1989) "!%@:: A Directory of Electronic
 Mail Addressing and Networks", O'Reilly & Associates, Inc, 632 Petaluma
 Ave, Sebastopol CA 95472.  Background about netlib is in Jack J.
 Dongarra and Eric Grosse, Distribution of Mathematical Software Via
 Electronic Mail, Comm. ACM (1987) 30,403-407 and in a quarterly column
 published in the SIAM News and SIGNUM Newsletter.

 Bugs reports, comments, and annual lists of recipients will be
 forwarded to the code authors when possible.  Many of these codes are
 designed for use by professional numerical analysts who are capable of
 checking for themselves whether an algorithm is suitable for their
 needs.  One routine can be superb and the next awful.  So be careful!

 -------quick summary of contents---------
 a - approximation algorithms
 aicm - selected material from Advances in Computational Mathematics
 alliant - set of programs collected from Alliant users
 amos - special functions by D. Amos.  = toms/644
 apollo - set of programs collected from Apollo users
 benchmark - various benchmark programs and a summary of timings
 bib - bibliographies
 bihar - Bjorstad's biharmonic solver
 blas - machine constants, vector and matrix * vector BLAS
 bmp - Brent's multiple precision package
 c - another "misc" library, for software written in C
 chammp - solution of shallow water equations in spherical geometry
 cheney-kincaid - programs from the 1985 text
 clapack - C version of LAPACK (See description for lapack)
 confdb - conference database
 conformal - conformal mapping
 contin - continuation, limit points
 c++ - code in the C++ language
 dierckx - Spline fitting on various geometries.
 domino - communication and scheduling of multiple tasks; Univ. Maryland
 eispack - matrix eigenvalues and vectors
 elefunt - Cody and Waite's tests for elementary functions
 errata - corrections to numerical books
 f2c - Fortran to C converter
 fishpack - separable elliptic PDEs; Swarztrauber and Sweet
 fitpack - Cline's splines under tension
 fftpack - Swarztrauber's Fourier transforms
 fmm - software from the book by Forsythe, Malcolm, and Moler
 fn - Fullerton's special functions
 fortran - single-double precision converter, static debugger
 fp - floating point arithmetic
 gcv - Generalized Cross Validation
 gmat - multi-processing Time Line and State Graph tools, Mark Seager
 go - "golden oldies"  gaussq, zeroin, lowess, ...
 graphics - auto color, ray-tracing benchmark
 harwell - MA28 sparse linear system
 hence - Heterogeneous Network Computing Environment
 hompack - nonlinear equations by homotopy method
 ieeecss - IEEE / Control Systems Society
 itpack - iterative linear system solution by Young and Kincaid
 jakef - automatic differentiation of Fortran subroutines
 jgraph - tool to create Postscript graphs (located in misc library)
 kincaid-cheney - programs from the 1990 text
 lapack - solving the most common problems in numerical linear algebra
 lanczos - Cullum and Willoughby's Lanczos programs
 lanz - Large Sparse Symmetric Generalized Eigenproblem, Jones and Patrick
 laso - Scott's Lanczos program for eigenvalues of sparse matrices
 linalg - various linear algebra stuff collected over time
 linpack - gaussian elimination, QR, SVD  by Dongarra, Bunch, Moler, Stewart
 lp - linear programming
 machines - short descriptions of various computers
 microscope - Alfeld and Harris' system for discontinuity checking
 minpack - nonlinear equations and least squares by More, Garbow, Hillstrom
 misc - everything else
 mpi - message passing interface (draft specifications)
 na-digest - archive of mailings to NA distribution list
 napack - numerical algebra programs
 news - Grosse's Netlib News column for na-net, SIAM News, SIGNUM Newsletter
 numeralgo - algorithms from the new journal "Numerical Algorithms"
 ode - ordinary differential equations
 odepack - ordinary differential equations from Hindmarsh
 odrpack - orthogonal distance regression, Boggs Byrd Donaldson Schnabel
 opt - optimization
 p4 - portable programs for parallel processors
 paragraph - display of algorithms on message-passing multiprocessor
 paranoia - Kahan's floating point test
 parmacs	-  parallel programmming macros
 pascal - another "misc" library, for software written in Pascal
 parkbench - (formerly pbwg) parallel benchmark working group 
 pchip - hermite cubics  Fritsch+Carlson
 pdes/madpack - a multigrid package, by Craig Douglas
 picl - portable instrumented communication library for multiprocessors
 pltmg - Bank's multigrid code;  too large for ordinary mail
 polyhedra - Hume's database of geometric solids
 popi - Digital Darkroom image manipulation software (Holzmann)
 port - the public subset of PORT library
 posix - draft standards
 pppack - subroutines from de Boor's Practical Guide to Splines
 pvm - parallel virtual machine
 pvm3 - parallel virtual machine version 3
 quadpack - univariate quadrature by Piessens, de Donker, Kahaner
 research - miscellanea from AT&T Bell Labs, Computing Science Research Center
 scalapack - software for MIMD distributed memory computers for some of the lapack routines
 sched - environment for portable parallel algorithms in a Fortran setting.
 sciport - portable version of Cray SCILIB, by McBride and Lamson
 sequent - software from the Sequent Users Group
 slap - Seager + Greenbaum, iterative methods for symmetric and unsymmetric
 slatec - comprehensive mathematical and statistical software package
 sparse - Kundert + Sangiovanni-Vincentelli, C sparse linear algebra
 sparse-blas - BLAS by indirection
 sparspak - George + Liu, sparse linear algebra core
 specfun - transportable special functions
 spin - simulation and validation of communication protocols, G. Holzmann
 stringsearch - string matching
 toeplitz - linear systems in Toeplitz or circulant form by Garbow
 toms - Collected Algorithms of the ACM
 typesetting - typesetting macros and preprocessors
 uncon/data - optimization test problems
 vanhuffel - total least squares, partial SVD  by Van Hufell
 vfftpk - vectorized FFT; variant of fftpack
 voronoi - Voronoi diagrams and Delaunay triangulations
 xnetlib - X windows interface to netlib
 y12m - sparse linear system  (Aarhus)

 --------a bit more detail--------

 The first few libraries here are widely regarded as being of high quality.
 The likelihood of your encountering a bug is relatively small; if you do,
 we certainly want to hear about it!   mail ehg@research.att.com

lib	a
for	approximation algorithms
editor	Eric Grosse
master	research.att.com

lib     aicm
for     selected material from Advances in Computational Mathematics
#       journal published by Baltzer
master  netlib.att.com

lib	alliant
for	programs collected from Alliant users
editor	Jack Dongarra
master	ornl.gov

lib	amos
for	Bessel functions of complex argument and nonnegative order
by	D.E. Amos
ref	ACM TOMS 12 (1986) 265-273 algorithm 644
master	ornl.gov
# The Bessel functions H1, H2, I, J, K, and Y, as well as the
# Airy functions Ai, Bi, and their  derivatives are provided.
# Exponential scaling and sequence generation are optional. 

lib	ampl/models
for	example model and data files for linear and nonlinear programming.
#	available only from netlib@research.att.com
editor	David Gay
master	research.att.com

lib	apollo
for	programs collected from Apollo users.
editor	Jack Dongarra
master	ornl.gov

lib	benchmark
for	contains benchmark programs and the table of Linpack timings.
editor	Jack Dongarra
master	ornl.gov

lib	bib
for	bibliographies:  Golub and Van Loan, 2nd ed.
editor	Eric Grosse
master	research.att.com

lib	bihar
for	biharmonic equation in rectangular geometry and polar coordinates
by	Petter Bjorstad
master	nac.no

lib     blas
for     blas (level 1, 2 and 3) and machine constants
rel     excellent
age     stable
editor  Eric Grosse
master  research.att.com

lib	bmp
for	Brent's multiple precision package
master	research.att.com

lib	c
for	miscellaneous codes written in C
#	Not all C software is in this "miscellaneous" library.
#	If it clearly fits into domain specific library, it is assigned there.
editor	Eric Grosse
master	research.att.com

lib	c/meschach
by	David E. Stewart  des@thrain.anu.edu.au
for	numerical linear algebra, dense and sparse, with permutations, error handling, input/output
lang	C
prec	double
#	o  dynamic allocation, de-allocation, re-sizing and copying of objects
#	o  input and output routines for these objects, and MATLAB
#		save/load format
#	o  error/exception handling
#	o  basic numerical linear algebra -- linear combinations, inner
#		products, matrix-vector and matrix-matrix products
#	o  dense matrix factorise and solve -- LU, Cholesky, LDL^T, QR,
#		QR with	column pivoting, symmetric indefinite (BKP)
#	o  dense matrix factorisation update routines -- LDL^T, QR
#	o  eigenvector/eigenvalue routines -- symmetric, real Schur
#		decomposition, SVD, extract eigenvector
#	o  sparse matrix "utility" routines
#	o  sparse matrix factorise and solve -- Cholesky and LU
#	o  sparse incomplete factorisations -- Cholesky and LU
#	o  iterative techniques -- pre-conditioned conjugate gradients,
#		LSQR, CGS, Lanczos, Arnoldi
#	o  allowance for "procedurally defined" matrices in the iterative
#		techniques
master	research.att.com
#  true master copy: ftp thrain.anu.edu.au:pub/meschach/

lib	c++
for	miscellaneous codes in C++
editor	Eric Grosse
master	research.att.com

lib	chammp
for  directory contains items relating to the numerical solution 
#  of the shallow water equations in spherical geometry.
#  The shallow water equations are used as a kernel for both
#  oceanic and atomospheric general circulation models and
#  are of interest in evaluating numerical methods for weather
#  forecasting and climate modeling.
editor  Jack Dongarra
master  ornl.gov

lib	cheney-kincaid
by	Ward Cheney & David Kincaid
ref	Numerical Mathematics and Computing, 2nd ed., 1985.
master	research.att.com

lib     clapack
for     C version of LAPACK
by      J. Demmel and Xiaoye Li
rel     pre-release
lang    C
master  ornl.gov

lib	confdb
for	conferences database
editor	Shirley Browne (browne@cs.utk.edu)
master	ornl.gov

lib	conformal
for	the "parameter problem" associated with conformal mapping
editor	Eric Grosse
master	research.att.com

lib	contin
for	continuation and limit points, version 6.1 of PITCON
by	Werner Rheinboldt and John Burkardt, University of Pittsburgh.
#	wcrhein@vms.cis.pitt.edu  burkardt@psc.edu
master	research.att.com

lib	crpc
for	NSF Science and Technology Center for Research in Parallel Computation
editor	Jack Dongarra
master	ornl.gov

lib	ddsv
for	"Linear Algebra Computations on Vector and Parallel Computers"
by	Jack Dongarra, Iain Duff, Danny Sorensen, and Henk Van der Vorst.

lib	dierckx
for	spline fitting routines for various kinds of data and geometries
by	Paul Dierckx
#	Comp Sci, K. U. Leuven, Celestijnenlaan 200A, B-3030 Heverlee, Belgium
#	also called fitpack, but no connection with Alan Cline's library
master	research.att.com

lib	domino
for	multiple tasks to communicate and schedule local tasks for execution.
#	These tasks may be on a single processor or spread among multiple
#	processors connected by a message-passing network.
by	O'Leary, Stewart, Van de Geijn, University of Maryland
lang	C, assembler
master	ornl.gov

lib	eispack
for	eigenvalues and eigenvectors
#	A collection of Fortran subroutines that compute the eigenvalues 
#	and eigenvectors of nine classes of matrices.  The package can 
#	determine the eigensystems of complex general, complex Hermitian, 
#	real general, real symmetric, real symmetric band, real symmetric 
#	tridiagonal, special real tridiagonal, generalized real, and 
#	generalized real symmetric matrices. In addition, there are two 
#	routines which use the singular value decomposition to solve 
#	certain least squares problems.
by	NATS Project at Argonne National Laboratory.
prec	double
see	seispack
rel	excellent
age	stable
master	ornl.gov

lib	elefunt
for	testing elementary function programs provided with Fortran compilers
ref	Software Manual for the  Elementary Functions, Prentice Hall, 1980.
by	W. J. Cody and W. Waite
master	ornl.gov

lib	f2c
for	converting Fortran to C
by	Feldman, Gay, Maimone, and Schryer
editor	David Gay
master	research.att.com

lib	fftpack
for	Fast Fourier Transform of periodic and other symmetric sequences
#	This package consists of programs which perform Fast Fourier
#	Transforms for both complex and real periodic sequences and
#	certain other symmetric sequences.
by	Paul Swarztrauber, NCAR.
rel	excellent
age	stable
master	research.att.com

lib	fishpack
for	finite differences for elliptic boundary value problems.
by	Paul Swarztrauber and Roland Sweet.
rel	excellent
age	stable
master	research.att.com

lib	fitpack
for	splines under tension.  (an early version)
by	Alan K. Cline
#	For a current copy and for other routines, contact:
#	Pleasant Valley Software, 8603 Altus Cove, Austin TX 78759, USA
master	research.att.com

lib	fmm
ref	Computer Methods for Mathematical Computations
by	George Forsythe, Mike Malcolm, and Cleve Moler.
prec	double
see	sfmm
master	ornl.gov

lib	fn
for	special functions
by	Wayne Fullerton
master	research.att.com

lib	fortran
for	tools specific to Fortran:  a single/double converter; static debugger
master	research.att.com

lib	fp
for	floating point arithmetic
editor	David Gay
master	research.att.com

lib	gcv
for	Generalized Cross Validation spline smoothing
editor	Eric Grosse
master	research.att.com

lib	gmat
for	multi-processing Time Line and State Graph tools.
by	Mark Seager (LLNL Oct 8, 1987)
master	ornl.gov
# werner@ramius.llnl.gov (Nancy Werner) 26 Oct 90

lib	go
for	Golden Oldies:  widely used,  but not in standard libraries.
#	Nominations welcome!
rel	excellent
age	old
editor	Eric Grosse
master	research.att.com

lib	graphics
for	scientific visualization
editor	Eric Grosse
master	research.att.com

lib	harwell
for	sparse unsymmetric matrix routine MA28 from the Harwell library
editor	Iain Duff
master	ornl.gov

lib	hence
for	Heterogeneous Network Computing Environment
master  ornl.gov

lib	hompack
for	solving nonlinear systems of equations by homotopy methods
#	fixed point, zero finding, and general homotopy curve tracking problems,
#	utilizing both dense and sparse Jacobian matrices;
#	ODE-based, normal flow, and augmentedJacobian.
by	Layne T. Watson  ltw@vtopus.cs.vt.edu  (703) 231-7540
#	Department of Computer Science, VPI & SU, Blacksburg, VA 24061
master	research.att.com

lib	ieeecss
for	IEEE / Control Systems Society
#	sqred, Van Loan's "square reduced" algorithm.
#	Systems and Control Analysis and Design Environment by J. D. Birdwell.
editor	Jack Dongarra
master	ornl.gov

lib	itpack
for	Iterative Linear System Solvers
#	Jacobi method, SOR, SSOR with conjugate gradient acceleration 
#	or with Chebyshev (semi-iteration - SI) acceleration.
by	Young and Kincaid and the group at U of Texas.
#	kincaid@cs.utexas.edu oppe@scri1.scri.fsu.edu joubert@cs.utexas.edu
#	Center for Numerical Analysis; (512) 471-1242
#	RLM Bldg. 13.150; University of Texas at Austin; Austin TX 78713-8510
editor	Bill Coughran
master	research.att.com

lib	jakef
for	automatic differentiation
#	a precompiler that analyses a given Fortran77 source code for 
#	the evaluation of a scalar or vector function and then generates an
#	expanded Fortran subroutine that simultaneously evaluates the gradient
#	or Jacobian respectively. For scalar functions the ratio between the 
#	run-time of the resulting gradient routine and that of the original
#	evaluation routine is never greater than a fixed bound of about five. 
#	The storage requirement may be considerable as it is also proportional 
#	to the run-time of the original routine. Since no differencing is done
#	the partial derivative values obtained are exact up to round-off errors.by	A. Griewank, Argonne National Laboratory, griewank@mcs.anl.gov, 12/1/88.
master	ornl.gov

lib	kincaid-cheney
by	Ward Cheney & David Kincaid
ref	Numerical Analysis: The Mathematics of Scientific Computing, 1990.
master	research.att.com

lib	lanczos
for	a few eigenvalues/eigenvectors of a large (sparse) symmetric matrix
#	real symmetric and  Hermitian matrices
#	singular values and vectors of real, rectangular matrices
by	Jane Cullum and Ralph A. Willoughby, IBM Yorktown  914-945-1589
ref	Lanczos Algorithms for Large Symmetric Eigenvalue Computations, Birkhauser
# Additional codes, for factored inverses, real symmetric generalized
# problems, complex symmetric problems and real symmetric block codes
# are available from the authors.
master	research.att.com

lib	laso
for	a few eigenvalues/eigenvectors of a large (sparse) symmetric matrix
alg	Lanczos
by	David Scott
master	ornl.gov

lib	lanz
for	Large Sparse Symmetric Generalized Eigenproblem
by	Mark T. Jones and Merrell L. Patrick
master	ornl.gov

lib	lapack
for	the most common problems in numerical linear algebra
#	linear equations, linear least squares problems, eigenvalue problems,
#	and singular value problems. It has been designed to be efficient
#	on a wide range of modern high-performance computers.
by	Ed Anderson, Z. Bai, Chris Bischof, Jim Demmel,  Jack Dongarra, Jeremy Du Croz, Anne Greenbaum, Sven Hammarling,  Alan McKenney, Susan Ostrouchov, and Danny Sorensen
rel	excellent
age	research
master	ornl.gov

lib   linalg
for   various linear algebra stuff collected over time
editor   Jack Dongarra
master  ornl.gov

lib	linpack
for	linear  equations and linear least squares problems
#	linear systems whose matrices are general, banded, symmetric 
#	indefinite, symmetric positive definite, triangular, and tridiagonal 
#	square.  In addition, the package computes the QR and singular value 
#	decompositions of rectangular matrices and applies them to least 
#	squares problems.
by	Jack Dongarra, Jim Bunch, Cleve Moler and Pete Stewart.
rel	excellent
age	stable
master	ornl.gov

lib	list
for	various databases searched by netlib's "find" and "who is" commands.
#	By default, "find" searches a large collection of one-line descriptions
#	of netlib items.  You can also search in some proprietary libraries
#	by sending a request of the form
#	   find bessel from imsl nag port.
#	Of course, you can't get the actual source code from netlib!
#	By default, "whois" searches the SIAM Membership List and the "nalist"
#	files maintained by Gene Golub and Mark Kent.  Use the form
#	   whois Ed Block.

lib	lp/data
for	linear programming test problems in MPS format
editor	David Gay
master	research.att.com

lib	machines
for	information on high performance computers
editor	Jack Dongarra
master	ornl.gov

lib	microscope
for	looking closely at functions
#	Given an  interpolation or  approximation  scheme, it
#	allows the following questions, among others, to   be answered:
#	Does the  scheme  interpolate?    How  often is  it
#	differentiable?    What functions does it reproduce exactly?  If
#	the scheme is polynomial, what is its polynomial degree?  Where
#	is the smoothness of a function reduced?  Where are the bugs in
#	a FORTRAN implementation?
by	Peter Alfeld and Bill Harris, Dept. Math., University of Utah
#	801-581-6842 or 801-581-6851
master	research.att.com

lib	minpack
for	nonlinear equations and nonlinear least squares problems.
#	Five algorithmic paths each include a core subroutine and an 
#	easy-to-use driver.  The algorithms proceed either from an analytic 
#	specification of the Jacobian matrix or directly from the problem 
#	functions.  The paths include facilities for systems of equations 
#	with a banded Jacobian matrix, for least squares problems with a 
#	large amount of data, and for checking the consistency of the 
#	Jacobian matrix with the functions.
by	Jorge More', Burt Garbow, and Ken Hillstrom at Argonne National Laboratory.
pred	double
see	sminpack
master	ornl.gov

lib	misc
for	various stuff collected over time
editor	Jack Dongarra
master	ornl.gov

lib     mpi
for     message passing interface
#       This directory contains version 0.1 of the Message Passing Interface
#       specification.  Message Passing Interface (MPI) is a set of
#       subprograms which allow writing portable code for
#       message-passing.
editor  Jack Dongarra
master  ornl.gov

lib	na-digest
for	archives of the numerical interest mailing group
editor	Cleve Moler
master	research.att.com

lib	napack
for	linear algebra and optimization
#	A collection of Fortran subroutines to solve linear systems,
#	to estimate the condition number or the norm of a matrix,
#	to compute determinants, to multiply a matrix by a vector,
#	to invert a matrix, to solve least squares problems, to perform
#	unconstrained minimization, to compute eigenvalues, eigenvectors,
#	the singular value decomposition, or the QR decomposition.
#	The package has special routines for general, band, symmetric,
#	indefinite, tridiagonal, upper Hessenberg, and circulant matrices.
by	Bill Hager
#	Mathematics, Univ. Florida, Gainesville, FL 32611, hager@math.ufl.edu
ref	Applied Numerical Linear Algebra, Prentice-Hall, 1988.
master	research.att.com

lib	news
for	netlib column for SIAM News
lang	LaTeX
by	Eric Grosse
master	research.att.com

lib	numeralgo
for	algorithms from the new journal "Numerical Algorithms"
master	research.att.com

lib	ode
for	initial and boundary value ordinary differential equation solvers
#	colsys, dverk, rkf45, ode
editor	Bill Coughran
master	research.att.com

lib	odepack
for	ODE package
by	Alan Hindmarch and others
prec	double
see	sodepack
master	research.att.com

lib	odrpack
for	Orthogonal Distance Regression
by	Boggs Byrd Rogers Schnabel
#	A portable collection of Fortran subprograms for fitting a model to
#	data.  It is designed primarily for instances when the independent
#	as well as the dependent variables have significant errors,
#	implementing a highly efficient algorithm for solving the weighted
#	orthogonal distance regression problem, i.e., for minimizing the
#	sum of the squares of the weighted orthogonal distances between
#	each data point and the curve described by the model equation.
master	research.att.com

lib   opt
for   miscellaneous optimization software, e.g. Brent's praxis.
editor   David Gay
master   research.att.com

lib     p4
for     Portable Programs for Parallel Processors
by      Rusty Lusk, Argonne National Lab
master  ornl.gov

lib	paragraph
for	graphical display of message-passing multiprocessor architectures.
by	Jennifer Etheridge and Michael Heath, Oak Ridge National Lab.
master	ornl.gov

lib	paranoia
for	exploring the floating point system on your computer.
by	Kahan, Berkeley
editor	David Gay
master	research.att.com

lib	parmacs
for	parallel programmming macros for monitors and send/receive
by	Rusty Lusk, Argonne National Lab (lusk@anl-mcs.arpa)
master	ornl.gov

lib	pascal
for	miscellaneous codes written in Pascal
#	At present, codes from J.C. Nash, Compact Numerical Methods for
#	Computers: Linear Algebra and Function Minimisation, Second Edition
#	Adam Hilger: Bristol & American Institute of Physics: New York, 1990
editor	Eric Grosse
master	research.att.com

lib     parkbench
for     parallel benchmark working group 
#       A collection of archived correspondence of the pbwg
#       and its subcommittee's.  Also available are various
#       parallel benchmarks.  (library formerly pbwg)
editor  Jack Dongarra
master  ornl.gov

lib	pchip
for	monotonic piecewise cubic hermite interpolation of data,
by	Fred N. Fritsch, Lawrence Livermore National Laboratory
editor	Eric Grosse
master	research.att.com

lib	pdes/madpack
for	multigrid
#	a compact package for solving systems of linear equations
#	using multigrid or aggregation-disaggregation methods.  Imbedded
#	in the algorithms are implementations for sparse Gaussian
#	elimination and symmetric Gauss-Seidel (unaccelerated or
#	accelerated by conjugate gradients or Orthomin(1)).  This
#	package is particularly useful for solving problems which arise
#	from discretizing partial differential equations, regardless of
#	whether finite differences, finite elements, or finite volumes
#	are used.
by	Craig Douglas
editor	Bill Coughran
master	research.att.com

lib	picl
for	generic message-passing interface to multiprocessors
#	also provides timestamped trace data
by	Geist, Heath, Peyton, and Worley, Oak Ridge National Lab.
master	ornl.gov

lib	pltmg
for	elliptic partial differential equations in general regions of the plane
#	It features adaptive local mesh
#	refinement, multigrid iteration, and a pseudo-arclength
#	continuation option for parameter dependencies.  The package
#	includes an initial mesh generator and several graphics
#	packages.
ref	PLTMG User's Guide, SIAM publications
by	Randy Bank
editor	Bill Coughran
master	research.att.com

lib	polyhedra
for	angles, vertex locations, etc of geometric solids
by	Andrew Hume
master	research.att.com

lib	popi
for	arbitrary manipulation of digitized images.
ref	Chap 5,6 of Beyond Photography--The Digital Darkroom, PrenticeHall
by	Gerard J. Holzmann
master	research.att.com

lib	port
for	public subset of the PORT library
#	Includes the latest version of Gay's NL2SOL nonlinear least squares.
#	The rest of the PORT3 library is available by license from AT&T.
editor	David Gay
master	research.att.com

lib	posix
for	an experiment sponsored by the IEEE Computer Society
#	to make available draft documents, meeting notices, and
#	minutes for its POSIX standardization activities.
#	Initially, only a very limited subset of working groups
#	and documents is provided.
editor	Andrew Hume
master	research.att.com

lib	pppack
for	splines
by	Carl de Boor
ref	A Practical Guide to Splines, Springer Verlag.
#	This is an old version, from around the time the book was published.
#	Some calling sequences differ slightly from those in the book.
#	We will install a newer version as soon as it arrives.
rel	excellent
age	old
editor	Eric Grosse
master	research.att.com

lib     pvm
for     software and papers on a Parallel Virtual Machine
#       software for heterogeneous netowrking parallel processing in
#       Fortran or C for execution on a wide variety of parallel
#       machines, supercomputers, and workstation networks.
editor  Jack Dongarra, University of Tennessee and Oak Ridge National Lab
master  ornl.gov
 
lib     pvm3
for     software and papers on a Parallel Virtual Machine
#       software for heterogeneous netowrking parallel processing in
#       Fortran or C for execution on a wide variety of parallel
#       machines, supercomputers, and workstation networks.
by      Beguelin, Dongarra, Geist, Jiang, Manchek, Moore, and Sunderam
editor  Jack Dongarra, University of Tennessee and Oak Ridge National Lab
master  ornl.gov

lib	quadpack
for	definite univariate integrals
by	Piessens,  de Donker,  Kahaner
#	(slatec version)
master	research.att.com

lib	research
for	Computing Science Research, AT&T Bell Labs, Murray Hill, NJ
editor	Eric Grosse
master	research.att.com

lib     scalapack
for	software for MIMD distributed memory computers for some of the
#		lapack routines
editor  Jack Dongarra, University of Tennessee and Oak Ridge National Lab
master  ornl.gov

lib	sched
for	the Schedule package, to aid transportable 
#	implementation of parallel algorithms in a Fortran setting.  
by	Jack Dongarra and Dan Sorensen
master	ornl.gov

lib	sciport
for	cray scilib
#	a portable FORTRAN emulation (by M.J. McBride and S.H. Lamson)
#	of CRAY SCILIB, a library of scientific applications subprograms
#	developed by Cray Research, Inc.
editor	Jack Dongarra
master	ornl.gov

lib	seispack
for	eigenvalues and eigenvectors
#	A collection of Fortran subroutines that compute the eigenvalues 
#	and eigenvectors of nine classes of matrices.  The package can 
#	determine the eigensystems of complex general, complex Hermitian, 
#	real general, real symmetric, real symmetric band, real symmetric 
#	tridiagonal, special real tridiagonal, generalized real, and 
#	generalized real symmetric matrices. In addition, there are two 
#	routines which use the singular value decomposition to solve 
#	certain least squares problems.
by	NATS Project at Argonne National Laboratory.
prec	single
see	eispack
master	ornl.gov

lib	sequent
for	software from the Sequent Users Group
editor	Jack Dongarra
master	ornl.gov

lib	sfmm
ref	Computer Methods for Mathematical Computations
by	George Forsythe, Mike Malcolm, and Cleve Moler.
see	fmm
prec	single
master	ornl.gov

lib	slap
for	iterative symmetric and non-symmetric linear system solution
#	Sparse Linear Algebra Package.    
#	  Included in  this package  are  core routines  to   do  Iterative
#	  Refinement    iteration,   Preconditioned    Conjugate   Gradient
#	  iteration,  Preconditioned Conjugate Gradient   iteration on  the
#	  Normal Equations,  Preconditioned BiConjugate Gradient iteration,
#	  Preconditioned BiConjugate Gradient  Squared iteration,  Orthomin
#	  iteration  and  Generalized  Minimum  Residual  iteration.   Core
#	  routines  require the   user  to supply  "MATVEC"  (Matrix Vector
#	  Multiply) and "MSOLVE" (Preconditiong) routines.
by	Mark K. Seager & Anne Greenbaum
editor	Jack Dongarra
master	ornl.gov

lib     slatec
#       comprehensive software library containing over 1400 general 
#       purpose mathematical and statistical routines written in Fortran 77.
editor  Jack Dongarra
master  ornl.gov

lib	sminpack
for	nonlinear equations and nonlinear least squares problems.
#	Five algorithmic paths each include a core subroutine and an 
#	easy-to-use driver.  The algorithms proceed either from an analytic 
#	specification of the Jacobian matrix or directly from the problem 
#	functions.  The paths include facilities for systems of equations 
#	with a banded Jacobian matrix, for least squares problems with a 
#	large amount of data, and for checking the consistency of the 
#	Jacobian matrix with the functions.
by	Jorge More', Burt Garbow, and Ken Hillstrom at Argonne National Laboratory.
pred	single
see	minpack
master	ornl.gov

lib	sodepack
for	ODE package
by	Alan Hindmarch and others
prec	single
see	odepack
master	research.att.com

lib	sparse
for	large sparse systems of linear equations using LU factorization.
#	real and complex square
#	Besides being able to solve linear systems,
#	it is solves transposed systems, find determinants, multiplies
#	a vector by a matrix, and estimate errors due to
#	ill-conditioning in the system of equations and instability in
#	the computations.  Sparse does not require symmetry
#	and is able to perform numerical pivoting (either diagonal or
#	complete) to avoid unnecessary error in the solution.
by	Ken Kundert, Alberto Sangiovanni-Vincentelli. (sparse@ic.berkeley.edu)
lang	C
editor	Jack Dongarra
master	ornl.gov

lib	sparse-blas
for	sparse extension to Basic Linear Algebra Subprograms.
by	Dave Dodson  convex!dodson@a.cs.uiuc.edu
editor	Jack Dongarra
master	ornl.gov

lib	sparspak
ref	Computer Solution of Large Sparse Positive Definite Systems, Prentice Hall, 1981.
by	George and Liu
master	ornl.gov

lib	specfun
for	special functions and accompanying test programs
by	W.J. Cody, Argonne National Laboratory
master	ornl.gov

lib	spin
for	simulation and automated validation of communication protocols.
ref	 ``Design and Validation of Computer Protocols,''
by	Gerard J. Holzmann
master	research.att.com

lib	stoeplitz
for	linear systems of Toeplitz or circulant form
#	and for orthogonal factorization of column-circulant matrices.
by	Burt Garbow at Argonne National Laboratory,
#	as a culmination of Soviet-American collaborative effort.
prec	single
see	toeplitz
master	ornl.gov

lib	stringsearch
for	testing string matching algorithms
#	This is a library of code, test data and harnesses for
#	various kinds of string matching, includeing Boyer-Moore.
by	Hume and Sunday   andrew@research.att.com
ref	"Fast String Searching", Software-Practice and Experience
master	research.att.com

lib	svdpack
for	singular values and singular vectors of large sparse matrices.
by	Mike Berry, University of Tennessee.
master	ornl.gov

lib     tennessee
master  ornl.gov

lib	toeplitz
for	linear systems of Toeplitz or circulant form
#	and for orthogonal factorization of column-circulant matrices.
by	Burt Garbow at Argonne National Laboratory,
#	as a culmination of Soviet-American collaborative effort.
prec	double
see	stoeplitz
master	ornl.gov

lib	toms
for	Collected Algorithms of the ACM
ref	ACM Transactions on Mathematical Software
editor	Robert Renka
master	research.att.com
#	See the back of any recent TOMS for information on ordering tapes.

lib	typesetting
for	troff and LaTeX macros
editor	Eric Grosse
master	research.att.com

lib	uncon/data
for	test problems: unconstrained optimization, nonlinear least squares.
#	Problems from More, Garbow, and Hillstrom;  Fraley, matrix square
#	root;  Hanson, Salane;  McKeown;  De Villiers and Glasser;
#	Dennis, Gay, and Vu.
editor	Chris Fraley
master	research.att.com

lib	vanhuffel
for	total least squares, Partial Singular Value Decomposition
#	The TLS problem assumes an overdetermined set of linear equations
#	AX = B, where both the data matrix A as well as the observation
#	matrix B are inaccurate.
#	The subroutine PTLS solves the Total Least Squares (TLS) problem by
#	using a Partial Singular Value Decomposition (PSVD), hereby improving
#	considerably the computational efficiency with respect to the classi-
#	cal TLS algorithm.
by	Sabine VAN HUFFEL, KU Leuven.
master	research.att.com

lib	vfftpack
for	a vectorized version of fftpack, for multiple sequences.
by	Sweet, Lindgren, and Boisvert.
master	research.att.com

lib	voronoi
for	Voronoi regions and Delaunay triangulations
editor	Eric Grosse
master	research.att.com

lib	xnetlib
for	X Windows netlib file retreival application
editor	Reed Wade (wade@cs.utk.edu)
master	ornl.gov

lib	y12m
for	sparse linear systems
by	Zahari Zlatev, Jerzy Wasniewski and Kjeld Schaumburg
ref	Springer LNCS
# Comp Sci; Math Inst; Univ Aarhus; Ny Munkegade; DK 8000 Aarhus
master	ornl.gov
CUT HERE............
cat > index <<'CUT HERE............'
lib	a
for	approximation algorithms
editor	Eric Grosse
master	netlib.att.com

lib     aicm
for     selected material from Advances in Computational Mathematics
#       journal published by Baltzer
master  netlib.att.com

lib	alliant
for	programs collected from Alliant users
editor	Jack Dongarra
master	ornl.gov

lib	amos
for	Bessel functions of complex argument and nonnegative order
by	D.E. Amos
ref	ACM TOMS 12 (1986) 265-273 algorithm 644
master	ornl.gov
# The Bessel functions H1, H2, I, J, K, and Y, as well as the
# Airy functions Ai, Bi, and their  derivatives are provided.
# Exponential scaling and sequence generation are optional. 

lib	ampl/models
for	example model and data files for linear and nonlinear programming.
#	available only from netlib@research.att.com
editor	David Gay
master	netlib.att.com

lib	anl-reports

lib	apollo
for	programs collected from Apollo users.
editor	Jack Dongarra
master	ornl.gov

lib	benchmark
for	contains benchmark programs and the table of Linpack timings.
editor	Jack Dongarra
master	ornl.gov

lib	bib
for	bibliographies:  Golub and Van Loan, 2nd ed.
editor	Eric Grosse
master	netlib.att.com

lib	bihar
for	biharmonic equation in rectangular geometry and polar coordinates
by	Petter Bjorstad
master	nac.no

lib	bmp
for	Brent's multiple precision package
master	netlib.att.com

lib	c
for	miscellaneous codes written in C
#	Not all C software is in this "miscellaneous" library.
#	If it clearly fits into domain specific library, it is assigned there.
editor	Eric Grosse
master	netlib.att.com

lib	c/meschach
by	David E. Stewart  des@thrain.anu.edu.au
for	numerical linear algebra, dense and sparse, with permutations, error handling, input/output
lang	C
prec	double
#	o  dynamic allocation, de-allocation, re-sizing and copying of objects
#	o  input and output routines for these objects, and MATLAB
#		save/load format
#	o  error/exception handling
#	o  basic numerical linear algebra -- linear combinations, inner
#		products, matrix-vector and matrix-matrix products
#	o  dense matrix factorise and solve -- LU, Cholesky, LDL^T, QR,
#		QR with	column pivoting, symmetric indefinite (BKP)
#	o  dense matrix factorisation update routines -- LDL^T, QR
#	o  eigenvector/eigenvalue routines -- symmetric, real Schur
#		decomposition, SVD, extract eigenvector
#	o  sparse matrix "utility" routines
#	o  sparse matrix factorise and solve -- Cholesky and LU
#	o  sparse incomplete factorisations -- Cholesky and LU
#	o  iterative techniques -- pre-conditioned conjugate gradients,
#		LSQR, CGS, Lanczos, Arnoldi
#	o  allowance for "procedurally defined" matrices in the iterative
#		techniques
master	netlib.att.com
#  true master copy: ftp thrain.anu.edu.au:pub/meschach/

lib	c++
for	miscellaneous codes in C++
editor	Eric Grosse
master	netlib.att.com

lib	chammp
editor	Jack Dongarra
master	ornl.gov

lib	cheney-kincaid
by	Ward Cheney & David Kincaid
ref	Numerical Mathematics and Computing, 2nd ed., 1985.
master	netlib.att.com

lib     clapack
for     C version of LAPACK
by      J. Demmel and Xiaoye Li
rel     pre-release
lang    C
master  ornl.gov

lib	confdb
for	conferences database
editor	Shirley Browne (browne@cs.utk.edu)
master	ornl.gov

lib	conformal
for	the "parameter problem" associated with conformal mapping
editor	Eric Grosse
master	netlib.att.com

lib	contin
for	continuation and limit points, version 6.1 of PITCON
by	Werner Rheinboldt and John Burkardt, University of Pittsburgh.
#	wcrhein@vms.cis.pitt.edu  burkardt@psc.edu
master	netlib.att.com

#lib	cor
for	blas (level 1, 2 and 3) and machine constants
rel	excellent
age	stable
editor	Eric Grosse
master	netlib.att.com

lib	blas
for     blas (level 1, 2 and 3) and machine constants
rel     excellent
age     stable
editor	Jack Dongarra
master	ornl.gov


lib	crpc
for	NSF Science and Technology Center for Research in Parallel Computation
editor	Jack Dongarra
master	ornl.gov

lib	ddsv
for	"Linear Algebra Computations on Vector and Parallel Computers"
by	Jack Dongarra, Iain Duff, Danny Sorensen, and Henk Van der Vorst.

lib	dierckx
for	spline fitting routines for various kinds of data and geometries
by	Paul Dierckx
#	Comp Sci, K. U. Leuven, Celestijnenlaan 200A, B-3030 Heverlee, Belgium
#	also called fitpack, but no connection with Alan Cline's library
master	netlib.att.com

lib	domino
for	multiple tasks to communicate and schedule local tasks for execution.
#	These tasks may be on a single processor or spread among multiple
#	processors connected by a message-passing network.
by	O'Leary, Stewart, Van de Geijn, University of Maryland
lang	C, assembler
master	ornl.gov

lib	eispack
for	eigenvalues and eigenvectors
#	A collection of Fortran subroutines that compute the eigenvalues 
#	and eigenvectors of nine classes of matrices.  The package can 
#	determine the eigensystems of complex general, complex Hermitian, 
#	real general, real symmetric, real symmetric band, real symmetric 
#	tridiagonal, special real tridiagonal, generalized real, and 
#	generalized real symmetric matrices. In addition, there are two 
#	routines which use the singular value decomposition to solve 
#	certain least squares problems.
by	NATS Project at Argonne National Laboratory.
prec	double
see	seispack
rel	excellent
age	stable
master	ornl.gov

lib	elefunt
for	testing elementary function programs provided with Fortran compilers
ref	Software Manual for the  Elementary Functions, Prentice Hall, 1980.
by	W. J. Cody and W. Waite
master	netlib.att.com

lib	f2c
for	converting Fortran to C
by	Feldman, Gay, Maimone, and Schryer
editor	David Gay
master	netlib.att.com

lib	fftpack
for	Fast Fourier Transform of periodic and other symmetric sequences
#	This package consists of programs which perform Fast Fourier
#	Transforms for both complex and real periodic sequences and
#	certain other symmetric sequences.
by	Paul Swarztrauber, NCAR.
rel	excellent
age	stable
master	netlib.att.com

lib	fishpack
for	finite differences for elliptic boundary value problems.
by	Paul Swarztrauber and Roland Sweet.
# CRAYFISHPAK is a new expanded version of FISHPAK that has been totally
# rewritten for vector computers, on which order of magnitude speedups 
# have been commonly observed.  For more information contact Green Mountain 
# Software, 1951 Alpine Ave., Boulder, Colorado, 80304-3657, USA,
# phone (303) 447-9224, or by email: lsweet@greenmtn.com (on internet).
rel	excellent
age	stable
master	netlib.att.com

lib	fitpack
for	splines under tension.  (an early version)
by	Alan K. Cline
#	For a current copy and for other routines, contact:
#	Pleasant Valley Software, 8603 Altus Cove, Austin TX 78759, USA
master	netlib.att.com

lib	fmm
ref	Computer Methods for Mathematical Computations
by	George Forsythe, Mike Malcolm, and Cleve Moler.
prec	double
see	sfmm
master	ornl.gov

lib	fn
for	special functions
by	Wayne Fullerton
master	netlib.att.com

lib	fortran
for	tools specific to Fortran:  a single/double converter; static debugger
master	netlib.att.com

lib	fp
for	floating point arithmetic
editor	David Gay
master	netlib.att.com

lib	gcv
for	Generalized Cross Validation spline smoothing
editor	Eric Grosse
master	netlib.att.com

lib	gmat
for	multi-processing Time Line and State Graph tools.
by	Mark Seager (LLNL Oct 8, 1987)
master	ornl.gov
# werner@ramius.llnl.gov (Nancy Werner) 26 Oct 90

lib	go
for	Golden Oldies:  widely used,  but not in standard libraries.
#	Nominations welcome!
rel	excellent
age	old
editor	Eric Grosse
master	netlib.att.com

lib	graphics
for	scientific visualization
editor	Eric Grosse
master	netlib.att.com

lib	harwell
for	sparse unsymmetric matrix routine MA28 from the Harwell library
editor	Iain Duff
master	ornl.gov

lib	hence
master	ornl.gov

lib	hompack
for	solving nonlinear systems of equations by homotopy methods
#	fixed point, zero finding, and general homotopy curve tracking problems,
#	utilizing both dense and sparse Jacobian matrices;
#	ODE-based, normal flow, and augmentedJacobian.
by	Layne T. Watson  ltw@vtopus.cs.vt.edu  (703) 231-7540
#	Department of Computer Science, VPI & SU, Blacksburg, VA 24061
master	netlib.att.com

lib	hpf
master	netlib.att.com

lib	hypercube

lib	ieeecss
for	IEEE / Control Systems Society
#	sqred, Van Loan's "square reduced" algorithm.
#	Systems and Control Analysis and Design Environment by J. D. Birdwell.
editor	Jack Dongarra
master	ornl.gov

lib	itpack
for	Iterative Linear System Solvers
#	Jacobi method, SOR, SSOR with conjugate gradient acceleration 
#	or with Chebyshev (semi-iteration - SI) acceleration.
by	Young and Kincaid and the group at U of Texas.
#	kincaid@cs.utexas.edu oppe@scri1.scri.fsu.edu joubert@cs.utexas.edu
#	Center for Numerical Analysis; (512) 471-1242
#	RLM Bldg. 13.150; University of Texas at Austin; Austin TX 78713-8510
editor	Bill Coughran
master	netlib.att.com

lib	jakef
for	automatic differentiation
#	a precompiler that analyses a given Fortran77 source code for 
#	the evaluation of a scalar or vector function and then generates an
#	expanded Fortran subroutine that simultaneously evaluates the gradient
#	or Jacobian respectively. For scalar functions the ratio between the 
#	run-time of the resulting gradient routine and that of the original
#	evaluation routine is never greater than a fixed bound of about five. 
#	The storage requirement may be considerable as it is also proportional 
#	to the run-time of the original routine. Since no differencing is done
#	the partial derivative values obtained are exact up to round-off errors.by	A. Griewank, Argonne National Laboratory, griewank@mcs.anl.gov, 12/1/88.
master	ornl.gov

lib	kincaid-cheney
by	Ward Cheney & David Kincaid
ref	Numerical Analysis: The Mathematics of Scientific Computing, 1990.
master	netlib.att.com

lib	lanczos
for	a few eigenvalues/eigenvectors of a large (sparse) symmetric matrix
#	real symmetric and  Hermitian matrices
#	singular values and vectors of real, rectangular matrices
by	Jane Cullum and Ralph A. Willoughby, IBM Yorktown  914-945-1589
ref	Lanczos Algorithms for Large Symmetric Eigenvalue Computations, Birkhauser
# Additional codes, for factored inverses, real symmetric generalized
# problems, complex symmetric problems and real symmetric block codes
# are available from the authors.
master	netlib.att.com

lib	laso
for	a few eigenvalues/eigenvectors of a large (sparse) symmetric matrix
alg	Lanczos
by	David Scott
master	ornl.gov

lib	lanz
for	Large Sparse Symmetric Generalized Eigenproblem
by	Mark T. Jones and Merrell L. Patrick
master	ornl.gov

lib	lapack
for	the most common problems in numerical linear algebra
#	linear equations, linear least squares problems, eigenvalue problems,
#	and singular value problems. It has been designed to be efficient
#	on a wide range of modern high-performance computers.
by	Ed Anderson, Z. Bai, Chris Bischof, Jim Demmel,  Jack Dongarra, Jeremy Du Croz, Anne Greenbaum, Sven Hammarling,  Alan McKenney, Susan Ostrouchov, and Danny Sorensen
rel	excellent
age	research
master	ornl.gov

lib	linalg
for	various linear algebra stuff collected over time
editor	Jack Dongarra
master	ornl.gov

lib	linpack
for	linear  equations and linear least squares problems
#	linear systems whose matrices are general, banded, symmetric 
#	indefinite, symmetric positive definite, triangular, and tridiagonal 
#	square.  In addition, the package computes the QR and singular value 
#	decompositions of rectangular matrices and applies them to least 
#	squares problems.
by	Jack Dongarra, Jim Bunch, Cleve Moler and Pete Stewart.
rel	excellent
age	stable
master	ornl.gov

lib	list
for	various databases searched by netlib's "find" and "who is" commands.
#	By default, "find" searches a large collection of one-line descriptions
#	of netlib items.  You can also search in some proprietary libraries
#	by sending a request of the form
#	   find bessel from imsl nag port.
#	Of course, you can't get the actual source code from netlib!
#	By default, "whois" searches the SIAM Membership List and the "nalist"
#	files maintained by Gene Golub and Mark Kent.  Use the form
#	   whois Ed Block.

lib	lp
lib	lp/data
for	linear programming test problems in MPS format
editor	David Gay
master	netlib.att.com


lib	machines
for	information on high performance computers
editor	Jack Dongarra
master	ornl.gov

lib	magic

lib	microscope
for	looking closely at functions
#	Given an  interpolation or  approximation  scheme, it
#	allows the following questions, among others, to   be answered:
#	Does the  scheme  interpolate?    How  often is  it
#	differentiable?    What functions does it reproduce exactly?  If
#	the scheme is polynomial, what is its polynomial degree?  Where
#	is the smoothness of a function reduced?  Where are the bugs in
#	a FORTRAN implementation?
by	Peter Alfeld and Bill Harris, Dept. Math., University of Utah
#	801-581-6842 or 801-581-6851
master	netlib.att.com

lib	minpack
for	nonlinear equations and nonlinear least squares problems.
#	Five algorithmic paths each include a core subroutine and an 
#	easy-to-use driver.  The algorithms proceed either from an analytic 
#	specification of the Jacobian matrix or directly from the problem 
#	functions.  The paths include facilities for systems of equations 
#	with a banded Jacobian matrix, for least squares problems with a 
#	large amount of data, and for checking the consistency of the 
#	Jacobian matrix with the functions.
by	Jorge More', Burt Garbow, and Ken Hillstrom at Argonne National Laboratory.
pred	double
see	sminpack
master	ornl.gov

lib	misc
for	various stuff collected over time
editor	Jack Dongarra
master	ornl.gov

lib mpi
for     message passing interface draft standard
editor	Jack Dongarra
master	ornl.gov

lib	na-digest
for	archives of the numerical interest mailing group
editor	Cleve Moler
master	netlib.att.com

lib	nag

lib	napack
for	linear algebra and optimization
#	A collection of Fortran subroutines to solve linear systems,
#	to estimate the condition number or the norm of a matrix,
#	to compute determinants, to multiply a matrix by a vector,
#	to invert a matrix, to solve least squares problems, to perform
#	unconstrained minimization, to compute eigenvalues, eigenvectors,
#	the singular value decomposition, or the QR decomposition.
#	The package has special routines for general, band, symmetric,
#	indefinite, tridiagonal, upper Hessenberg, and circulant matrices.
by	Bill Hager
#	Mathematics, Univ. Florida, Gainesville, FL 32611, hager@math.ufl.edu
ref	Applied Numerical Linear Algebra, Prentice-Hall, 1988.
master	netlib.att.com

lib	news
for	netlib column for SIAM News
lang	LaTeX
by	Eric Grosse
master	netlib.att.com

lib	numeralgo
for	algorithms from the new journal "Numerical Algorithms"
master	netlib.att.com

lib	ode
for	initial and boundary value ordinary differential equation solvers
#	colsys, dverk, rkf45, ode
editor	Bill Coughran
master	netlib.att.com

lib	odepack
for	ODE package
by	Alan Hindmarch and others
prec	double
see	sodepack
master	netlib.att.com

lib	odrpack
for	Orthogonal Distance Regression
by	Boggs Byrd Rogers Schnabel
#	A portable collection of Fortran subprograms for fitting a model to
#	data.  It is designed primarily for instances when the independent
#	as well as the dependent variables have significant errors,
#	implementing a highly efficient algorithm for solving the weighted
#	orthogonal distance regression problem, i.e., for minimizing the
#	sum of the squares of the weighted orthogonal distances between
#	each data point and the curve described by the model equation.
master	netlib.att.com

lib   opt
for   miscellaneous optimization software, e.g. Brent's praxis.
editor	David Gay
master	netlib.att.com

lib	p4
for     parallel programming system.
#       subroutines and macors for writing portable parallel
#       programs in Frtran or C for execution on a wide variety of parallel
#       machines and workstation networks.
by      Rusty Lusk, Argonne National Laboratory
lib	papers
master	netlib.att.com

lib	paragraph
for	graphical display of message-passing multiprocessor architectures.
by	Jennifer Etheridge and Michael Heath, Oak Ridge National Lab.
master	ornl.gov

lib	paranoia
for	exploring the floating point system on your computer.
by	Kahan, Berkeley
editor	David Gay
master	netlib.att.com

lib	parmacs
for	parallel programmming macros for monitors and send/receive
by	Rusty Lusk, Argonne National Lab (lusk@anl-mcs.arpa)
master	ornl.gov

lib	pascal
for	miscellaneous codes written in Pascal
#	At present, codes from J.C. Nash, Compact Numerical Methods for
#	Computers: Linear Algebra and Function Minimisation, Second Edition
#	Adam Hilger: Bristol & American Institute of Physics: New York, 1990
editor	Eric Grosse
master	netlib.att.com

lib     parkbench
for     parallel benchmark working group
editor	Jack Dongarra
master	ornl.gov

lib	pbwg

lib	pchip
for	monotonic piecewise cubic hermite interpolation of data,
by	Fred N. Fritsch, Lawrence Livermore National Laboratory
editor	Eric Grosse
master	netlib.att.com

lib	pdes
for	partial differential equation packages
editor	Bill Coughran
master	netlib.att.com

lib     performance

lib	picl
for	generic message-passing interface to multiprocessors
#	also provides timestamped trace data
by	Geist, Heath, Peyton, and Worley, Oak Ridge National Lab.
master	ornl.gov

lib	pltmg
for	elliptic partial differential equations in general regions of the plane
#	It features adaptive local mesh
#	refinement, multigrid iteration, and a pseudo-arclength
#	continuation option for parameter dependencies.  The package
#	includes an initial mesh generator and several graphics
#	packages.
ref	PLTMG User's Guide, SIAM publications
by	Randy Bank
editor	Bill Coughran
master	netlib.att.com

lib	poly2

lib	polyhedra
for	angles, vertex locations, etc of geometric solids
by	Andrew Hume
master	netlib.att.com

lib	popi
for	arbitrary manipulation of digitized images.
ref	Chap 5,6 of Beyond Photography--The Digital Darkroom, PrenticeHall
by	Gerard J. Holzmann
master	netlib.att.com

lib	port
for	public subset of the PORT library
#	Includes the latest version of Gay's NL2SOL nonlinear least squares.
#	The rest of the PORT3 library is available by license from AT&T.
editor	David Gay
master	netlib.att.com

lib	posix
for	an experiment sponsored by the IEEE Computer Society
#	to make available draft documents, meeting notices, and
#	minutes for its POSIX standardization activities.
#	Initially, only a very limited subset of working groups
#	and documents is provided.
editor	Andrew Hume
master	netlib.att.com

lib	pppack
for	splines
by	Carl de Boor
ref	A Practical Guide to Splines, Springer Verlag.
#	This is an old version, from around the time the book was published.
#	Some calling sequences differ slightly from those in the book.
#	We will install a newer version as soon as it arrives.
rel	excellent
age	old
editor	Eric Grosse
master	netlib.att.com

lib	presto

lib	problem-set

lib	pvm
for	software and papers on a Parallel Virtual Machine
#       software for heterogeneous netowrking parallel processing in 
#       Fortran or C for execution on a wide variety of parallel
#       machines, supercomputers, and workstation networks.
editor	Jack Dongarra, University of Tennessee and Oak Ridge National Lab
master	ornl.gov

lib	pvm3
for	software and papers on a Parallel Virtual Machine
#       software for heterogeneous netowrking parallel processing in 
#       Fortran or C for execution on a wide variety of parallel
#       machines, supercomputers, and workstation networks.
by      Beguelin, Dongarra, Geist, Jiang, Manchek, Moore, and Sunderam
editor	Jack Dongarra, University of Tennessee and Oak Ridge National Lab
master	ornl.gov

lib	quadpack
for	definite univariate integrals
by	Piessens,  de Donker,  Kahaner
#	(slatec version)
master	netlib.att.com

lib	research
for	Computing Science Research, AT&T Bell Labs, Murray Hill, NJ
editor	Eric Grosse
master	netlib.att.com

lib	scalapack
for     software for MIMD distributed memory computers for some of the
#       lapack routines
editor	Jack Dongarra, University of Tennessee and Oak Ridge National Lab
master	ornl.gov

lib	sched
for	the Schedule package, to aid transportable 
#	implementation of parallel algorithms in a Fortran setting.  
by	Jack Dongarra and Dan Sorensen
master	ornl.gov

lib	scilib
for	cray scilib
#	a portable FORTRAN emulation (by M.J. McBride and S.H. Lamson)
#	of CRAY SCILIB, a library of scientific applications subprograms
#	developed by Cray Research, Inc.
editor	Jack Dongarra
master	ornl.gov

lib	seispack
for	eigenvalues and eigenvectors
#	A collection of Fortran subroutines that compute the eigenvalues 
#	and eigenvectors of nine classes of matrices.  The package can 
#	determine the eigensystems of complex general, complex Hermitian, 
#	real general, real symmetric, real symmetric band, real symmetric 
#	tridiagonal, special real tridiagonal, generalized real, and 
#	generalized real symmetric matrices. In addition, there are two 
#	routines which use the singular value decomposition to solve 
#	certain least squares problems.
by	NATS Project at Argonne National Laboratory.
prec	single
see	eispack
master	ornl.gov

lib	sequent
for	software from the Sequent Users Group
editor	Jack Dongarra
master	ornl.gov

lib	sfmm
ref	Computer Methods for Mathematical Computations
by	George Forsythe, Mike Malcolm, and Cleve Moler.
see	fmm
prec	single
master	ornl.gov

lib	slap
for	iterative symmetric and non-symmetric linear system solution
#	Sparse Linear Algebra Package.    
#	  Included in  this package  are  core routines  to   do  Iterative
#	  Refinement    iteration,   Preconditioned    Conjugate   Gradient
#	  iteration,  Preconditioned Conjugate Gradient   iteration on  the
#	  Normal Equations,  Preconditioned BiConjugate Gradient iteration,
#	  Preconditioned BiConjugate Gradient  Squared iteration,  Orthomin
#	  iteration  and  Generalized  Minimum  Residual  iteration.   Core
#	  routines  require the   user  to supply  "MATVEC"  (Matrix Vector
#	  Multiply) and "MSOLVE" (Preconditiong) routines.
by	Mark K. Seager & Anne Greenbaum
editor	Jack Dongarra
master	ornl.gov

lib     slatec
#       comprehensive software library containing over 1400 general 
#       purpose mathematical and statistical routines written in Fortran 77.
editor	Eric Grosse
master	netlib.att.com

lib	sminpack
for	nonlinear equations and nonlinear least squares problems.
#	Five algorithmic paths each include a core subroutine and an 
#	easy-to-use driver.  The algorithms proceed either from an analytic 
#	specification of the Jacobian matrix or directly from the problem 
#	functions.  The paths include facilities for systems of equations 
#	with a banded Jacobian matrix, for least squares problems with a 
#	large amount of data, and for checking the consistency of the 
#	Jacobian matrix with the functions.
by	Jorge More', Burt Garbow, and Ken Hillstrom at Argonne National Laboratory.
pred	single
see	minpack
master	ornl.gov

lib	sodepack
for	ODE package
by	Alan Hindmarch and others
prec	single
see	odepack
master	netlib.att.com

lib	sparse
for	large sparse systems of linear equations using LU factorization.
#	real and complex square
#	Besides being able to solve linear systems,
#	it is solves transposed systems, find determinants, multiplies
#	a vector by a matrix, and estimate errors due to
#	ill-conditioning in the system of equations and instability in
#	the computations.  Sparse does not require symmetry
#	and is able to perform numerical pivoting (either diagonal or
#	complete) to avoid unnecessary error in the solution.
by	Ken Kundert, Alberto Sangiovanni-Vincentelli. (sparse@ic.berkeley.edu)
lang	C
editor	Jack Dongarra
master	ornl.gov

lib	sparse-blas
for	sparse extension to Basic Linear Algebra Subprograms.
by	Dave Dodson  convex!dodson@a.cs.uiuc.edu
editor	Jack Dongarra
master	ornl.gov

lib	sparspak
ref	Computer Solution of Large Sparse Positive Definite Systems, Prentice Hall, 1981.
by	George and Liu
master	ornl.gov

lib	specfun
for	special functions and accompanying test programs
by	W.J. Cody, Argonne National Laboratory
master	ornl.gov

lib	spin
for	simulation and automated validation of communication protocols.
ref	 ``Design and Validation of Computer Protocols,''
by	Gerard J. Holzmann
master	netlib.att.com

lib	stoeplitz
for	linear systems of Toeplitz or circulant form
#	and for orthogonal factorization of column-circulant matrices.
by	Burt Garbow at Argonne National Laboratory,
#	as a culmination of Soviet-American collaborative effort.
prec	single
see	toeplitz
master	ornl.gov

lib	stringsearch
for	testing string matching algorithms
#	This is a library of code, test data and harnesses for
#	various kinds of string matching, includeing Boyer-Moore.
by	Hume and Sunday   andrew@research.att.com
ref	"Fast String Searching", Software-Practice and Experience
master	netlib.att.com

lib	svdpack
for	singular values and singular vectors of large sparse matrices.
by	Mike Berry, University of Tennessee.
master	ornl.gov

lib     tennessee
master	ornl.gov

lib	toeplitz
for	linear systems of Toeplitz or circulant form
#	and for orthogonal factorization of column-circulant matrices.
by	Burt Garbow at Argonne National Laboratory,
#	as a culmination of Soviet-American collaborative effort.
prec	double
see	stoeplitz
master	ornl.gov

lib	toms
for	Collected Algorithms of the ACM
ref	ACM Transactions on Mathematical Software
editor	Robert Renka
master	netlib.att.com
#	See the back of any recent TOMS for information on ordering tapes.

lib	typesetting
for	troff and LaTeX macros
editor	Eric Grosse
master	netlib.att.com

lib	uncon
lib	uncon/data
for	test problems: unconstrained optimization, nonlinear least squares.
#	Problems from More, Garbow, and Hillstrom;  Fraley, matrix square
#	root;  Hanson, Salane;  McKeown;  De Villiers and Glasser;
#	Dennis, Gay, and Vu.
editor	Chris Fraley
master	netlib.att.com

lib	vanhuffel
for	total least squares, Partial Singular Value Decomposition
#	The TLS problem assumes an overdetermined set of linear equations
#	AX = B, where both the data matrix A as well as the observation
#	matrix B are inaccurate.
#	The subroutine PTLS solves the Total Least Squares (TLS) problem by
#	using a Partial Singular Value Decomposition (PSVD), hereby improving
#	considerably the computational efficiency with respect to the classi-
#	cal TLS algorithm.
by	Sabine VAN HUFFEL, KU Leuven.
master	netlib.att.com

lib	vfftpack
for	a vectorized version of fftpack, for multiple sequences.
by	Sweet, Lindgren, and Boisvert.
master	netlib.att.com

lib	vfnlib
for	vectorized evaluation of special functions
alg	chebyshev series approximation
by	Ron Boisvert and Bonita Saunders
ref	ACM Trans Math Softw, vol 18 (1992), no 4, pp 456-469
age     research
see	fn
master	netlib.att.com

lib	voronoi
for	Voronoi regions and Delaunay triangulations
editor	Eric Grosse
master	netlib.att.com

lib	xmagic

lib	xnetlib
for	X Windows netlib file retreival application
editor	Reed Wade (wade@cs.utk.edu)
master	ornl.gov

lib	y12m
for	sparse linear systems
by	Zahari Zlatev, Jerzy Wasniewski and Kjeld Schaumburg
ref	Springer LNCS
# Comp Sci; Math Inst; Univ Aarhus; Ny Munkegade; DK 8000 Aarhus
master	ornl.gov


CUT HERE............
#define END