SLATEC
A Mathematical Library
SLATEC
is a FORTRAN90 library which
contains a large amount of numerical software.
The orignal, correct version of SLATEC is as
a FORTRAN77 library. This library is available through NETLIB:
http://www.netlib.org/slatec/index.html.
What you are seeing here is a version of the library that I
have lightly edited; a few changes have been made so that it
will compile as a FORTRAN90 program. However, this version is
not an official version, it is not supported by anybody, and
if you have any doubts about its accuracy, you should refer
to the original, correct FORTRAN77 version!
The huge size of the SLATEC library is both a plus (it has
everything) and a minus (there's so much here I can't find
what I'm looking for!) Since SLATEC is built, in large part,
from a number of smaller, specialized libraries, I would
strongly recommend that if your interests lie entirely within
one of those libraries, you try to find a copy of that library!
Another issue to keep in mind is the extraordinary complexity
of some of the routines. It is not unusual for a single routine
in the SLATEC library to call, directly or indirectly, thirty
or forty routines. In part, this is a testimony to the modularity
of the routines; however, it can make debugging a nightmare.
SLATEC includes
all or some of the following libraries:
-
BLAS, basic linear algebra subprograms;
-
BVSUP, two point boundary value problems solved by superposition;
-
DASSL, for the solution of differential/algebraic systems;
-
DDRIVE/SDRIVE, for the solution of double precision or
single precision systems of ordinary differential equations;
-
DEPAC, for the solution of systems of differential equations;
-
DLAP/SLAP, for the solution of double precision or single
precision sparse systems of linear equations;
-
EISPACK, for the computation of eigenvalues and eigenvectors;
-
FFTPACK, for fast Fourier transforms;
-
FISHPACK, for solution of the Poisson equation;
-
FNLIB, the Fullerton special function library;
-
LINPACK, for solving systems of linear equations;
-
MACHINE, for "looking up" machine arithmetic constants;
-
MINPACK, for minimization (SNLS1, SNSQ);
-
MP, for Brent's multiple-precision arithmetic package;
-
PCHIP, for piecewise cubic Hermite interpolation;
-
PPPACK, for piecewise cubic polynomial interpolation;
-
QUADPACK, for quadrature over finite or infinite 1D intervals;
-
SOS, for square systems of nonlinear equations;
-
SPLP, for linear programming problems;
-
XERROR, for error handling.
Some more information about the SLATEC library is available in
Languages:
SLATEC is available in
a FORTRAN90 version.
Related Data and Programs:
BLAS,
a FORTRAN90 library which
contains the Basic Linear Algebra Subprograms (BLAS)
for level 1, 2 and 3, for single and double precision,
and for real and complex arithmetic.
DLAP,
a FORTRAN90 library which
carries out the iterative solution of sparse linear systems,
by Anne Greenbaum and Mark Seager.
EISPACK,
a FORTRAN90 library which
carries out eigenvalue computations;
superseded by LAPACK;
FFTPACK5,
a FORTRAN90 library which
implements the Fast Fourier Transform (FFT)
by Paul Swarztrauber and Dick Valent;
LINPACK,
a FORTRAN90 library which
contains linear algebra routines.
MACHINE,
a FORTRAN90 library which
contains integer,
single precision real
and double precision real machine constants, and is included
in SLATEC.
MINPACK,
a FORTRAN90 library which
solves systems of nonlinear equations, or the least squares minimization of the
residual of a set of linear or nonlinear equations.
NMS,
a FORTRAN90 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,
optimization and nonlinear least squares, simulation and random numbers,
trigonometric approximation and Fast Fourier Transforms.
PPPACK,
a FORTRAN90 library which
contains cubic spline and general
piecewise polynomial interpolation routines,
included in SLATEC.
QUADPACK,
a FORTRAN90 library which
approximates integrals by numerical quadrature,
included in SLATEC.
XERROR,
a FORTRAN90 library which
is designed to report and handle errors detected during program execution.
Reference:
-
Richard Brent,
A FORTRAN Multiple-Precision Arithmetic Package,
ACM Transactions on Mathematical Software,
Volume 4, Number 1, March 1978, pages 71-81.
-
Richard Brent,
Algorithm 524:
MP: A FORTRAN Multiple-Precision Arithmetic Package,
ACM Transactions on Mathematical Software,
Volume 4, Number 1, March 1978, pages 57-70.
-
Bill Buzbee,
The SLATEC Common Math Library,
in Sources and Development of Mathematical Software,
edited by Wayne Cowell,
Prentice-Hall, 1984,
ISBN: 0-13-823501-5,
LC: QA76.95.S68.
-
Carl deBoor,
A Practical Guide to Splines,
Springer, 2001,
ISBN: 0387953663,
LC: QA1.A647.v27.
-
Jack Dongarra, Jim Bunch, Cleve Moler, Pete Stewart,
LINPACK User's Guide,
SIAM, 1979,
ISBN13: 978-0-898711-72-1.
-
Kirby Fong, Thomas Jefferson, Tokihiko Suyehiro, Lee Walton,
Guide to the SLATEC Common Mathematical Library,
April 10, 1990.
-
Phyllis Fox, Andrew Hall, Norman Schryer,
Algorithm 528:
Framework for a Portable Library,
ACM Transactions on Mathematical Software,
Volume 4, Number 2, June 1978, page 176-188.
-
Fred Fritsch, Ralph Carlson,
Monotone Piecewise Cubic Interpolation,
SIAM Journal on Numerical Analysis,
Volume 17, Number 2, April 1980, pages 238-246.
-
Charles Gear,
Numerical Initial Value Problems in Ordinary Differential
Equations,
Prentice-Hall, 1971,
ISBN: 0136266061,
LC: QA372.G4.
-
Ron Jones, David Kahaner,
XERROR, The SLATEC Error Handling Package,
Technical Report SAND82-0800,
Sandia Laboratories, 1982.
-
David Kahaner, Cleve Moler, Steven Nash,
Numerical Methods and Software,
Prentice Hall, 1989,
ISBN: 0-13-627258-4,
LC: TA345.K34.
-
Charles Lawson, Richard Hanson, David Kincaid, Fred Krogh,
Algorithm 539:
Basic Linear Algebra Subprograms for Fortran Usage,
ACM Transactions on Mathematical Software,
Volume 5, Number 3, September 1979, pages 308-323.
-
Jorge More, Burton Garbow, Kenneth Hillstrom,
User Guide for MINPACK-1,
Technical Report ANL-80-74,
Argonne National Laboratory, 1980.
-
Robert Piessens, Elise deDoncker-Kapenga,
Christian Ueberhuber, David Kahaner,
QUADPACK: A Subroutine Package for Automatic Integration,
Springer, 1983,
ISBN: 3540125531,
LC: QA299.3.Q36.
-
Mark Seager,
A SLAP for the Masses,
Technical Report UCRL-100267,
Lawrence Livermore National Laboratory, December 1988.
-
Paul Swarztrauber,
Vectorizing the FFT's,
in Parallel Computations,
edited by Garry Rodrigue,
Academic Press, 1982,
ISBN: 0125921012,
LC: QA76.6.P348.
-
James Wilkinson, Christian Reinsch,
Handbook for Automatic Computation,
Volume II, Linear Algebra, Part 2,
Springer, 1971,
ISBN: 0387054146,
LC: QA251.W67.
Source Code:
Examples and Tests:
AIRY_PRB just calls some routines that evaluate the Airy function.
SLATEC_PRB is a large program that performs a lot
of tests on the routines.
MACHINE_PRB just calls the routines from the MACHINE library.
List of Routines:
-
AAAAAA is the SLATEC Common Mathematical Library disclaimer and version.
-
ACOSH computes the arc hyperbolic cosine.
-
AI evaluates the Airy function.
-
AIE calculates the Airy function for a negative argument...
-
ALBETA computes the natural logarithm of the complete Beta function.
-
ALGAMS computes the logarithm of the absolute value of the Gamma function.
-
ALI computes the logarithmic integral.
-
ALNGAM computes the logarithm of the absolute value of the Gamma function.
-
ALNREL evaluates ln(1+X) accurate in the sense of relative error.
-
ASINH computes the arc hyperbolic sine.
-
ASYIK is subsidiary to BESI and BESK.
-
ASYJY is subsidiary to BESJ and BESY.
-
ATANH computes the arc hyperbolic tangent.
-
AVINT integrates a function tabulated at arbitrarily spaced abscissas...
-
BAKVEC forms the eigenvectors of a certain real non-symmetric tridiagonal
-
BALANC balances a real general matrix and isolates eigenvalues when possible.
-
BALBAK forms the eigenvectors of a real general matrix from the ...
-
BANDR reduces a real symmetric band matrix to symmetric tridiagonal ...
-
BANDV forms the eigenvectors of a real symmetric band matrix ...
-
BCRH is subsidiary to CBLKTR
-
BDIFF is subsidiary to BSKIN
-
BESI computes an N member sequence of I Bessel functions
-
BESI0 computes the hyperbolic Bessel function of the first kind ...
-
BESI0E computes the exponentially scaled modified (hyperbolic) ...
-
BESI1 computes the modified (hyperbolic) Bessel function of the ...
-
BESI1E computes the exponentially scaled modified (hyperbolic) ...
-
BESJ computes an N member sequence of J Bessel functions ...
-
BESJ0 computes the Bessel function of the first kind of order zero.
-
BESJ1 computes the Bessel function of the first kind of order one.
-
BESK implements forward recursion on the three term recursion ...
-
BESK0 computes the modified (hyperbolic) Bessel function of the
-
BESK0E computes the exponentially scaled modified (hyperbolic)
-
BESK1 computes the modified (hyperbolic) Bessel function of the
-
BESK1E computes the exponentially scaled modified (hyperbolic)
-
BESKES computes a sequence of exponentially scaled modified Bessel
-
BESKNU is subsidiary to BESK.
-
BESKS computes a sequence of modified Bessel functions of the
-
BESY implements forward recursion on the three term recursion ...
-
BESY0 computes the Bessel function of the second kind of order zero.
-
BESY1 computes the Bessel function of the second kind of order one.
-
BESYNU is subsidiary to BESY.
-
BETA computes the complete Beta function.
-
BETAI calculates the incomplete Beta function.
-
BFQAD computes the integral of a product of a function and a ...
-
BI evaluates the Bairy function (the Airy function of the second kind).
-
BIE calculates the Bairy function for a negative argument and an
-
BINOM computes the binomial coefficients.
-
BINT4 computes the B-representation of a cubic spline ...
-
BINTK computes the B-representation of a spline which interpolates ...
-
BISECT computes the eigenvalues of a symmetric tridiagonal matrix ...
-
BKIAS is subsidiary to BSKIN.
-
BKISR is subsidiary to BSKIN.
-
BKSOL is subsidiary to BVSUP.
-
BLKTR1 is subsidiary to BLKTRI.
-
BLKTRI solves a block tridiagonal system of linear equations ...
-
BNDACC computes the LU factorization of a banded matrices using ...
-
BNDSOL solves the least squares problem for a banded matrix using ...
-
BNFAC is subsidiary to BINT4 and BINTK.
-
BNSLV is subsidiary to BINT4 and BINTK.
-
BQR computes some of the eigenvalues of a real symmetric ...
-
BSGQ8 is subsidiary to BFQAD.
-
BSKIN computes repeated integrals of the K-zero Bessel function.
-
BSPDOC is documentation for BSPLINE, a package of subprograms for ...
-
BSPDR uses the B-representation to construct a divided difference
-
BSPEV calculates the value of the spline and its derivatives from
-
BSPLVD is subsidiary to FC.
-
BSPLVN is subsidiary to FC.
-
BSPPP converts the B-representation of a B-spline to the piecewise ...
-
BSPVD calculates the value and all derivatives of order less than ...
-
BSPVN calculates the value of all (possibly) nonzero basis ...
-
BSQAD computes the integral of a K-th order B-spline using the ...
-
BSRH is subsidiary to BLKTRI.
-
BVALU evaluates the B-representation of a B-spline at X for the
-
BVDER is subsidiary to BVSUP.
-
BVPOR is subsidiary to BVSUP.
-
BVSUP solves a linear two-point boundary value problem using ...
-
C0LGMC evaluates (Z+0.5)*LOG((Z+1.)/Z) - 1.0 with relative accuracy.
-
C1MERG merges two strings of complex numbers. Each string is ...
-
C9LGMC computes the log gamma correction factor so that ...
-
C9LN2R evaluates LOG(1+Z) from second order relative accuracy so ...
-
CACAI is subsidiary to CAIRY.
-
CACON is subsidiary to CBESH and CBESK.
-
CACOS computes the complex arc cosine.
-
CACOSH computes the arc hyperbolic cosine.
-
CAIRY computes the Airy function Ai(z) or its derivative dAi/dz ...
-
CARG computes the argument of a complex number.
-
CASIN computes the complex arc sine.
-
CASINH computes the arc hyperbolic sine.
-
CASYI is subsidiary to CBESI and CBESK.
-
CATAN computes the complex arc tangent.
-
CATAN2 computes the complex arc tangent in the proper quadrant.
-
CATANH computes the arc hyperbolic tangent.
-
CAXPY computes a constant times a vector plus a vector.
-
CBABK2 forms the eigenvectors of a complex general matrix from the ...
-
CBAL balances a complex general matrix and isolates eigenvalues ...
-
CBESH computes a sequence of the Hankel functions H(m,a,z) ...
-
CBESI computes a sequence of the Bessel functions I(a,z) for ...
-
CBESJ computes a sequence of the Bessel functions J(a,z) for ...
-
CBESK computes a sequence of the Bessel functions K(a,z) for ...
-
CBESY computes a sequence of the Bessel functions Y(a,z) for ...
-
CBETA computes the complete Beta function.
-
CBINU is subsidiary to CAIRY, CBESH, CBESI, CBESJ, CBESK and CBIRY.
-
CBIRY computes the Airy function Bi(z) or its derivative dBi/dz ...
-
CBKNU is subsidiary to CAIRY, CBESH, CBESI and CBESK.
-
CBLKT1 is subsidiary to CBLKTR.
-
CBLKTR solves a block tridiagonal system of linear equations ...
-
CBRT computes the cube root.
-
CBUNI is subsidiary to CBESI and CBESK.
-
CBUNK is subsidiary to CBESH and CBESK.
-
CCBRT computes the cube root.
-
CCHDC computes the Cholesky decomposition of a positive definite ...
-
CCHDD downdates an augmented Cholesky decomposition or the ...
-
CCHEX updates the Cholesky factorization A=TRANS(R)*R of a ...
-
CCHUD updates an augmented Cholesky decomposition of the ...
-
CCMPB is subsidiary to CBLKTR.
-
CCOPY copies a vector.
-
CCOSH computes the complex hyperbolic cosine.
-
CCOT computes the cotangent.
-
CDCDOT computes the inner product of two vectors with extended ...
-
CDCOR computes corrections to the Y array.
-
CDCST sets coefficients used by the core integrator CDSTP.
-
CDIV computes the complex quotient of two complex numbers.
-
CDNTL sets parameters on the first call to CDSTP, on an internal ...
-
CDNTP interpolates the K-th derivative of Y at TOUT, using the data ...
-
CDOTC computes the dot product of two complex vectors using the complex ...
-
CDOTU computes the inner product of two vectors.
-
CDPSC computes the predicted YH values by effectively multiplying ...
-
CDPST evaluates the Jacobian matrix of the right hand side ...
-
CDRIV1 solves N (200 or fewer) ordinary differential equations ...
-
CDRIV2 solves N ordinary differential equations of the form ...
-
CDRIV3 solves N ordinary differential equations of the form ...
-
CDSCL rescales the YH array whenever the step size is changed.
-
CDSTP performs one step of the integration of an initial value problem ...
-
CDZRO searches for a zero of a function F(N, T, Y, IROOT) ...
-
CEXPRL calculates the relative error exponential (EXP(X)-1)/X.
-
CFFTB computes the unnormalized inverse of CFFTF.
-
CFFTB1 computes the unnormalized inverse of CFFTF1.
-
CFFTF computes the forward transform of a complex, periodic sequence.
-
CFFTF1 computes the forward transform of a complex, periodic sequence.
-
CFFTI initializes a work array for CFFTF and CFFTB.
-
CFFTI1 initializes a real and an integer work array for CFFTF1 and CFFTB1.
-
CFOD is subsidiary to DEBDF.
-
CG computes the eigenvalues and, optionally, the eigenvectors ...
-
CGAMMA computes the complete Gamma function.
-
CGAMR computes the reciprocal of the Gamma function.
-
CGBCO factors a band matrix by Gaussian elimination and ...
-
CGBDI computes the determinant of a complex band matrix using the ...
-
CGBFA factors a band matrix using Gaussian elimination.
-
CGBMV multiplies a complex vector by a complex general band matrix.
-
CGBSL solves the complex band system A*X=B or CTRANS(A)*X=B using ...
-
CGECO factors a matrix using Gaussian elimination and estimates ...
-
CGEDI computes the determinant and inverse of a matrix using the ...
-
CGEEV computes the eigenvalues and, optionally, the eigenvectors ...
-
CGEFA factors a matrix using Gaussian elimination.
-
CGEFS solves a general system of linear equations.
-
CGEIR solves a general system of linear equations. Iterative ...
-
CGEMM multiplies a complex general matrix by a complex general matrix.
-
CGEMV multiplies a complex vector by a complex general matrix.
-
CGERC performs conjugated rank 1 update of a complex general matrix.
-
CGERU performs unconjugated rank 1 update of a complex general matrix.
-
CGESL solves the complex system A*X=B or CTRANS(A)*X=B using the ...
-
CGTSL solves a tridiagonal linear system.
-
CH computes the eigenvalues and, optionally, the eigenvectors ...
-
CHBMV multiplies a complex vector by a complex Hermitian band matrix.
-
CHEMM multiplies a complex general matrix by a complex Hermitian matrix.
-
CHEMV multiplies a complex vector by a complex Hermitian matrix.
-
CHER performs Hermitian rank 1 update of a complex Hermitian matrix.
-
CHER2 performs Hermitian rank 2 update of a complex Hermitian matrix.
-
CHER2K performs Hermitian rank 2k update of a complex Hermitian matrix.
-
CHERK performs Hermitian rank k update of a complex Hermitian matrix.
-
CHFCM checks a single cubic for monotonicity.
-
CHFDV evaluates a cubic polynomial given in Hermite form and its ...
-
CHFEV evaluates a cubic polynomial given in Hermite form at an ...
-
CHFIE evaluates the integral of a single cubic for PCHIA.
-
CHICO factors a complex Hermitian matrix by elimination with symmetric ...
-
CHIDI computes the determinant, inertia and inverse of a complex ...
-
CHIEV computes the eigenvalues and, optionally, the eigenvectors ...
-
CHIFA factors a complex Hermitian matrix by elimination (symmetric pivoting).
-
CHISL solves the complex Hermitian system using factors obtained from CHIFA.
-
CHKDER checks the gradients of M nonlinear functions in N variables, ...
-
CHKPR4 subsidiary to SEPX4.
-
CHKPRM is subsidiary to SEPELI.
-
CHKSN4 is subsidiary to SEPX4.
-
CHKSNG is subsidiary to SEPELI.
-
CHPCO factors a complex Hermitian matrix stored in packed form by ...
-
CHPDI computes the determinant, inertia and inverse of a complex ...
-
CHPFA factors a complex Hermitian matrix stored in packed form by ...
-
CHPMV performs the matrix-vector operation y := alpha*A*x + beta*y.
-
CHPR performs a hermitian rank 1 operation.
-
CHPR2 performs a hermitian rank 2 operation.
-
CHPSL solves a complex Hermitian system using factors from CHPFA.
-
CHU computes the logarithmic confluent hypergeometric function.
-
CINVIT computes the eigenvectors of a complex upper Hessenberg matrix ...
-
CKSCL is subsidiary to CBKNU, CUNK1 and CUNK2.
-
CLBETA computes the natural logarithm of the complete Beta function.
-
CLNGAM computes the logarithm of the absolute value of the Gamma function.
-
CLNREL evaluates ln(1+X) accurate in the sense of relative error.
-
CLOG10 computes the principal value of the complex base 10 logarithm.
-
CMGNBN solves a complex block tridiagonal linear system of ...
-
CMLRI is subsidiary to CBESI and CBESK.
-
CMPCSG is subsidiary to CMGNBN.
-
CMPOSD is subsidiary to CMGNBN.
-
CMPOSN is subsidiary to CMGNBN.
-
CMPOSP is subsidiary to CMGNBN.
-
CMPTR3 is subsidiary to CMGNBN.
-
CMPTRX is subsidiary to CMGNBN.
-
CNBCO factors a band matrix using Gaussian elimination and
-
CNBDI computes the determinant of a band matrix using the factors
-
CNBFA factors a band matrix by elimination.
-
CNBFS solves a general nonsymmetric banded system of linear equations.
-
CNBIR solves a general nonsymmetric banded system of linear equations. ...
-
CNBSL solves a complex band system with factors computed by CNBCO or CNBFA.
-
COMBAK forms the eigenvectors of a complex general matrix from the ...
-
COMHES reduces a complex general matrix to complex upper Hessenberg ...
-
COMLR computes the eigenvalues of a complex upper Hessenberg ...
-
COMLR2 domputes the eigenvalues and eigenvectors of a complex upper ...
-
COMPB is subsidiary to BLKTRI.
-
COMQR computes the eigenvalues of complex upper Hessenberg matrix ...
-
COMQR2 computes the eigenvalues and eigenvectors of a complex upper ...
-
CORTB forms the eigenvectors of a complex general matrix from ...
-
CORTH reduces a complex general matrix to complex upper Hessenberg ...
-
COSDG computes the cosine of an argument in degrees.
-
COSGEN is subsidiary to GENBUN.
-
COSQB computes the unnormalized inverse cosine transform.
-
COSQB1 computes the unnormalized inverse of COSQF1.
-
COSQF computes the forward cosine transform with odd wave numbers.
-
COSQF1 computes the forward cosine transform with odd wave numbers.
-
COSQI initializes a work array for COSQF and COSQB.
-
COST computes the cosine transform of a real, even sequence.
-
COSTI initializes a work array for COST.
-
COT computes the cotangent.
-
CPADD is subsidiary to CBLKTR.
-
CPBCO factors a complex Hermitian positive definite matrix stored ...
-
CPBDI computes the determinant of a complex Hermitian positive
-
CPBFA factors a complex Hermitian positive definite band matrix.
-
CPBSL solves the complex Hermitian positive definite band system ...
-
CPEVL is subsidiary to CPZERO.
-
CPEVLR is subsidiary to CPZERO.
-
CPOCO factors a complex Hermitian positive definite matrix ...
-
CPODI computes the determinant and inverse of a certain complex ...
-
CPOFA factors a complex Hermitian positive definite matrix.
-
CPOFS solves a positive definite symmetric complex linear system.
-
CPOIR solves a positive definite Hermitian system of linear equations. ...
-
CPOSL solves the complex Hermitian positive definite linear system ...
-
CPPCO factors a complex Hermitian positive definite matrix stored ...
-
CPPDI computes the determinant and inverse of a complex Hermitian ...
-
CPPFA factors a complex Hermitian positive definite matrix in packed form.
-
CPPSL solves the complex Hermitian positive definite system using ...
-
CPQR79 finds the zeros of a polynomial with complex coefficients.
-
CPROC is subsidiary to CBLKTR.
-
CPROCP is subsidiary to CBLKTR.
-
CPROD is subsidiary to BLKTRI.
-
CPRODP is subsidiary to BLKTRI.
-
CPSI computes the Psi (or Digamma) function.
-
CPTSL solves a positive definite tridiagonal linear system.
-
CPZERO finds the zeros of a polynomial with complex coefficients.
-
CQRDC uses Householder transformations to compute the QR factorization ...
-
CQRSL applies the output of CQRDC to compute coordinate transformations, ...
-
CRATI is subsidiary to CBESH, CBESI and CBESK.
-
CROTG constructs a Givens transformation.
-
CS1S2 is subsidiary to CAIRY and CBESK.
-
CSCAL multiplies a vector by a constant.
-
CSCALE is subsidiary to BVSUP.
-
CSERI is subsidiary to CBESI and CBESK.
-
CSEVL evaluates a Chebyshev series.
-
CSHCH is subsidiary to CBESH and CBESK.
-
CSICO factors a complex symmetric matrix by elimination with ...
-
CSIDI computes the determinant and inverse of a complex symmetric ...
-
CSIFA factors a complex symmetric matrix with symmetric pivoting.
-
CSINH computes the complex hyperbolic sine.
-
CSISL solves a complex symmetric system factored by CSIFA.
-
CSPCO factors a complex symmetric matrix stored in packed form ...
-
CSPDI computes the determinant and inverse of a complex symmetric ...
-
CSPFA factors a complex symmetric matrix stored in packed form by ...
-
CSPSL solves a complex symmetric system factored by CSPFA.
-
CSROOT computes the complex square root of a complex number.
-
CSROT applies a plane Givens rotation.
-
CSSCAL scales a complex vector.
-
CSVDC performs the singular value decomposition of a rectangular matrix.
-
CSWAP interchanges two vectors.
-
CSYMM multiplies a complex general matrix by a complex symmetric matrix.
-
CSYR2K performs symmetric rank 2k update of a complex symmetric matrix.
-
CSYRK performs symmetric rank k update of a complex symmetric matrix.
-
CTAN computes the complex tangent.
-
CTANH computes the complex hyperbolic tangent.
-
CTBMV multiplies a complex vector by a complex triangular band matrix.
-
CTBSV solves a complex triangular banded system of equations.
-
CTPMV performs one of the matrix-vector operations.
-
CTPSV solves a triangular system of linear equations.
-
CTRCO estimates the condition number of a triangular matrix.
-
CTRDI computes the determinant and inverse of a triangular matrix.
-
CTRMM multiplies a complex general matrix by a complex triangular matrix.
-
CTRMV multiplies a complex vector by a complex triangular matrix.
-
CTRSL solves a system of the form T*X=B or CTRANS(T)*X=B, where ...
-
CTRSM solves a complex triangular system of equations with ...
-
CTRSV solves a complex triangular system of equations.
-
CUCHK is subsidiary to SERI, CUOIK, CUNK1, CUNK2, CUNI1, CUNI2 and CKSCL.
-
CUNHJ is subsidiary to CBESI and CBESK
-
CUNI1 is subsidiary to CBESI and CBESK.
-
CUNI2 is subsidiary to CBESI and CBESK.
-
CUNIK is subsidiary to CBESI and CBESK.
-
CUNK1 is subsidiary to CBESK.
-
CUNK2 is subsidiary to CBESK.
-
CUOIK is subsidiary to CBESH, CBESI and CBESK.
-
CV evaluates the variance function of the curve obtained by FC.
-
CWRSK is subsidiary to CBESI and CBESK.
-
D1MACH returns floating point machine dependent constants.
-
D1MERG merges two strings of ascending double precision numbers.
-
D1MPYQ is subsidiary to DNSQ and DNSQE.
-
D1UPDT is subsidiary to DNSQ and DNSQE.
-
D9AIMP evaluates the Airy modulus and phase.
-
D9ATN1 evaluates DATAN(X) from first order relative accuracy ...
-
D9B0MP evaluates the modulus and phase for the J0 and Y0 Bessel functions.
-
D9B1MP evaluates the modulus and phase for the J1 and Y1 Bessel functions.
-
D9CHU evaluates, for large Z, Z**A * U(A,B,Z), where U is the ...
-
D9GMIC computes the complementary incomplete Gamma function ...
-
D9GMIT computes Tricomi's incomplete Gamma function for small arguments.
-
D9KNUS computes Bessel functions EXP(X)*K-SUB-XNU(X) and ...
-
D9LGIC computes the log complementary incomplete Gamma function ...
-
D9LGIT computes the logarithm of Tricomi's incomplete Gamma function ...
-
D9LGMC computes the log Gamma correction factor so that ...
-
D9LN2R evaluates LOG(1+X) from second order relative accuracy ...
-
D9PAK packs a base 2 exponent into a floating point number.
-
D9UPAK unpacks a floating point number X so that X = Y*2**N.
-
DACOSH computes the arc hyperbolic cosine.
-
DAI evaluates the Airy function.
-
DAIE calculates the Airy function for a negative argument ...
-
DASINH computes the arc hyperbolic sine.
-
DASUM sums the magnitudes of the elements of a vector.
-
DASYIK is subsidiary to DBESI and DBESK.
-
DASYJY is subsidiary to DBESJ and DBESY.
-
DATANH computes the arc hyperbolic tangent.
-
DAVINT integrates a function tabulated at arbitrarily spaced abscissas...
-
DAWS computes Dawson's function.
-
DAXPY computes a constant times a vector plus a vector.
-
DBCG: Preconditioned BiConjugate Gradient Sparse Ax = b Solver.
-
DBDIFF is subsidiary to DBSKIN.
-
DBESI computes an N member sequence of I Bessel functions ...
-
DBESI0 computes the hyperbolic Bessel function of the first kind of order zero.
-
DBESI1 computes the modified (hyperbolic) Bessel function of the first ...
-
DBESJ computes an N member sequence of J Bessel functions ...
-
DBESJ0 computes the Bessel function of the first kind of order zero.
-
DBESJ1 computes the Bessel function of the first kind of order one.
-
DBESK implements forward recursion on the three term recursion ...
-
DBESK0 computes the modified (hyperbolic) Bessel function of the ...
-
DBESK1 computes the modified (hyperbolic) Bessel function of the ...
-
DBESKS computes a sequence of modified Bessel functions of the ...
-
DBESY implements forward recursion on the three term recursion ...
-
DBESY0 computes the Bessel function of the second kind of order zero.
-
DBESY1 computes the Bessel function of the second kind of order one.
-
DBETA computes the complete Beta function.
-
DBETAI calculates the incomplete Beta function.
-
DBFQAD computes the integral of a product of a function and a...
-
DBHIN reads a Sparse Linear System in the Boeing/Harwell Format.
-
DBI evaluates the Bairy function (the Airy function of the second kind).
-
DBIE calculates the Bairy function for a negative argument and an ...
-
DBINOM computes the binomial coefficients.
-
DBINT4 computes the B-representation of a cubic spline ...
-
DBINTK computes the B-representation of a spline which interpolates ...
-
DBKIAS is subsidiary to DBSKIN.
-
DBKISR is subsidiary to DBSKIN.
-
DBKSOL is subsidiary to DBVSUP.
-
DBNDAC computes the LU factorization of banded matrices using ...
-
DBNDSL solves the least squares problem for a banded matrix using ...
-
DBNFAC is subsidiary to DBINT4 and DBINTK.
-
DBNSLV is subsidiary to DBINT4 and DBINTK.
-
DBOCLS solves the bounded and constrained least squares problem ...
-
DBOLS solves the problem E*X = F (in the least squares sense) ...
-
DBOLSM is subsidiary to DBOCLS and DBOLS.
-
DBSGQ8 is subsidiary to DBFQAD.
-
DBSI0E computes the exponentially scaled modified (hyperbolic) Bessel...
-
DBSI1E computes the exponentially scaled modified (hyperbolic) Bessel...
-
DBSK0E computes the exponentially scaled modified (hyperbolic) Bessel ...
-
DBSK1E computes the exponentially scaled modified (hyperbolic) Bessel ...
-
DBSKES computes a sequence of exponentially scaled modified Bessel ...
-
DBSKIN computes repeated integrals of the K-zero Bessel function.
-
DBSKNU is subsidiary to DBESK.
-
DBSPDR uses the B-representation to construct a divided difference table...
-
DBSPEV calculates the value of the spline and its derivatives from...
-
DBSPPP converts the B-representation of a B-spline to the piecewise ...
-
DBSPVD calculates the value and all derivatives of order less than ...
-
DBSPVN calculates the value of all (possibly) nonzero basis functions at X.
-
DBSQAD computes the integral of a K-th order B-spline using the ...
-
DBSYNU is subsidiary to DBESY.
-
DBVALU evaluates the B-representation of a B-spline at X for the ...
-
DBVDER is subsidiary to DBVSUP.
-
DBVPOR is subsidiary to DBVSUP.
-
DBVSUP solves a linear two-point boundary value problem using ...
-
DCBRT computes the cube root.
-
DCDOT computes the inner product of two vectors with extended ...
-
DCFOD is subsidiary to DDEBDF.
-
DCG is a Preconditioned Conjugate Gradient Sparse Ax=b Solver.
-
DCGN is a Preconditioned CG Sparse Ax=b Solver for Normal Equations.
-
DCGS is the Preconditioned BiConjugate Gradient Squared Ax=b Solver.
-
DCHDC computes the Cholesky decomposition of a positive definite matrix.
-
DCHDD downdates an augmented Cholesky decomposition or the ...
-
DCHEX updates the Cholesky factorization A=TRANS(R)*R of a ...
-
DCHFCM checks a single cubic for monotonicity.
-
DCHFDV evaluates a cubic polynomial given in Hermite form and its ...
-
DCHFEV evaluates a cubic polynomial in Hermite form at an array of points.
-
DCHFIE evaluates the integral of a single cubic for DPCHIA.
-
DCHKW is the SLAP WORK/IWORK Array Bounds Checker.
-
DCHU computes the logarithmic confluent hypergeometric function.
-
DCHUD updates an augmented Cholesky decomposition...
-
DCKDER checks the gradients of M nonlinear functions in N variables...
-
DCOEF is subsidiary to DBVSUP.
-
DCOPY copies a vector.
-
DCOPYM copies the negative of a vector to a vector.
-
DCOSDG computes the cosine of an argument in degrees.
-
DCOT computes the cotangent.
-
DCOV calculates the covariance matrix for a nonlinear data fitting problem.
-
DCPPLT makes a Printer Plot of a SLAP Column Format Matrix.
-
DCSCAL is subsidiary to DBVSUP and DSUDS.
-
DCSEVL evaluates a Chebyshev series.
-
DCV evaluates the variance function of the curve obtained ...
-
DDAINI is the initialization routine for DDASSL.
-
DDAJAC computes the DDASSL iteration matrix and forms the LU-decomposition.
-
DDANRM computes vector norms for DDASSL.
-
DDASLV is a linear system solver for DDASSL.
-
DDASSL solves a system of differential/algebraic equations...
-
DDASTP performs one step of the DDASSL integration.
-
DDATRP is an interpolation routine for DDASSL.
-
DDAWS computes Dawson's function.
-
DDAWTS sets the error weight vector for DDASSL.
-
DDCOR computes corrections to the Y array for DDRIVE.
-
DDCST sets coefficients used by the core integrator DDSTP.
-
DDEABM solves an initial value problem in ordinary differential ...
-
DDEBDF solves an initial value problem in ordinary differential ...
-
DDERKF solves an initial value problem in ordinary differential ...
-
DDES is subsidiary to DDEABM.
-
DDNTL sets parameters on the first call to DDSTP, on an internal restart, ...
-
DDNTP interpolates the K-th derivative of Y at TOUT, using the data ...
-
DDOGLG is subsidiary to DNSQ and DNSQE.
-
DDOT computes the inner product of two vectors.
-
DDPSC computes the predicted YH values by effectively multiplying ...
-
DDPST evaluates the Jacobian matrix of the right hand side of the ...
-
DDRIV1 solves N (200 or fewer) ordinary differential equations ...
-
DDRIV2 solves N ordinary differential equations of the form ...
-
DDRIV3 solves N ordinary differential equations of the form ...
-
DDSCL rescales the YH array whenever the step size is changed.
-
DDSTP performs one step of the integration of an initial value problem ...
-
DDZRO searches for a zero of a function F(N, T, Y, IROOT) ...
-
DE1 computes the exponential integral E1(X).
-
DEABM solves an initial value problem in ordinary differential ...
-
DEBDF solves an initial value problem in ordinary differential ...
-
DEFC fits a piecewise polynomial curve to discrete data.
-
DEFCMN is subsidiary to DEFC.
-
DEFE4 is subsidiary to SEPX4.
-
DEFEHL is subsidiary to DERKF.
-
DEFER is subsidiary to SEPELI.
-
DEI computes the exponential integral Ei(X).
-
DENORM is subsidiary to DNSQ and DNSQE.
-
DERF computes the error function.
-
DERFC computes the complementary error function.
-
DERKF solves an initial value problem in ordinary differential ...
-
DERKFS is subsidiary to DERKF.
-
DES is subsidiary to DEABM.
-
DEXBVP is subsidiary to DBVSUP.
-
DEXINT computes an M member sequence of exponential integrals ...
-
DEXPRL calculates the relative error exponential (EXP(X)-1)/X.
-
DFAC computes the factorial function.
-
DFC fits a piecewise polynomial curve to discrete data.
-
DFCMN is subsidiary to FC.
-
DFDJC1 computes a forward difference approximation to an N by N Jacobian.
-
DFDJC3 computes an M by N forward difference approximation to a Jacobian.
-
DFEHL implements a (4,5) order Runge-Kutta-Fehlberg ODE method.
-
DFSPVD evaluates all nonzero B splines and derivatives at X.
-
DFSPVN evaluates all nonzero B-splines of given order at X.
-
DFULMT decodes a standard 2D Fortran array passed as a vector.
-
DFZERO finds a zero of a function in a given interval.
-
DGAMI evaluates the incomplete Gamma function.
-
DGAMIC calculates the complementary incomplete Gamma function.
-
DGAMIT calculates Tricomi's form of the incomplete Gamma function.
-
DGAMLM computes bounds for the argument in the Gamma function.
-
DGAMLN computes the logarithm of the Gamma function.
-
DGAMMA computes the complete Gamma function.
-
DGAMR computes the reciprocal of the Gamma function.
-
DGAMRN computes a Gamma function ratio.
-
DGAUS8 integrates a real function of one variable over a finite interval ...
-
DGBCO factors a band matrix by Gaussian elimination and estimates ...
-
DGBDI computes the determinant of a band matrix using the factors ...
-
DGBFA factors a band matrix using Gaussian elimination.
-
DGBMV performs y = alpha*A*x+beta*y or y = alpha*A'*x+beta*y.
-
DGBSL solves the real band system A*X=B or TRANS(A)*X=B using ...
-
DGECO factors a matrix using Gaussian elimination and estimate ...
-
DGEDI computes the determinant and inverse of a matrix using the ...
-
DGEFA factors a matrix using Gaussian elimination.
-
DGEFS solves a general system of linear equations.
-
DGEMM performs the operation C = alpha op(A) op(B) + beta * C.
-
DGEMV performs y = alpha*A*x+beta*y or y = alpha*A'*x+beta*y.
-
DGER performs A = A + alpha*x*y'.
-
DGESL solves the real system A*X=B or TRANS(A)*X=B using the ...
-
DGLSS solves a linear least squares problems by performing a QR ...
-
DGMRES is the Preconditioned GMRES iterative sparse Ax=b solver.
-
DGTSL solves a tridiagonal linear system.
-
DH12 constructs or applies a Householder transformation.
-
DHELS is an internal routine for DGMRES.
-
DHEQR is an internal routine for DGMRES.
-
DHFTI solves a least squares problem for banded matrices using ...
-
DHKSEQ is subsidiary to DBSKIN.
-
DHSTRT computes a starting step for DDEABM, DDEBDF or DDERKF.
-
DHVNRM computes the maximum norm of a vector.
-
DINIT initializes a double precision vector to a constant.
-
DINTP approximates the solution at XOUT by evaluating the polynomial ...
-
DINTRV computes the largest integer ILEFT in 1 <= ILEFT <= LXT ...
-
DINTYD approximates the ODE solution at T by polynomial interpolation.
-
DIR is the Preconditioned Iterative Refinement Sparse Ax = b Solver.
-
DJAIRY is subsidiary to DBESJ and DBESY.
-
DLBETA computes the natural logarithm of the complete Beta function.
-
DLGAMS computes the logarithm of the absolute value of the Gamma function.
-
DLI computes the logarithmic integral.
-
DLLSIA solves linear least squares problems by performing a QR ...
-
DLLTI2 is the SLAP Backsolve routine for LDL' Factorization.
-
DLNGAM computes the logarithm of the absolute value of the Gamma function.
-
DLNREL evaluates ln(1+X) accurate in the sense of relative error.
-
DLPDOC is the Sparse Linear Algebra Package Version 2.0.2 Documentation.
-
DLPDP is subsidiary to DLSEI.
-
DLSEI solves a linearly constrained least squares problem with ...
-
DLSI is subsidiary to DLSEI.
-
DLSOD is subsidiary to DDEBDF.
-
DLSSUD is subsidiary to DBVSUP and DSUDS.
-
DMACON is subsidiary to DBVSUP.
-
DMGSBV orthogonalizes a set of vectors and determines their rank.
-
DMOUT prints a double precision matrix.
-
DMPAR is subsidiary to DNLS1 and DNLS1E.
-
DNBCO factors a band matrix using Gaussian elimination and ...
-
DNBDI computes the determinant of a band matrix using the factors ...
-
DNBFA factors a band matrix by elimination.
-
DNBFS solves a general nonsymmetric banded system of linear equations.
-
DNBSL solves a real band system using the factors computed by DNBCO or DNBFA.
-
DNLS1 minimizes the sum of the squares of M nonlinear functions ...
-
DNLS1E is an easy-to-use code which minimizes the sum of the squares ...
-
DNRM2 computes the Euclidean length (L2 norm) of a vector.
-
DNSQ finds a zero of a system of a N nonlinear functions in N variables ...
-
DNSQE is an easy-to-use code to find a zero of a system of N nonlinear ...
-
DOGLEG is subsidiary to SNSQ and SNSQE.
-
DOHTRL is subsidiary to DBVSUP and DSUDS.
-
DOMN is a Preconditioned Orthomin Sparse Iterative Ax=b Solver.
-
DORTH is an internal routine for DGMRES.
-
DORTHR is subsidiary to DBVSUP and DSUDS.
-
DP1VLU uses the coefficients generated by DPOLFT to evaluate the ...
-
DPBCO factors a real symmetric positive definite matrix stored in
-
DPBDI computes the determinant of a symmetric positive definite
-
DPBFA factors a real symmetric positive definite matrix stored in
-
DPBSL solves a real symmetric positive definite band system
-
DPCHBS is a piecewise Cubic Hermite to B-Spline converter.
-
DPCHCE sets boundary conditions for DPCHIC.
-
DPCHCI sets interior derivatives for DPCHIC.
-
DPCHCM checks a cubic Hermite function for monotonicity.
-
DPCHCS adjusts derivative values for DPCHIC.
-
DPCHDF computes divided differences for DPCHCE and DPCHSP.
-
DPCHFD evaluates a piecewise cubic Hermite function and its first ...
-
DPCHFE evaluate a piecewise cubic Hermite function at an array of points.
-
DPCHIA evaluates the definite integral of a piecewise cubic Hermite ...
-
DPCHIC sets derivatives needed to determine a piecewise monotone ...
-
DPCHID evaluates the definite integral of a piecewise cubic Hermite ...
-
DPCHIM sets derivatives needed to determine a monotone piecewise ...
-
DPCHKT computes B-spline knot sequence for DPCHBS.
-
DPCHNG is subsidiary to DSPLP.
-
DPCHSP sets derivatives needed to determine the Hermite representation ...
-
DPCHST is the DPCHIP Sign-Testing Routine.
-
DPCHSW limits excursion from data for DPCHCS.
-
DPCOEF converts the DPOLFT coefficients to Taylor series form.
-
DPFQAD computes the integral on (X1,X2) of a product of a ...
-
DPIGMR is an internal routine for DGMRES.
-
DPINCW is subsidiary to DSPLP.
-
DPINIT is subsidiary to DSPLP.
-
DPINTM is subsidiary to DSPLP.
-
DPJAC is subsidiary to DDEBDF.
-
DPLINT produces the polynomial which interpolates a set of discrete ...
-
DPLPCE is subsidiary to DSPLP.
-
DPLPDM is subsidiary to DSPLP.
-
DPLPFE is subsidiary to DSPLP.
-
DPLPFL is subsidiary to DSPLP.
-
DPLPMN is subsidiary to DSPLP.
-
DPLPMU is subsidiary to DSPLP.
-
DPLPUP is subsidiary to DSPLP.
-
DPNNZR is subsidiary to DSPLP.
-
DPOCH evaluates a generalization of Pochhammer's symbol.
-
DPOCH1 calculates a generalization of Pochhammer's symbol starting ...
-
DPOCO factors a real symmetric positive definite matrix
-
DPODI computes the determinant and inverse of a certain real symmetric ...
-
DPOFA factors a real symmetric positive definite matrix.
-
DPOFS solves a positive definite symmetric system of linear equations.
-
DPOLCF computes the coefficients of the polynomial fit (including ...
-
DPOLFT fits discrete data in a least squares sense by polynomials ...
-
DPOLVL evaluates a polynomial and its first NDER derivatives where ...
-
DPOPT is subsidiary to DSPLP.
-
DPOSL solves the real symmetric positive definite linear system ...
-
DPPCO factors a symmetric positive definite matrix stored in
-
DPPDI computes the determinant and inverse of a real symmetric ...
-
DPPERM rearranges an array according to a prescribed permutation.
-
DPPFA factors a real symmetric positive definite matrix in packed form.
-
DPPGQ8 is subsidiary to DPFQAD.
-
DPPQAD computes the integral on (X1,X2) of a K-th order B-spline ...
-
DPPSL solves the real symmetric positive definite system using ...
-
DPPVAL calculates the value of the IDERIV-th derivative of the
-
DPRVEC is subsidiary to DBVSUP.
-
DPRWPG is subsidiary to DSPLP.
-
DPRWVR is subsidiary to DSPLP.
-
DPSI computes the Psi (or Digamma) function.
-
DPSIFN computes derivatives of the Psi function.
-
DPSIXN is subsidiary to DEXINT.
-
DPSORT sorts a double precision array.
-
DPTSL solves a positive definite tridiagonal linear system.
-
DQAG approximates the definite integral of F(X) over (A,B), ...
-
DQAGE approximates the definite integral of F(X) over (A,B), ...
-
DQAGI approximates the integral of F(X) over an infinite interval.
-
DQAGIE approximates the integral of F(X) over an infinite interval.
-
DQAGP approximates the integral of a function with singularities.
-
DQAGPE approximates the integral of a function with singularities.
-
DQAGS approximates the integral of a function with singularities.
-
DQAGSE approximates the integral of a function with singularities.
-
DQAWC approximates the Cauchy principal value of the integral of F(X)/(X-C).
-
DQAWCE approximates the Cauchy principal value of the integral of F(X)/(X-C).
-
DQAWF approximates a given Fourier integral.
-
DQAWFE approximates a given Fourier integral.
-
DQAWO approximates a Fourier integral over a finite interval.
-
DQAWOE approximates a Fourier integral over a finite interval.
-
DQAWS approximates the integral of F(X)*W(X); W has endpoint singularities.
-
DQAWSE approimates the integral F(X)*W(X); W(X) has endpoint singularities.
-
DQC25C computes I = Integral of F/(X-C) over (A,B) with error estimate.
-
DQC25F integrates F(X)*SIN(OMEGA*X) or F(X)*COS(OMEGA*X).
-
DQC25S estimates integral F(X)*W(X) for algebraic or logarithmic singularity.
-
DQCHEB computes Chebyshev series expansions of a function.
-
DQDOTA computes the inner product of two vectors with extended ...
-
DQDOTI computes the inner product of two vectors with extended precision.
-
DQELG applies the Epsilon algorithm.
-
DQFORM explicitly forms the Q matrix of an implicit QR factorization.
-
DQK15 computes Integral of F over (A,B), with error estimate.
-
DQK15I computes an integral over an infinite range.
-
DQK15W computes Integral of F*W over (A,B), with error estimate.
-
DQK21 computes Integral of F over (A,B), with error estimate.
-
DQK31 computes Integral of F over (A,B) with error estimate.
-
DQK41 computes Integral of F over (A,B), with error estimate.
-
DQK51 computes Integral of F over (A,B) with error estimate.
-
DQK61 computes Integral of F over (A,B) with error estimate.
-
DQMOMO computes modified Chebyshev moments.
-
DQNC79 integrates a function using a 7-point adaptive Newton-Cotes rule.
-
DQNG approximates the integral of a function over a finite interval.
-
DQPSRT sorts the local error estimates for a quadrature routine.
-
DQRDC computes the QR factorization of a rectangular matrix.
-
DQRFAC computes the QR factorization of a rectangulr matrix.
-
DQRSL applies the output of DQRDC to compute coordinate transformations, ...
-
DQRSLV solves a least squares problem.
-
DQWGTC defines the weight function for DQAWC.
-
DQWGTF defines the weight function for DQAWF.
-
DQWGTS defines the weight function for DQAWS.
-
DRC approximates the elliptic integral RC.
-
DRC3JJ evaluates the 3J symbol f(L1) for all allowed values of L1.
-
DRC3JM evaluates the 3j symbol g(M2) for all allowed values of M2.
-
DRC6J evaluates the 6j symbol h(L1) for all allowed values of L1.
-
DRD computes the incomplete or complete elliptic integral of 2nd kind.
-
DREADP reads a record from a file, for DSPLP.
-
DREORT orthonormalizes the solution vector of a homogeneous system.
-
DRF computes the incomplete or complete elliptic integral of 1st kind.
-
DRJ computes the incomplete or complete elliptic integral of 3rd kind.
-
DRKFAB integrates an initial value problem for DBVSUP.
-
DRKFS integrates a system of ODE's for DDERKF.
-
DRLCAL calculates the scaled residual for DGMRES.
-
DROT applies a plane Givens rotation.
-
DROTG constructs a plane Givens rotation.
-
DROTM applies a modified Givens rotation.
-
DROTMG constructs a modified Givens rotation.
-
DRSCO transfers data from arrays to common blocks for DDEBDF.
-
DS2LT is the Lower Triangle Preconditioner SLAP Set Up.
-
DS2Y is the SLAP Triad to SLAP Column Format Converter.
-
DSBMV performs the matrix-vector operation y := alpha*A*x + beta*y.
-
DSCAL multiplies a vector by a constant.
-
DSD2S is the Diagonal Scaling Preconditioner SLAP Normal Eqns Set Up.
-
DSDBCG is the Diagonally Scaled BiConjugate Gradient Sparse Ax=b Solver.
-
DSDCG is the Diagonally Scaled Conjugate Gradient Sparse Ax=b Solver.
-
DSDCGN is the Diagonally Scaled CG Sparse Ax=b Solver for Normal Eqn's.
-
DSDCGS is the Diagonally Scaled CGS Sparse Ax=b Solver.
-
DSDGMR is the Diagonally scaled GMRES iterative sparse Ax=b solver.
-
DSDI is a Diagonal Matrix Vector Multiply.
-
DSDOMN is a Diagonally Scaled Orthomin Sparse Iterative Ax=b Solver.
-
DSDOT computes the inner product of two vectors with extended ...
-
DSDS is the Diagonal Scaling Preconditioner SLAP Set Up.
-
DSDSCL carries out Diagonal Scaling of system Ax = b.
-
DSGS is the Gauss-Seidel Method Iterative Sparse Ax = b Solver.
-
DSICCG is the Incomplete Cholesky Conjugate Gradient Sparse Ax=b Solver.
-
DSICO factors a symmetric matrix by elimination with symmetric ...
-
DSICS is the Incompl. Cholesky Decomposition Preconditioner SLAP Set Up.
-
DSIDI computes the determinant, inertia and inverse of a real symmetric ...
-
DSIFA factors a real symmetric matrix by elimination with symmetric pivoting.
-
DSILUR is the incomplete LU Iterative Refinement Sparse Ax = b Solver.
-
DSILUS is the incomplete LU Decomposition Preconditioner SLAP Set Up.
-
DSINDG computes the sine of an argument in degrees.
-
DSISL solves a real symmetric system using the factors obtained from SSIFA.
-
DSJAC is the Jacobi's Method Iterative Sparse Ax = b Solver.
-
DSLI is the SLAP MSOLVE for Lower Triangle Matrix.
-
DSLI2 is the SLAP Lower Triangle Matrix Backsolve.
-
DSLLTI is the SLAP MSOLVE for LDL' (IC) Factorization.
-
DSLUBC is the incomplete LU BiConjugate Gradient Sparse Ax=b Solver.
-
DSLUCN is the ncomplete LU CG Sparse Ax=b Solver for Normal Equations.
-
DSLUCS is the incomplete LU BiConjugate Gradient Squared Ax=b Solver.
-
DSLUGM is the incomplete LU GMRES iterative sparse Ax=b solver.
-
DSLUI is the SLAP MSOLVE for LDU Factorization.
-
DSLUI2 is the SLAP Backsolve for LDU Factorization.
-
DSLUI4 is the SLAP Backsolve for LDU Factorization.
-
DSLUOM is the Incomplete LU Orthomin Sparse Iterative Ax=b Solver.
-
DSLUTI is the SLAP MTSOLV for LDU Factorization.
-
DSLVS is subsidiary to DDEBDF.
-
DSMMI2 is the SLAP Backsolve for LDU Factorization of Normal Equations.
-
DSMMTI is the SLAP MSOLVE for LDU Factorization of Normal Equations.
-
DSMTV is the SLAP Column Format Sparse Matrix Transpose Vector Product.
-
DSMV is the SLAP Column Format Sparse Matrix Vector Product.
-
DSORT sorts an array and optionally make the same interchanges in ...
-
DSOS solves a square system of nonlinear equations.
-
DSOSEQ is subsidiary to DSOS
-
DSOSSL is subsidiary to DSOS.
-
DSPCO factors a real symmetric matrix stored in packed form ...
-
DSPDI computes the determinant, inertia, inverse of a real symmetric ...
-
DSPENC computes a form of Spence's integral due to K. Mitchell.
-
DSPFA factors a real symmetric matrix stored in packed form by ...
-
DSPLP solves linear programming problems involving at most a few thousand ...
-
DSPMV performs the matrix-vector operation y := alpha*A*x + beta*y.
-
DSPR performs a symmetric rank 1 operation.
-
DSPR2 performs a symmetric rank 2 operation.
-
DSPSL solves a real symmetric system using the factors obtained from DSPFA.
-
DSTEPS integrates a system of first order ODE's one step.
-
DSTOD is subsidiary to DDEBDF.
-
DSTOR1 is subsidiary to DBVSUP.
-
DSTWAY is subsidiary to DBVSUP.
-
DSUDS solves an underdetermined system for DBVSUP.
-
DSVCO transfers data from a common block to arrays for DDEBDF.
-
DSVDC performs the singular value decomposition of a rectangular matrix.
-
DSWAP interchanges two vectors.
-
DSYMM performs C = alpha*A*B + beta*C or C = alpha*B*A + beta*C.
-
DSYMV performs y = alpha*A*x + beta*y.
-
DSYR performs A = alpha*x*x' + A.
-
DSYR2 performs A = alpha*x*y' + alpha*y*x' + A.
-
DSYR2K performs a symmetric rank 2k update operation.
-
DSYRK performs a symmetric rank k update operation.
-
DTBMV computes x = A*x or x = A'*x when A is a triangular band matrix.
-
DTBSV solves a triangular band linear system.
-
DTIN reads in SLAP Triad Format Linear System.
-
DTOUT writes out SLAP Triad Format Linear System.
-
DTPMV computes x = A*x or x = A'*x where A is a packed triangular matrix.
-
DTPSV solves A*x=b or A'*x=b where A is a packed triangular matrix.
-
DTRCO estimates the condition number of a triangular matrix.
-
DTRDI computes the determinant and inverse of a triangular matrix.
-
DTRMM performs B = alpha*op(A)*B or B = alpha*B*op(A), A triangular.
-
DTRMV computes x=A*x or x=A'*x where A is triangular.
-
DTRSL solves a triangular system of linear equations.
-
DTRSM solves a matrix equation op(A)*X=alpha*B or X*op(A)=alpha*B.
-
DTRSV solves A*x=b or A'*x=b where A is triangular.
-
DU11LS performs QR factorization for DLLSIA.
-
DU11US performs LQ factorization for DULSIA.
-
DU12LS solves a QR factored linear system for DLLSIA.
-
DU12US solves a QR factored system for DULSIA.
-
DULSIA solves an underdetermined linear system of equations by ...
-
DUSRMT is subsidiary to DSPLP.
-
DVECS is subsidiary to DBVSUP.
-
DVNRMS computes a weighted root-mean-square vector norm for DDEBDF.
-
DVOUT prints a double precision vector.
-
DWNLIT is subsidiary to DWNNLS.
-
DWNLSM is subsidiary to DWNNLS.
-
DWNLT1 is subsidiary to WNLIT.
-
DWNLT2 is subsidiary to WNLIT.
-
DWNLT3 is subsidiary to WNLIT.
-
DWNNLS solves a linearly constrained least squares problem with ...
-
DWRITP is subsidiary to DSPLP.
-
DWUPDT is subsidiary to DNLS1 and DNLS1E.
-
DX is subsidiary to SEPELI.
-
DX4 is subsidiary to SEPX4.
-
DXADD provides double-precision floating-point arithmetic ...
-
DXADJ provides double-precision floating-point arithmetic ...
-
DXC210 provides double-precision floating-point arithmetic ...
-
DXCON provides double-precision floating-point arithmetic ...
-
DXLCAL is an internal routine for DGMRES.
-
DXLEGF computes normalized Legendre polynomials and associated Legendre ...
-
DXNRMP computes normalized Legendre polynomials.
-
DXPMU computes the values of Legendre functions for DXLEGF. ...
-
DXPMUP computes the values of Legendre functions for DXLEGF. ...
-
DXPNRM computes the values of Legendre functions for DXLEGF.
-
DXPQNU computes the values of Legendre functions for DXLEGF.
-
DXPSI computes values of the Psi function for DXLEGF.
-
DXQMU computes the values of Legendre functions for DXLEGF.
-
DXQNU computes the values of Legendre functions for DXLEGF.
-
DXRED provides double-precision floating-point arithmetic ...
-
DXSET provides double-precision floating-point arithmetic ...
-
DY is subsidiary to SEPELI.
-
DY4 is subsidiary to SEPX4.
-
DYAIRY is subsidiary to DBESJ and DBESY.
-
E1 computes the exponential integral E1(X).
-
EFC fits a piecewise polynomial curve to discrete data.
-
EFCMN is subsidiary to EFC.
-
EI computes the exponential integral Ei(X).
-
EISDOC contains documentation for EISPACK, a collection of subprograms ...
-
ELMBAK forms the eigenvectors of a real general matrix from the ...
-
ELMHES reduces a real general matrix to upper Hessenberg form ...
-
ELTRAN accumulates the stabilized elementary similarity ...
-
ENORM is subsidiary to SNLS1, SNLS1E, SNSQ and SNSQE.
-
ERF computes the error function.
-
ERFC computes the complementary error function.
-
EXBVP is subsidiary to BVSUP.
-
EXINT computes an M member sequence of exponential integrals ...
-
EXPREL calculates the relative error exponential (EXP(X)-1)/X.
-
EZFFT1 calls EZFFT1 with appropriate work array partitioning.
-
EZFFTB is a simplified real, periodic, backward fast Fourier transform.
-
EZFFTF computes a simplified real, periodic, fast Fourier forward transform.
-
EZFFTI initializes a work array for EZFFTF and EZFFTB.
-
FAC computes the factorial function.
-
FC fits a piecewise polynomial curve to discrete data.
-
FCMN is subsidiary to FC.
-
FDJAC1 is subsidiary to SNSQ and SNSQE.
-
FDJAC3 is subsidiary to SNLS1 and SNLS1E.
-
FDUMP makes a symbolic dump (should be locally written).
-
FFTDOC is documentation for FFTPACK, a collection of Fast Fourier ...
-
FIGI transforms certain real non-symmetric tridiagonal matrix ...
-
FIGI2 transforms certain real non-symmetric tridiagonal matrix ...
-
FULMAT is subsidiary to SPLP.
-
FUNDOC is documentation for FNLIB, a collection of routines for ...
-
FZERO searches for a zero of a function F(X) in a given interval ...
-
GAMI evaluates the incomplete Gamma function.
-
GAMIC calculates the complementary incomplete Gamma function.
-
GAMIT calculates Tricomi's form of the incomplete Gamma function.
-
GAMLIM computes minimum and maximum argument bounds for the Gamma function.
-
GAMLN computes the logarithm of the Gamma function.
-
GAMMA computes the complete Gamma function.
-
GAMR computes the reciprocal of the Gamma function.
-
GAMRN is subsidiary to BSKIN.
-
GAUS8 integrates a real function of one variable over a finite interval ...
-
GENBUN solves by a cyclic reduction algorithm the linear system ...
-
H12 is subsidiary to HFTI, LSEI and WNNLS.
-
HFTI solves a linear least squares problems by performing a QR ...
-
HKSEQ is subsidiary to BSKIN.
-
HPPERM rearranges an array according to a permutation vector.
-
HPSORT returns the permutation vector generated by sorting a ...
-
HQR computes the eigenvalues of a real upper Hessenberg matrix ...
-
HQR2 computes the eigenvalues and eigenvectors of a real upper ...
-
HSTART is subsidiary to DEABM, DEBDF and DERKF.
-
HSTCRT solves the standard five-point finite difference ...
-
HSTCS1 is subsidiary to HSTCSP.
-
HSTCSP solves the standard five-point finite difference ...
-
HSTCYL solves the standard five-point finite difference ...
-
HSTPLR solves the standard five-point finite difference ...
-
HSTSSP solves the standard five-point finite difference approximation ...
-
HTRIB3 computes the eigenvectors of a complex Hermitian matrix from ...
-
HTRIBK forms the eigenvectors of a complex Hermitian matrix from ...
-
HTRID3 reduces a complex Hermitian (packed) matrix to a real ...
-
HTRIDI reduces a complex Hermitian matrix to a real symmetric ...
-
HVNRM is subsidiary to DEABM, DEBDF and DERKF.
-
HW3CRT solves the standard seven-point finite difference ...
-
HWSCRT solves the standard five-point finite difference ...
-
HWSCS1 is subsidiary to HWSCSP.
-
HWSCSP solves a finite difference approximation to the modified ...
-
HWSCYL solves a standard finite difference approximation ...
-
HWSPLR solves a finite difference approximation to the Helmholtz ...
-
HWSSS1 is subsidiary to HWSSSP.
-
HWSSSP solves a finite difference approximation to the Helmholtz ...
-
I1MACH returns integer machine dependent constants.
-
I1MERG merges two strings of ascending integers.
-
ICAMAX finds the smallest index of the component of a complex ...
-
ICOPY copies a vector.
-
IDAMAX finds the smallest index of that component of a vector ...
-
IDLOC is subsidiary to DSPLP.
-
IMTQL1 computes the eigenvalues of a symmetric tridiagonal matrix
-
IMTQL2 computes eigenvalues and eigenvectors of a symmetric tridiagonal ...
-
IMTQLV computes the eigenvalues of a symmetric tridiagonal matrix ...
-
INDXA is subsidiary to BLKTRI.
-
INDXB is subsidiary to BLKTRI.
-
INDXC is subsidiary to BLKTRI.
-
INITDS determines the number of terms needed in an orthogonal ...
-
INITS determines the number of terms needed in an orthogonal ...
-
INTRV computes the largest integer ILEFT in 1 <= ILEFT <= LXT ...
-
INTYD is subsidiary to DEBDF.
-
INVIT computes the eigenvectors of a real upper Hessenberg ...
-
INXCA is subsidiary to CBLKTR.
-
INXCB is subsidiary to CBLKTR.
-
INXCC is subsidiary to CBLKTR.
-
IPLOC is subsidiary to SPLP.
-
IPPERM rearranges a given array according to a prescribed ...
-
IPSORT returns the permutation vector generated by sorting a given ...
-
ISAMAX finds the smallest index of that component of a vector
-
ISDBCG is the Preconditioned BiConjugate Gradient Stop Test.
-
ISDCG is the Preconditioned Conjugate Gradient Stop Test.
-
ISDCGN is the Preconditioned CG on Normal Equations Stop Test.
-
ISDCGS is the Preconditioned BiConjugate Gradient Squared Stop Test.
-
ISDGMR is the Generalized Minimum Residual Stop Test.
-
ISDIR is the Preconditioned Iterative Refinement Stop Test.
-
ISDOMN is the Preconditioned Orthomin Stop Test.
-
ISORT sorts an array and optionally make the same interchanges in ...
-
ISSBCG is the Preconditioned BiConjugate Gradient Stop Test.
-
ISSCG is the Preconditioned Conjugate Gradient Stop Test.
-
ISSCGN is the Preconditioned CG on Normal Equations Stop Test.
-
ISSCGS is the Preconditioned BiConjugate Gradient Squared Stop Test.
-
ISSGMR is the Generalized Minimum Residual Stop Test.
-
ISSIR is the Preconditioned Iterative Refinement Stop Test.
-
ISSOMN is the Preconditioned Orthomin Stop Test.
-
ISWAP interchanges two vectors.
-
IVOUT prints an integer vector.
-
J4SAVE saves or recalls global variables needed by error handling routines.
-
JAIRY is subsidiary to BESJ and BESY.
-
LA05AD is subsidiary to DSPLP.
-
LA05AS is subsidiary to SPLP.
-
LA05BD is subsidiary to DSPLP.
-
LA05BS is subsidiary to SPLP.
-
LA05CD is subsidiary to DSPLP.
-
LA05CS is subsidiary to SPLP.
-
LA05ED is subsidiary to DSPLP.
-
LA05ES is subsidiary to SPLP.
-
LLSIA solves a linear least squares problems by performing a QR ...
-
LMPAR is subsidiary to SNLS1 and SNLS1E.
-
LPDP is subsidiary to LSEI.
-
LSAME tests two characters to determine if they are the same ...
-
LSEI solves a linearly constrained least squares problem with ...
-
LSI is subsidiary to LSEI.
-
LSOD is subsidiary to DEBDF.
-
LSSODS is subsidiary to BVSUP.
-
LSSUDS is subsidiary to BVSUP.
-
MACON is subsidiary to BVSUP.
-
MC20AD is subsidiary to DSPLP.
-
MC20AS is subsidiary to SPLP.
-
MGSBV is subsidiary to BVSUP.
-
MINFIT computes the singular value decomposition of a rectangular ...
-
MINSO4 is subsidiary to SEPX4.
-
MINSOL is subsidiary to SEPELI.
-
MPADD is subsidiary to DQDOTA and DQDOTI.
-
MPADD2 is subsidiary to DQDOTA and DQDOTI.
-
MPADD3 is subsidiary to DQDOTA and DQDOTI.
-
MPBLAS is subsidiary to DQDOTA and DQDOTI.
-
MPCDM is subsidiary to DQDOTA and DQDOTI.
-
MPCHK is subsidiary to DQDOTA and DQDOTI.
-
MPCMD is subsidiary to DQDOTA and DQDOTI.
-
MPDIVI is subsidiary to DQDOTA and DQDOTI.
-
MPERR is subsidiary to DQDOTA and DQDOTI.
-
MPMAXR sets X to the largest possible 'mp' number.
-
MPMLP performs the inner multiplication loop for MPMUL.
-
MPMUL multiples two 'mp' numbers.
-
MPMUL2 multiplies an 'mp' number by a single precision integer.
-
MPMULI multiplies 'mp' X by a single precision integer.
-
MPNZR is subsidiary to DQDOTA and DQDOTI.
-
MPOVFL is called on multiple precision overflow.
-
MPSTR copies Y = X for multiple precision arguments.
-
MPUNFL is called to handle multiple precision underflow.
-
NUMXER returns the most recent error number.
-
OHTROL
-
OHTROR further reduces a triangular form after ORTHOL has been applied.
-
ORTBAK forms the eigenvectors of a general real matrix from the ...
-
ORTHES reduces a real general matrix to upper Hessenberg form ...
-
ORTHO4 is subsidiary to SEPX4.
-
ORTHOG is subsidiary to SEPELI.
-
ORTHOL reduces a matrix to upper triangular form by Householder.
-
ORTHOR reduces a matrix to lower triangular form by Householder.
-
ORTRAN accumulates orthogonal similarity transformations in the ...
-
PASSB calculates fast Fourier transforms of subvectors of arbitrary length.
-
PASSB2 calculates the fast Fourier transform of subvectors of length two.
-
PASSB3 calculates the fast Fourier transform of subvectors of length three.
-
PASSB4 calculates the fast Fourier transform of subvectors of length four.
-
PASSB5 calculates the fast Fourier transform of subvectors of length five.
-
PASSF calculates fast Fourier transforms of subvectors of arbitrary length.
-
PASSF2 calculates the fast Fourier transform of subvectors of length two.
-
PASSF3 calculates the fast Fourier transform of subvectors of length three.
-
PASSF4 calculates the fast Fourier transform of subvectors of length four.
-
PASSF5 calculates the fast Fourier transform of subvectors of length five.
-
PCHBS is a Piecewise Cubic Hermite to B-Spline converter.
-
PCHCE sets boundary conditions for PCHIC.
-
PCHCI sets interior derivatives for PCHIC.
-
PCHCM checks a cubic Hermite function for monotonicity.
-
PCHCS adjusts derivative values for PCHIC.
-
PCHDF computes divided differences for PCHCE and PCHSP.
-
PCHDOC is documentation for PCHIP, for piecewise cubic Hermite interpolation.
-
PCHFD evaluates a piecewise cubic Hermite function and its first ...
-
PCHFE evaluates a piecewise cubic Hermite function at an array of points. ...
-
PCHIA evaluates the definite integral of a piecewise cubic Hermite ...
-
PCHIC sets derivatives needed to determine a piecewise monotone ...
-
PCHID evaluates the definite integral of a piecewise cubic Hermite ...
-
PCHIM sets derivatives needed to determine a monotone piecewise ...
-
PCHKT computes B-spline knot sequence for PCHBS.
-
PCHNGS is subsidiary to SPLP.
-
PCHSP sets derivatives needed to determine the Hermite representation ...
-
PCHST is the PCHIP Sign-Testing Routine
-
PCHSW limits excursion from data for PCHCS.
-
PCOEF converts the POLFIT coefficients to Taylor series form.
-
PFQAD computes the integral on (X1,X2) of a product of a function F and ...
-
PGSF is subsidiary to CBLKTR.
-
PIMACH supplies the value of PI.
-
PINITM is subsidiary to SPLP.
-
PJAC is subsidiary to DEBDF.
-
PNNZRS is subsidiary to SPLP.
-
POCH evaluates a generalization of Pochhammer's symbol.
-
POCH1 calculates a generalization of Pochhammer's symbol starting
-
POIS3D solves a three-dimensional block tridiagonal linear system ...
-
POISD2 is subsidiary to GENBUN.
-
POISN2 is subsidiary to GENBUN.
-
POISP2 is subsidiary to GENBUN.
-
POISTG solves a block tridiagonal system of linear equations ...
-
POLCOF computes the coefficients of the polynomial fit (including ...
-
POLFIT fits discrete data in a least squares sense by polynomials ...
-
POLINT produces the polynomial which interpolates a set of discrete data.
-
POLYVL calculates the value of a polynomial and its first NDER ...
-
POS3D1 is subsidiary to POIS3D.
-
POSTG2 is subsidiary to POISTG.
-
PPADD is subsidiary to BLKTRI.
-
PPGQ8 is subsidiary to PFQAD.
-
PPGSF is subsidiary to CBLKTR.
-
PPPSF is subsidiary to CBLKTR.
-
PPQAD computes the integral on (X1,X2) of a K-th order B-spline ...
-
PPSGF is subsidiary to BLKTRI.
-
PPSPF is subsidiary to BLKTRI.
-
PPVAL calculates the value of the IDERIV-th derivative of the B-spline ...
-
PROC is subsidiary to CBLKTR.
-
PROCP is subsidiary to CBLKTR.
-
PROD is subsidiary to BLKTRI.
-
PRODP is subsidiary to BLKTRI.
-
PRVEC is subsidiary to BVSUP.
-
PRWPGE is subsidiary to SPLP.
-
PRWVIR is subsidiary to SPLP.
-
PSGF is subsidiary to BLKTRI.
-
PSI computes the Psi (or Digamma) function.
-
PSIFN computes derivatives of the Psi function.
-
PSIXN is subsidiary to EXINT.
-
PVALUE uses the coefficients generated by POLFIT to evaluate the ...
-
PYTHAG computes the complex square root of a complex number without ...
-
QAG calculates an approximation RESULT to a given ...
-
QAGE calculates an approximation RESULT to a given definite integral
-
QAGI calculates an approximation RESULT to a given integral ...
-
QAGIE calculates an approximation RESULT to a given integral ...
-
QAGP calculates an approximation RESULT to a given integral ...
-
QAGPE approximates a given integral I = Integral of F over (A,B), ...
-
QAGS approximates the definite integral of F(X) over (A,B).
-
QAGSE calculates an approximation RESULT to a given integral ...
-
QAWC calculates an approximation RESULT to a Cauchy principal value ...
-
QAWCE calculates an approximation RESULT to a CAUCHY PRINCIPAL VALUE ...
-
QAWF calculates an approximation RESULT to a given Fourier integral ...
-
QAWFE calculates an approximation result to a given Fourier integral ...
-
QAWO calculates an approximation to a given definite integral ...
-
QAWOE calculates an approximation to a given definite integral
-
QAWS calculates an approximation RESULT to a given integral ...
-
QAWSE calculates an approximation RESULT to a given integral ...
-
QC25C computes I = Integral of F*W over (A,B) with error estimate, ...
-
QC25F computes the integral I=Integral of F(X) over (A,B) ...
-
QC25S computes I = Integral of F*W over (BL,BR), with error estimate, ...
-
QCHEB computes the CHEBYSHEV series expansion of degrees 12 and 24 ...
-
QELG determines the limit of a given sequence of approximations, ...
-
QFORM is subsidiary to SNSQ and SNSQE.
-
QK15 computes I = Integral of F over (A,B), with error estimate...
-
QK15I estimates an integral over an infinite or semi-infinite domain.
-
QK15W estimates an integral with a weight function W(X).
-
QK21 estimates an integral with a 21 point Gauss Kronrod rule.
-
QK31 estimates an integral with a 31 point Gauss-Kronrod rule.
-
QK41 estimates an integral with a 41 point Gauss Kronrod rule.
-
QK51 estimates an integral with a 51 point Gauss-Kronrod rule.
-
QK61 estimates an integral with a 61 point Gauss-Kronrod rule.
-
QMOMO computes modified Chebyshev moments. ...
-
QNC79 integrates a function using 7-point adaptive Newton-Cotes quadrature.
-
QNG calculates an approximation RESULT to an integral
-
QPDOC contains documentation for QUADPACK, ...
-
QPSRT is subsidiary to QAGE, QAGIE, QAGPE, QAGSE, QAWCE, QAWOE and QAWSE.
-
QRFAC computes the QR factorization of an M by N matrix.
-
QRSOLV solves a linear system in the least squares sense.
-
QS2I1D sorts an integer array, and adjusts two companion arrays.
-
QS2I1R sorts an integer array, and adjusts two companion arrays.
-
QWGTC defines the WEIGHT function for QAWC.
-
QWGTF defines the weight function for QAWF.
-
QWGTS defines the weight function for QAWS.
-
QZHES is the first step of the QZ algorithm for generalized eigenproblems.
-
QZIT is the second step of the QZ algorithm for generalized eigenproblems.
-
QZVAL is the third step of the QZ algorithm for generalized eigenproblems.
-
QZVEC is the fourth step of the QZ algorithm for generalized eigenproblems.
-
R1MACH returns floating point machine dependent constants.
-
R1MPYQ is subsidiary to SNSQ and SNSQE.
-
R1UPDT is subsidiary to SNSQ and SNSQE.
-
R9AIMP evaluates the Airy modulus and phase.
-
R9ATN1 evaluates ATAN(X) from first order relative accuracy so that ...
-
R9CHU evaluates for large Z Z**A * U(A,B,Z) where U is the logarithmic ...
-
R9GMIC computes the complementary incomplete Gamma function for A ...
-
R9GMIT computes Tricomi's incomplete Gamma function for small arguments.
-
R9KNUS: Bessel functions EXP(X)*K-SUB-XNU(X) and EXP(X)*K-SUB-XNU+1(X) ...
-
R9LGIC computes the log complementary incomplete Gamma function ...
-
R9LGIT computes the logarithm of Tricomi's incomplete Gamma ...
-
R9LGMC computes the log Gamma correction factor so that ...
-
R9LN2R evaluates LOG(1+X) from second order relative accuracy so ...
-
R9PAK packs a base 2 exponent into a floating point number.
-
R9UPAK unpacks a floating point number X so that X = Y*2**N.
-
RADB2 calculates the fast Fourier transform of subvectors of length two.
-
RADB3 calculates the fast Fourier transform of subvectors of length three.
-
RADB4 calculates the fast Fourier transform of subvectors of length four.
-
RADB5 calculates the fast Fourier transform of subvectors of length five.
-
RADBG calculates fast Fourier transforms of subvectors of arbitrary length.
-
RADF2 calculates the fast Fourier transform of subvectors of length two.
-
RADF3 calculates the fast Fourier transform of subvectors of length three.
-
RADF4 calculates the fast Fourier transform of subvectors of length four.
-
RADF5 calculates the fast Fourier transform of subvectors of length five.
-
RADFG calculates fast Fourier transform of subvectors of arbitrary length.
-
RAND generates a uniformly distributed random number.
-
RATQR computes the largest or smallest eigenvalues of a symmetric...
-
RC approximates the elliptic integral RC(X,Y).
-
RC3JJ evaluates the 3j symbol f(L1) = ( L1 L2 L3) ...
-
RC3JM evaluates the 3j symbol g(M2) = (L1 L2 L3 ) ...
-
RC6J evaluates the 6j symbol h(L1) = {L1 L2 L3} ...
-
RD computes the incomplete or complete elliptic integral of the 2nd kind.
-
REBAK forms the eigenvectors of a generalized symmetric ...
-
REBAKB forms the eigenvectors of a generalized symmetric ...
-
REDUC reduces a generalized symmetric eigenproblem to a standard ...
-
REDUC2 reduces a certain generalized symmetric eigenproblem to a ...
-
REORT is subsidiary to BVSUP.
-
RF computes the incomplete or complete elliptic integral of the 1st kind.
-
RFFTB computes the backward fast Fourier transform of a real array.
-
RFFTB1 computes the backward fast Fourier transform of a real array.
-
RFFTF computes the forward transform of a real, periodic sequence.
-
RFFTF1 computes the forward transform of a real, periodic sequence.
-
RFFTI initializes a work array for RFFTF and RFFTB.
-
RFFTI1 initializes a real and an integer work array for RFFTF1 and RFFTB1.
-
RG computes the eigenvalues and eigenvectors of a real general matrix.
-
RG computes the eigenvalues and eigenvectors of a real general matrix.
-
RGAUSS generate a normally distributed (Gaussian) random number.
-
RGG computes eigenvalues and eigenvectors for real generalized eigenproblem.
-
RJ: incomplete or complete (X, Y, or Z = 0) elliptic integral of 3rd kind.
-
RKFAB integrates an initial value problem for BVSUP.
-
RPQR79 finds the zeros of a polynomial with real coefficients.
-
RPZERO finds the zeros of a polynomial with real coefficients.
-
RS computes the eigenvalues and the eigenvectors of a real symmetric matrix.
-
RSB computes eigenvalues and eigenvectors of a symmetric band matrix.
-
RSCO is subsidiary to DEBDF.
-
RSG computes eigenvalues, eigenvectors of symmetric generalized eigenproblem.
-
RSGAB: eigenvalues and eigenvectors of a symmetric generalized eigenproblem.
-
RSGBA: eigenvalues and eigenvectors of a symmetric generalized eigenproblem.
-
RSP eigenvalues and eigenvectors of real symmetric packed matrix.
-
RST eigenvalues and eigenvectors of a real symmetric tridiagonal matrix.
-
RT computes eigenvalues/vectors of a special real tridiagonal matrix.
-
RUNIF generates a uniformly distributed random number.
-
RWUPDT is subsidiary to SNLS1 and SNLS1E.
-
S1MERG merges two strings of ascending real numbers.
-
SASUM compute the sum of the magnitudes of the elements of a vector.
-
SAXPY computes a constant times a vector plus a vector.
-
SBCG is the Preconditioned BiConjugate Gradient Sparse Ax = b Solver.
-
SBHIN reads a Sparse Linear System in the Boeing/Harwell Format.
-
SBOCLS solves the bounded and constrained least squares problem ...
-
SBOLS solves the problem E*X = F (in the least squares sense) ...
-
SBOLSM is subsidiary to SBOCLS and SBOLS.
-
SCASUM computes the sum of the magnitudes of the real and ...
-
SCG is the Preconditioned Conjugate Gradient Sparse Ax=b Solver.
-
SCGN is the Preconditioned CG Sparse Ax=b Solver for Normal Equations.
-
SCGS is the Preconditioned BiConjugate Gradient Squared Ax=b Solver.
-
SCHDC computes the Cholesky decomposition of a positive definite matrix.
-
SCHDD downdates an augmented Cholesky decomposition or the ...
-
SCHEX updates the Cholesky factorization A=TRANS(R)*R of a positive ...
-
SCHKW is the SLAP WORK/IWORK Array Bounds Checker.
-
SCHUD updates an augmented Cholesky decomposition of the triangular part ...
-
SCLOSM is subsidiary to SPLP.
-
SCNRM2 computes the unitary norm of a complex vector.
-
SCOEF is subsidiary to BVSUP.
-
SCOPY copies a vector.
-
SCOPYM copies the negative of a vector to a vector.
-
SCOV calculates the covariance matrix for a nonlinear data fitting problem.
-
SCPPLT does a Printer Plot of SLAP Column Format Matrix.
-
SDAINI is the initialization routine for SDASSL.
-
SDAJAC computes and LU factors the iteration matrix for SDASSL.
-
SDANRM computes vector norms for SDASSL.
-
SDASLV is the linear system solver for SDASSL.
-
SDASSL solves a system of differential/algebraic equations ...
-
SDASTP performs one step of the SDASSL integration.
-
SDATRP is the interpolation routine for SDASSL.
-
SDAWTS sets the Gerror weight vector for SDASSL.
-
SDCOR computes corrections to the Y array for SDRIVE.
-
SDCST sets coefficients used by the core integrator SDSTP.
-
SDNTL sets parameters on the first call to SDSTP, on an internal restart, ...
-
SDNTP interpolates the K-th derivative of Y at TOUT, using the data ...
-
SDOT computes the inner product of two vectors.
-
SDPSC computes the predicted YH values by effectively multiplying ...
-
SDPST evaluates the Jacobian matrix of the right hand side of the ...
-
SDRIV1 solves N ordinary differential equations of the form ...
-
SDRIV2 solves N ordinary differential equations of the form ...
-
SDRIV3 solves N ordinary differential equations of the form ...
-
SDSCL rescales the YH array whenever the step size is changed.
-
SDSCL rescales the YH array whenever the step size is changed.
-
SDSDOT computes the inner product of two vectors with extended precision.
-
SDSTP performs one step of the integration of an initial value problem ...
-
SDZRO searches for a zero of a function F(N, T, Y, IROOT) ...
-
SEPELI discretizes and solves a second and, optionally, a fourth order ...
-
SEPX4 solves for either the second or fourth order finite difference ...
-
SGBCO factors a band matrix by Gaussian elimination and estimates ...
-
SGBDI computes the determinant of a band matrix using the factors ...
-
SGBFA factors a band matrix using Gaussian elimination.
-
SGBMV multiplies a real vector by a real general band matrix.
-
SGBSL solves the real band system A*X=B or TRANS(A)*X=B using ...
-
SGECO factors a matrix using Gaussian elimination and estimates ...
-
SGEDI computes the determinant and inverse of a matrix using the ...
-
SGEEV computes the eigenvalues and, optionally, the eigenvectors ...
-
SGEFA factors a matrix using Gaussian elimination.
-
SGEFS solves a general system of linear equations.
-
SGEIR solves a general system of linear equations. Iterative refinement ...
-
SGEMM multiplies a real general matrix by a real general matrix.
-
SGEMV multiplies a real vector by a real general matrix.
-
SGER performs a rank 1 update of a real general matrix.
-
SGESL solves the real system A*X=B or TRANS(A)*X=B using the ...
-
SGLSS solves a linear least squares problems by performing a QR ...
-
SGMRES is a Preconditioned GMRES Iterative Sparse Ax=b Solver.
-
SGTSL solves a tridiagonal linear system.
-
SHELS is an internal routine for SGMRES.
-
SHEQR is an internal routine for SGMRES.
-
SINDG computes the sine of an argument in degrees.
-
SINIT initializes a real vector to a constant.
-
SINQB computes the unnormalized inverse of SINQF.
-
SINQF computes the forward sine transform with odd wave numbers.
-
SINQI initializes a work array for SINQF and SINQB.
-
SINT computes the sine transform of a real, odd sequence.
-
SINTI initializes a work array for SINT.
-
SINTRP approximates the solution at XOUT by evaluating the polynomial ...
-
SIR is the Preconditioned Iterative Refinement Sparse Ax = b Solver.
-
SLLTI2 is the SLAP Backsolve routine for LDL' Factorization.
-
SLPDOC is the Sparse Linear Algebra Package Version 2.0.2 Documentation.
-
SLVS solves the linear system for the integrator package DEBDF.
-
SMOUT prints a single precision matrix.
-
SNBCO factors a band matrix using Gaussian elimination and estimates ...
-
SNBDI computes the determinant of a band matrix using the factors ...
-
SNBFA factors a real band matrix by elimination.
-
SNBFS solves a general nonsymmetric banded system of linear equations.
-
SNBIR solves a general nonsymmetric banded system of linear equations.
-
SNBSL solves a real band system using the factors computed by SNBCO or SNBFA.
-
SNLS1 minimizes the sum of the squares of M nonlinear functions ...
-
SNLS1E is the easy-to-use version of SNLS1.
-
SNRM2 computes the Euclidean length (L2 norm) of a vector.
-
SNSQ finds a zero of a system of a N nonlinear functions in N variables ...
-
SNSQE is an easy-to-use version of SNSQ.
-
SODS solves an overdetermined linear system for BVSUP.
-
SOMN is the Preconditioned Orthomin Sparse Iterative Ax=b Solver.
-
SOPENM is subsidiary to SPLP.
-
SORTH is an internal routine for SGMRES.
-
SOS solves a square system of nonlinear equations.
-
SOSEQS is subsidiary to SOS.
-
SOSSOL is subsidiary to SOS.
-
SPBCO factors a real symmetric positive definite matrix stored in ...
-
SPBDI computes the determinant of a symmetric positive definite ...
-
SPBFA factors a real symmetric positive definite matrix stored in band form.
-
SPBSL solves a real symmetric positive definite band system using the ...
-
SPELI4 is subsidiary to SEPX4.
-
SPELIP is subsidiary to SEPELI.
-
SPENC computes a form of Spence's integral due to K. Mitchell.
-
SPIGMR is an internal routine for SGMRES.
-
SPINCW is subsidiary to SPLP.
-
SPINIT is subsidiary to SPLP.
-
SPLP solves linear programming problems involving at most a few thousand ...
-
SPLPCE is subsidiary to SPLP.
-
SPLPDM is subsidiary to SPLP.
-
SPLPFE is subsidiary to SPLP.
-
SPLPFL is subsidiary to SPLP.
-
SPLPMN is subsidiary to SPLP.
-
SPLPMU is subsidiary to SPLP.
-
SPLPUP is subsidiary to SPLP.
-
SPOCO factors a real symmetric positive definite matrix ...
-
SPODI computes the determinant and inverse of a certain real symmetric ...
-
SPOFA factors a real symmetric positive definite matrix.
-
SPOFS solves a positive definite symmetric system of linear equations.
-
SPOIR solves a positive definite symmetric system of linear equations.
-
SPOPT is subsidiary to SPLP.
-
SPOSL solves the real symmetric positive definite linear system ...
-
SPPCO factors a symmetric positive definite matrix stored in packed form ...
-
SPPDI computes the determinant and inverse of a real symmetric ...
-
SPPERM rearranges a given array according to a prescribed permutation vector.
-
SPPFA factors a real symmetric positive definite matrix in packed form.
-
SPPSL solves the real symmetric positive definite system using factors ...
-
SPSORT returns the permutation vector generated by sorting a given array ...
-
SPTSL solves a positive definite tridiagonal linear system.
-
SQRDC computes the QR factorization of an N by P matrix.
-
SQRSL applies the output of SQRDC to compute coordinate transformations, ...
-
SREADP reads a record for a file for SPLP.
-
SRLCAL is an internal routine for SGMRES.
-
SROT applies a plane Givens rotation.
-
SROTG constructs a plane Givens rotation.
-
SROTM applies a modified Givens transformation.
-
SROTMG constructs a modified Givens transformation.
-
SS2LT is the Lower Triangle Preconditioner SLAP Set Up.
-
SS2Y is the SLAP Triad to SLAP Column Format Converter.
-
SSBMV multiplies a real vector by a real symmetric band matrix.
-
SSCAL multiplies a vector by a constant.
-
SSD2S is the Diagonal Scaling Preconditioner SLAP Normal Eqns Set Up.
-
SSDBCG is the Diagonally Scaled BiConjugate Gradient Sparse Ax=b Solver.
-
SSDCG is the Diagonally Scaled Conjugate Gradient Sparse Ax=b Solver.
-
SSDCGN is the Diagonally Scaled CG Sparse Ax=b Solver for Normal Eqn's.
-
SSDCGS is the Diagonally Scaled CGS Sparse Ax=b Solver.
-
SSDGMR is the Diagonally Scaled GMRES Iterative Sparse Ax=b Solver.
-
SSDI is the Diagonal Matrix Vector Multiply.
-
SSDOMN is the Diagonally Scaled Orthomin Sparse Iterative Ax=b Solver.
-
SSDS is the Diagonal Scaling Preconditioner SLAP Set Up.
-
SSDSCL is the Diagonal Scaling of system Ax = b.
-
SSGS is the Gauss-Seidel Method Iterative Sparse Ax = b Solver.
-
SSICCG is the Incomplete Cholesky Conjugate Gradient Sparse Ax=b Solver.
-
SSICO factors a symmetric matrix by elimination with symmetric pivoting ...
-
SSICS is the Incomplete Cholesky Decomposition Preconditioner SLAP Set Up.
-
SSIDI computes the determinant, inertia and inverse of a real symmetric ...
-
SSIEV computes the eigenvalues and eigenvectors of a real symmetric matrix.
-
SSIFA factors a real symmetric matrix by elimination with symmetric pivoting.
-
SSILUR is the Incomplete LU Iterative Refinement Sparse Ax = b Solver.
-
SSILUS is the Incomplete LU Decomposition Preconditioner SLAP Set Up.
-
SSISL solves a real symmetric system using the factors obtained from SSIFA.
-
SSJAC is a Jacobi's Method Iterative Sparse Ax = b Solver.
-
SSLI is the SLAP MSOLVE for Lower Triangle Matrix.
-
SSLI2 is the SLAP Lower Triangle Matrix Backsolve.
-
SSLLTI is the SLAP MSOLVE for LDL' (IC) Factorization.
-
SSLUBC is the Incomplete LU BiConjugate Gradient Sparse Ax=b Solver.
-
SSLUCN is the Incomplete LU CG Sparse Ax=b Solver for Normal Equations.
-
SSLUCS is the Incomplete LU BiConjugate Gradient Squared Ax=b Solver.
-
SSLUGM is the Incomplete LU GMRES Iterative Sparse Ax=b Solver.
-
SSLUI is the SLAP MSOLVE for LDU Factorization.
-
SSLUI2 is the SLAP Backsolve for LDU Factorization.
-
SSLUI4 is the SLAP Backsolve for LDU Factorization.
-
SSLUOM is the Incomplete LU Orthomin Sparse Iterative Ax=b Solver.
-
SSLUTI is the SLAP MTSOLV for LDU Factorization.
-
SSMMI2 is the SLAP Backsolve for LDU Factorization of Normal Equations.
-
SSMMTI is the SLAP MSOLVE for LDU Factorization of Normal Equations.
-
SSMTV is the SLAP Column Format Sparse Matrix Transpose Vector Product.
-
SSMV is the SLAP Column Format Sparse Matrix Vector Product.
-
SSORT sorts an array and optionally make the same interchanges in ...
-
SSPCO factors a real symmetric matrix stored in packed form ...
-
SSPDI computes the determinant, inertia, inverse of a real symmetric ...
-
SSPEV computes eigenvalues and eigenvectors of a real symmetric matrix ...
-
SSPFA factors a real symmetric matrix stored in packed form by ...
-
SSPMV performs the matrix-vector operation y = alpha*A*x + beta*y.
-
SSPR performs the symmetric rank 1 operation A = A + alpha*x*x'.
-
SSPR2 performs the symmetric rank 2 operation A = A + alpha*(x*y'+y*x')
-
SSPSL solves a real symmetric system using the factors obtained from SSPFA.
-
SSVDC performs the singular value decomposition of a rectangular matrix.
-
SSWAP interchanges two vectors.
-
SSYMM multiplies a real general matrix by a real symmetric matrix.
-
SSYMV multiplies a real vector by a real symmetric matrix.
-
SSYR performs symmetric rank 1 update of a real symmetric matrix.
-
SSYR2 performs symmetric rank 2 update of a real symmetric matrix.
-
SSYR2K performs symmetric rank 2k update of a real symmetric matrix
-
SSYRK performs symmetric rank k update of a real symmetric matrix.
-
STBMV multiplies a real vector by a real triangular band matrix.
-
STBSV solves a real triangular banded system of linear equations.
-
STEPS integrates a system of ordinary differential equations one step.
-
STIN reads in SLAP Triad Format Linear System.
-
STOD integrates a system of first order ODE's over one step for DEBDF.
-
STOR1 is subsidiary to BVSUP.
-
STOUT writes out SLAP Triad Format Linear System.
-
STPMV performs x = A*x or x = A'*x for triangular A.
-
STPSV solves a triangular system of linear equations.
-
STRCO estimates the condition number of a triangular matrix.
-
STRDI computes the determinant and inverse of a triangular matrix.
-
STRMM multiplies a real general matrix by a real triangular matrix.
-
STRMV multiplies a real vector by a real triangular matrix.
-
STRSL solves a triangular system of linear equations.]
-
STRSM solves a triangular system of linear equations with multiple RHS.
-
STRSV solves a real triangular system of linear equations.
-
STWAY stores or recalls integration data for a restart of BVSUP.
-
SUDS solves an undetermined linear system for BVSUP.
-
SVCO transfers data from a common block to arrays for DEBDF.
-
SVD performs the singular value decomposition of a rectangular matrix.
-
SVECS is subsidiary to BVSUP.
-
SVOUT prints out a single precision array.
-
SWRITP writes a record out to a file for SPLP.
-
SXLCAL is an internal routine for SGMRES.
-
TEVLC finds eigenvalues of a symmetric tridiagonal matrix by rational QL.
-
TEVLS finds eigenvalues of a symmetric tridiagonal matrix by rational QL.
-
TIMESTAMP prints the current YMDHMS date as a time stamp.
-
TINVIT computes eigenvectors of symmetric tridiagonal matrix ...
-
TQL1 computes eigenvalues of symmetric tridiagonal matrix by the QL method.
-
TQL2 computes eigenvalues and eigenvectors of symmetric tridiagonal matrix.
-
TQLRAT computes the eigenvalues of symmetric tridiagonal matrix ...
-
TRBAK1 forms the eigenvectors of real symmetric matrix ...
-
TRBAK3 forms the eigenvectors of a real symmetric matrix from the ...
-
TRED1 reduces a real symmetric matrix to symmetric tridiagonal ...
-
TRED2 reduces a real symmetric matrix to a symmetric tridiagonal ...
-
TRED3 reduces a real symmetric matrix stored in packed form to
-
TRI3 solves three tridiagonal systems for GENBUN.
-
TRIDIB computes the eigenvalues of a symmetric tridiagonal matrix ...
-
TRIDQ is subsidiary to POIS3D.
-
TRIS4 is subsidiary to SEPX4.
-
TRISP is subsidiary to SEPELI.
-
TRIX is subsidiary to GENBUN.
-
TSTURM finds those eigenvalues of a symmetric tridiagonal matrix ...
-
U11LS is subsidiary to LLSIA.
-
U11US is subsidiary to ULSIA.
-
U12LS is subsidiary to LLSIA.
-
U12US is subsidiary to ULSIA.
-
ULSIA solves an underdetermined linear system of equations ...
-
USRMAT is subsidiary to SPLP.
-
VNWRMS is subsidiary to DEBDF.
-
WNLIT is subsidiary to WNNLS.
-
WNLSM is subsidiary to WNNLS
-
WNLT1 is subsidiary to WNLIT.
-
WNLT2 is subsidiary to WNLIT.
-
WNLT3 is subsidiary to WNLIT.
-
WNNLS solves a linearly constrained least squares problem with ...
-
XADD provides single-precision floating-point arithmetic ...
-
XADJ transforms X*RADIX**IX so RADIX**(-L) <= ABS(X) < RADIX(L).
-
XC210 determines J and Z so that RADIX**K = Z * 10**J.
-
XCON converts (X,IX) = X * RADIX**IX to decimal form.
-
XERBLA is the error handler for the Level 2 and Level 3 BLAS Routines.
-
XERCLR resets the XERROR current error number to zero.
-
XERCNT allows user control over handling of XERROR errors.
-
XERDMP prints the XERROR error tables and then clears them.
-
XERHLT aborts program execution after printing XERROR error message.
-
XERMAX sets maximum number of times any XERROR message is to be printed.
-
XERMSG processes XERROR messages.
-
XERPRN prints XERROR error messages processed by XERMSG.
-
XERSVE records that an XERROR error has occurred.
-
XGETF returns the current value of the XERROR error control flag.
-
XGETUA returns unit numbers to which XERROR messages are sent.
-
XGETUN returns the (first) output file to which XERROR messages are sent.
-
XLEGF computes normalized Legendre polynomials and associated ...
-
XNRMP computes normalized Legendre polynomials.
-
XPMU computes the values of Legendre functions for XLEGF.
-
XPMUP computes the values of Legendre functions for XLEGF.
-
XPNRM computes the values of Legendre functions for XLEGF.
-
XPQNU computes the values of Legendre functions for XLEGF.
-
XPSI computes values of the Psi function for XLEGF.
-
XQMU computes the values of Legendre functions for XLEGF.
-
XQNU computes the values of Legendre functions for XLEGF.
-
XRED transforms X*RADIX**IX so that IX = 0.
-
XSET sets up extended exponent range arithmetic.
-
XSETF sets the XERROR control flag.
-
XSETUA sets logical unit numbers to which error messages are to be sent.
-
XSETUN sets output file to which XERROR messages are to be sent.
-
YAIRY is subsidiary to BESJ and BESY
-
ZABS is subsidiary to ZBESH, ZBESI, ZBESJ, ZBESK, ZBESY, ZAIRY and ZBIRY.
-
ZACAI is subsidiary to ZAIRY
-
ZACON is subsidiary to ZBESH and ZBESK
-
ZAIRY computes the Airy function Ai(z) or its derivative dAi/dz ...
-
ZASYI is subsidiary to ZBESI and ZBESK.
-
ZBESH computes a sequence of the Hankel functions H(m,a,z) ...
-
ZBESI computes a sequence of the Bessel functions I(a,z) for ...
-
ZBESJ computes a sequence of the Bessel functions J(a,z) for ...
-
ZBESK computes a sequence of the Bessel functions K(a,z) for ...
-
ZBESY computes a sequence of the Bessel functions Y(a,z) for ...
-
ZBINU is subsidiary to ZAIRY, ZBESH, ZBESI, ZBESJ, ZBESK and ZBIRY.
-
ZBIRY computes the Airy function Bi(z) or its derivative dBi/dz ...
-
ZBKNU is subsidiary to ZAIRY, ZBESH, ZBESI and ZBESK.
-
ZBUNI is subsidiary to ZBESI and ZBESK.
-
ZBUNK is subsidiary to ZBESH and ZBESK.
-
ZDIV is subsidiary to ZBESH, ZBESI, ZBESJ, ZBESK, ZBESY, ZAIRY and ZBIRY.
-
ZEXP is subsidiary to ZBESH, ZBESI, ZBESJ, ZBESK, ZBESY, ZAIRY and ZBIRY.
-
ZKSCL is subsidiary to ZBESK.
-
ZLOG is subsidiary to ZBESH, ZBESI, ZBESJ, ZBESK, ZBESY, ZAIRY and ZBIRY.
-
ZMLRI is subsidiary to ZBESI and ZBESK.
-
ZMLT is subsidiary to ZBESH, ZBESI, ZBESJ, ZBESK, ZBESY, ZAIRY and ZBIRY.
-
ZRATI is subsidiary to ZBESH, ZBESI and ZBESK.
-
ZS1S2 is subsidiary to ZAIRY and ZBESK.
-
ZSERI is subsidiary to ZBESI and ZBESK.
-
ZSHCH is subsidiary to ZBESH and ZBESK.
-
ZSQRT is subsidiary to ZBESH, ZBESI, ZBESJ, ZBESK, ZBESY, ZAIRY and ZBIRY.
-
ZUCHK is subsidiary to SERI, ZUOIK, ZUNK1, ZUNK2, ZUNI1, ZUNI2 and ZKSCL.
-
ZUNHJ is subsidiary to ZBESI and ZBESK.
-
ZUNI1 is subsidiary to ZBESI and ZBESK.
-
ZUNI2 is subsidiary to ZBESI and ZBESK.
-
ZUNIK is subsidiary to ZBESI and ZBESK.
-
ZUNK1 is subsidiary to ZBESK.
-
ZUNK2 is subsidiary to ZBESK.
-
ZUOIK is subsidiary to ZBESH, ZBESI and ZBESK.
-
ZWRSK is subsidiary to ZBESI and ZBESK.
You can go up one level to
the FORTRAN90 source codes.
Last revised on 29 March 2007.