Procedure | Location | Procedure Type | Description |
---|---|---|---|
adjlr | adjlr.inc | Subroutine | This routine computes an adjustment, LDIF, to the required integer storage space in IWK (sparse matrix work space). |
adjlr | M_odepack | Subroutine | This routine computes an adjustment, LDIF, to the required integer storage space in IWK (sparse matrix work space). |
cdrv | cdrv.inc | Subroutine | cdrv(3f) - [M_odepack ] driver for solving sparse non-symmetric systems of linear equations |
cdrv | M_odepack | Subroutine | cdrv(3f) - [M_odepack ] driver for solving sparse non-symmetric systems of linear equations |
cntnzu | cntnzu.inc | Subroutine | This routine counts the number of nonzero elements in the strict upper triangle of the matrix M + M(transpose), where the sparsity structure of M is given by pointer arrays IA and JA. |
cntnzu | M_odepack | Subroutine | This routine counts the number of nonzero elements in the strict upper triangle of the matrix M + M(transpose), where the sparsity structure of M is given by pointer arrays IA and JA. |
daigbt | daigbt.inc | Subroutine | This subroutine computes the initial value of the vector YDOT satisfying |
daigbt | M_odepack | Subroutine | This subroutine computes the initial value of the vector YDOT satisfying |
dainvg | dainvg.inc | Subroutine | This subroutine computes the initial value of the vector YDOT satisfying |
dainvg | M_odepack | Subroutine | This subroutine computes the initial value of the vector YDOT satisfying |
dainvgs | dainvgs.inc | Subroutine | This subroutine computes the initial value of the vector YDOT satisfying |
dainvgs | M_odepack.f90 | Subroutine | This subroutine computes the initial value of the vector YDOT satisfying |
datp | datp.inc | Subroutine | This routine computes the product |
datv | datv.inc | Subroutine | This routine computes the product |
daxpy | daxpy.inc | Subroutine | daxpy(3f) - [M_odepack::matrix] Compute a constant times a vector plus a vector. |
daxpy | M_odepack | Subroutine | daxpy(3f) - [M_odepack::matrix] Compute a constant times a vector plus a vector. |
dbnorm | dbnorm.inc | Function | This function computes the norm of a banded N by N matrix, stored in the array A, that is consistent with the weighted max-norm on vectors, with weights stored in the array W. ML and MU are the lower and upper half-bandwidths of the matrix. NRA is the first dimension of the A array, NRA .ge. ML+MU+1. In terms of the matrix elements a(i,j), the norm is given by: |
dcfode | dcfode.inc | Subroutine | dcfode(3f) - [M_odepack] Set ODE integrator coefficients. |
dcfode | M_odepack | Subroutine | dcfode(3f) - [M_odepack] Set ODE integrator coefficients. |
dcopy | dcopy.inc | Subroutine | dcopy(3f) - [M_odepack::matrix] copy a vector |
dcopy | M_odepack | Subroutine | dcopy(3f) - [M_odepack::matrix] copy a vector |
ddecbt | ddecbt.inc | Subroutine | ddecbt(3f) -[M_odepack] Block-tridiagonal matrix decomposition routine. |
ddot | ddot.inc | Function | ddot(3f) - [M_odepack::matrix] Compute the inner product of two vectors. |
dewset | dewset.inc | Subroutine | dewset(3f) - [M_odepack] Set error weight vector. |
dewset | M_odepack | Subroutine | dewset(3f) - [M_odepack] Set error weight vector. |
dfnorm | dfnorm.inc | Function | This function computes the norm of a full N by N matrix, stored in the array A, that is consistent with the weighted max-norm on vectors, with weights stored in the array W: |
dgbfa | dgbfa.inc | Subroutine | dgbfa(3f) - [M_odepack::matrix] Factor a band matrix using Gaussian elimination. |
dgbsl | dgbsl.inc | Subroutine | dgbsl(3f) - [M_odepack::Matrix] Solve the real band system AX=B or TRANS(A)X=B using the factors computed by DGBCO(3f) or DGBFA(). |
dgefa | dgefa.inc | Subroutine | dgefa(3f) - [M_odepack::matrix] Factor a matrix using Gaussian elimination. |
dgefa | M_odepack | Subroutine | dgefa(3f) - [M_odepack::matrix] Factor a matrix using Gaussian elimination. |
dgesl | dgesl.inc | Subroutine | dgesl(3f) - [M_odepack::matrix] Solve the real system AX=B or TRANS(A)X=B using the factors computed by DGECO or DGEFA. |
dgesl | M_odepack | Subroutine | dgesl(3f) - [M_odepack::matrix] Solve the real system AX=B or TRANS(A)X=B using the factors computed by DGECO or DGEFA. |
dhefa | dhefa.inc | Subroutine | This routine is a modification of the LINPACK routine DGEFA and performs an LU decomposition of an upper Hessenberg matrix A. There are two options available: |
dhels | dhels.inc | Subroutine | This is part of the LINPACK routine DGESL with changes due to the fact that A is an upper Hessenberg matrix. |
dheqr | dheqr.inc | Subroutine | This routine performs a QR decomposition of an upper Hessenberg matrix A. There are two options available: |
dhesl | dhesl.inc | Subroutine | This is essentially the LINPACK routine DGESL except for changes due to the fact that A is an upper Hessenberg matrix. |
dintdy | dintdy.inc | Subroutine | DINTDY computes interpolated values of the K-th derivative of the dependent variable vector y, and stores it in DKY. This routine is called within the package with K = 0 and T = TOUT, but may also be called by the user for any K up to the current order. (See detailed instructions in the usage documentation.) |
dintdy | M_odepack | Subroutine | DINTDY computes interpolated values of the K-th derivative of the dependent variable vector y, and stores it in DKY. This routine is called within the package with K = 0 and T = TOUT, but may also be called by the user for any K up to the current order. (See detailed instructions in the usage documentation.) |
diprep | diprep.inc | Subroutine | This routine serves as an interface between the driver and Subroutine DPREP. It is called only if MITER is 1 or 2. Tasks performed here are: |
diprep | M_odepack | Subroutine | This routine serves as an interface between the driver and Subroutine DPREP. It is called only if MITER is 1 or 2. Tasks performed here are: |
diprepi | diprepi.inc | Subroutine | This routine serves as an interface between the driver and Subroutine DPREPI. Tasks performed here are: |
diprepi | M_odepack | Subroutine | This routine serves as an interface between the driver and Subroutine DPREPI. Tasks performed here are: |
dlhin | dlhin.inc | Subroutine | dlhin(3f) - [M_odepack] compute step size H0 to be attempted on the first step, when the user supplied value is absent |
dlhin | M_odepack | Subroutine | dlhin(3f) - [M_odepack] compute step size H0 to be attempted on the first step, when the user supplied value is absent |
dlsoda | dlsoda.inc | Subroutine | DLSODA solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form |
dlsoda | M_odepack | Subroutine | DLSODA solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form |
dlsodar | dlsodar.inc | Subroutine | DLSODAR solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form |
dlsodar | M_odepack | Subroutine | DLSODAR solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form |
dlsode | dlsode.inc | Subroutine | DLSODE solves the initial-value problem for stiff or nonstiff systems of first-order ODE’s, |
dlsode | M_odepack | Subroutine | DLSODE solves the initial-value problem for stiff or nonstiff systems of first-order ODE’s, |
dlsodes | dlsodes.inc | Subroutine | DLSODES solves the initial value problem for stiff or nonstiff systems of first order ODEs, |
dlsodes | M_odepack | Subroutine | DLSODES solves the initial value problem for stiff or nonstiff systems of first order ODEs, |
dlsodi | dlsodi.inc | Subroutine | DLSODI solves the initial value problem for linearly implicit systems of first order ODEs, |
dlsodi | M_odepack | Subroutine | DLSODI solves the initial value problem for linearly implicit systems of first order ODEs, |
dlsodis | dlsodis.inc | Subroutine | DLSODIS solves the initial value problem for linearly implicit systems of first order ODEs, |
dlsodis | M_odepack | Subroutine | DLSODIS solves the initial value problem for linearly implicit systems of first order ODEs, |
dlsodkr | dlsodkr.inc | Subroutine | DLSODKR: Livermore Solver for Ordinary Differential equations, with preconditioned Krylov iteration methods for the Newton correction linear systems, and with Rootfinding. |
dlsodkr | M_odepack | Subroutine | DLSODKR: Livermore Solver for Ordinary Differential equations, with preconditioned Krylov iteration methods for the Newton correction linear systems, and with Rootfinding. |
dlsodpk | dlsodpk.inc | Subroutine | DLSODPK: Livermore Solver for Ordinary Differential equations, with Preconditioned Krylov iteration methods for the Newton correction linear systems. |
dlsodpk | M_odepack | Subroutine | DLSODPK: Livermore Solver for Ordinary Differential equations, with Preconditioned Krylov iteration methods for the Newton correction linear systems. |
dlsoibt | dlsoibt.inc | Subroutine | DLSOIBT: Livermore Solver for Ordinary differential equations given in Implicit form, with Block-Tridiagonal Jacobian treatment. |
dlsoibt | M_odepack | Subroutine | DLSOIBT: Livermore Solver for Ordinary differential equations given in Implicit form, with Block-Tridiagonal Jacobian treatment. |
dmnorm | dmnorm.inc | Function | This function routine computes the weighted max-norm of the vector of length N contained in the array V, with weights contained in the array w of length N: DMNORM = MAX(i=1,…,N) ABS(V(i))*W(i) |
dmnorm | M_odepack | Function | This function routine computes the weighted max-norm of the vector of length N contained in the array V, with weights contained in the array w of length N: DMNORM = MAX(i=1,…,N) ABS(V(i))*W(i) |
DNRM2 | dnrm2.inc | Function | dnrm2(3f) - [M_odepack::matrix] Compute the Euclidean length (L2 norm) of a vector. |
dorthog | dorthog.inc | Subroutine | This routine orthogonalizes the vector VNEW against the previous KMP vectors in the V array. It uses a modified Gram-Schmidt orthogonalization procedure with conditional reorthogonalization. This is the version of 28 may 1986. |
dpcg | dpcg.inc | Subroutine | This routine computes the solution to the system A*x = b using a preconditioned version of the Conjugate Gradient algorithm. It is assumed here that the matrix A and the preconditioner matrix M are symmetric positive definite or nearly so. |
dpcgs | dpcgs.inc | Subroutine | This routine computes the solution to the system A*x = b using a scaled preconditioned version of the Conjugate Gradient algorithm. |
dpjibt | dpjibt.inc | Subroutine | DPJIBT is called by DSTODI to compute and process the matrix P = A - HEL(1)J, where J is an approximation to the Jacobian dr/dy, and r = g(t,y) - A(t,y)*s. |
dpjibt | M_odepack | Subroutine | DPJIBT is called by DSTODI to compute and process the matrix P = A - HEL(1)J, where J is an approximation to the Jacobian dr/dy, and r = g(t,y) - A(t,y)*s. |
dpkset | dpkset.inc | Subroutine | DPKSET is called by DSTODPK to interface with the user-supplied routine JAC, to compute and process relevant parts of the matrix P = I - HEL(1)J, where J is the Jacobian df/dy, as need for preconditioning matrix operations later. |
dprep | M_odepack.f90 | Subroutine | This routine performs preprocessing related to the sparse linear systems that must be solved if MITER = 1 or 2. |
dprep | dprep.inc | Subroutine | This routine performs preprocessing related to the sparse linear systems that must be solved if MITER = 1 or 2. |
dprepi | M_odepack.f90 | Subroutine | This routine performs preprocessing related to the sparse linear systems that must be solved. |
dprepi | dprepi.inc | Subroutine | This routine performs preprocessing related to the sparse linear systems that must be solved. |
dprepj | dprepj.inc | Subroutine | DPREPJ is called by DSTODE to compute and process the matrix P = I - hel(1)J , where J is an approximation to the Jacobian. |
dprepj | M_odepack | Subroutine | DPREPJ is called by DSTODE to compute and process the matrix P = I - hel(1)J , where J is an approximation to the Jacobian. |
dprepji | dprepji.inc | Subroutine | DPREPJI is called by DSTODI to compute and process the matrix P = A - HEL(1)J, where J is an approximation to the Jacobian dr/dy, where r = g(t,y) - A(t,y)*s. |
dprepji | M_odepack | Subroutine | DPREPJI is called by DSTODI to compute and process the matrix P = A - HEL(1)J, where J is an approximation to the Jacobian dr/dy, where r = g(t,y) - A(t,y)*s. |
dprja | dprja.inc | Subroutine | DPRJA is called by DSTODA to compute and process the matrix P = I - HEL(1)J, where J is an approximation to the Jacobian. |
dprja | M_odepack | Subroutine | DPRJA is called by DSTODA to compute and process the matrix P = I - HEL(1)J, where J is an approximation to the Jacobian. |
dprjis | dprjis.inc | Subroutine | DPRJIS is called to compute and process the matrix P = A - HEL(1)J, where J is an approximation to the Jacobian dr/dy, where r = g(t,y) - A(t,y)*s. |
dprjis | M_odepack | Subroutine | DPRJIS is called to compute and process the matrix P = A - HEL(1)J, where J is an approximation to the Jacobian dr/dy, where r = g(t,y) - A(t,y)*s. |
dprjs | dprjs.inc | Subroutine | DPRJS is called to compute and process the matrix P = I - HEL(1)J, where J is an approximation to the Jacobian. J is computed by columns, either by the user-supplied routine JAC if MITER = 1, or by finite differencing if MITER = 2. |
dprjs | M_odepack | Subroutine | DPRJS is called to compute and process the matrix P = I - HEL(1)J, where J is an approximation to the Jacobian. J is computed by columns, either by the user-supplied routine JAC if MITER = 1, or by finite differencing if MITER = 2. |
drchek | drchek.inc | Subroutine | This routine checks for the presence of a root in the vicinity of the current T, in a manner depending on the input flag JOB. It calls Subroutine DROOTS to locate the root as precisely as possible. |
drchek | M_odepack | Subroutine | This routine checks for the presence of a root in the vicinity of the current T, in a manner depending on the input flag JOB. It calls Subroutine DROOTS to locate the root as precisely as possible. |
droots | droots.inc | Subroutine | This subroutine finds the leftmost root of a set of arbitrary functions gi(x) (i = 1,…,NG) in an interval (X0,X1). Only roots of odd multiplicity (i.e. changes of sign of the gi) are found. Here the sign of X1 - X0 is arbitrary, but is constant for a given problem, and -leftmost- means nearest to X0. The values of the vector-valued function g(x) = (gi, i=1…NG) are communicated through the call sequence of DROOTS. The method used is the Illinois algorithm. |
dscal | dscal.inc | Subroutine | dscal(3f) - [M_odepack::matrix] Multiply a vector by a constant. |
dscal | M_odepack | Subroutine | dscal(3f) - [M_odepack::matrix] Multiply a vector by a constant. |
dsetpk | dsetpk.inc | Subroutine | DSETPK is called by DSTOKA to interface with the user-supplied routine JAC, to compute and process relevant parts of the matrix P = I - HEL(1)J, where J is the Jacobian df/dy, as need for preconditioning matrix operations later. |
dslsbt | dslsbt.inc | Subroutine | This routine acts as an interface between the core integrator routine and the DSOLBT routine for the solution of the linear system arising from chord iteration. Communication with DSLSBT uses the following variables: |
dslsbt | M_odepack | Subroutine | This routine acts as an interface between the core integrator routine and the DSOLBT routine for the solution of the linear system arising from chord iteration. Communication with DSLSBT uses the following variables: |
dsolbt | dsolbt.inc | Subroutine | Solution of block-tridiagonal linear system. Coefficient matrix must have been previously processed by DDECBT. M, N, A,B,C, and IP must not have been changed since call to DDECBT. Written by A. C. Hindmarsh. |
dsolpk | dsolpk.inc | Subroutine | This routine interfaces to one of DSPIOM, DSPIGMR, DPCG, DPCGS, or DUSOL, for the solution of the linear system arising from a Newton iteration. It is called if MITER .ne. 0. In addition to variables described elsewhere, communication with DSOLPK uses the following variables: |
dsolss | dsolss.inc | Subroutine | This routine manages the solution of the linear system arising from a chord iteration. It is called if MITER .ne. 0. |
dsolss | M_odepack | Subroutine | This routine manages the solution of the linear system arising from a chord iteration. It is called if MITER .ne. 0. |
dsolsy | dsolsy.inc | Subroutine | This routine manages the solution of the linear system arising from a chord iteration. It is called if MITER .ne. 0. |
dsolsy | M_odepack | Subroutine | This routine manages the solution of the linear system arising from a chord iteration. It is called if MITER .ne. 0. |
dspigmr | dspigmr.inc | Subroutine | This routine solves the linear system A * x = b using a scaled preconditioned version of the Generalized Minimal Residual method. An initial guess of x = 0 is assumed. |
dspiom | dspiom.inc | Subroutine | This routine solves the linear system A * x = b using a scaled preconditioned version of the Incomplete Orthogonalization Method. An initial guess of x = 0 is assumed. |
dsrcar | dsrcar.inc | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, type(dlsa01)::DLSA, DLSR01, which are used internally by one or more ODEPACK solvers. |
dsrcar | M_odepack | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, type(dlsa01)::DLSA, DLSR01, which are used internally by one or more ODEPACK solvers. |
dsrckr | dsrckr.inc | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, DLSR01, DLPK01, which are used internally by the DLSODKR solver. |
dsrckr | M_odepack | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, DLSR01, DLPK01, which are used internally by the DLSODKR solver. |
dsrcma | dsrcma.inc | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, type(DLSA01)::DLSA, which are used internally by one or more ODEPACK solvers. |
dsrcma | M_odepack | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, type(DLSA01)::DLSA, which are used internally by one or more ODEPACK solvers. |
dsrcms | dsrcms.inc | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, DLSS01, which are used internally by one or more ODEPACK solvers. |
dsrcms | M_odepack | Subroutine | This routine saves or restores (depending on JOB) the contents of the Common blocks DLS001, DLSS01, which are used internally by one or more ODEPACK solvers. |
dsrcom | dsrcom.inc | Subroutine | dsrcom(3f) - [M_odepack] Save/restore ODEPACK COMMON blocks. |
dsrcom | M_odepack | Subroutine | dsrcom(3f) - [M_odepack] Save/restore ODEPACK COMMON blocks. |
dsrcpk | dsrcpk.inc | Subroutine | This routine saves or restores (depending on JOB) the contents of the internal types used internally by the DLSODPK solver. |
dsrcpk | M_odepack | Subroutine | This routine saves or restores (depending on JOB) the contents of the internal types used internally by the DLSODPK solver. |
dstoda | dstoda.inc | Subroutine | DSTODA performs one step of the integration of an initial value problem for a system of ordinary differential equations. |
dstoda | M_odepack | Subroutine | DSTODA performs one step of the integration of an initial value problem for a system of ordinary differential equations. |
dstode | dstode.inc | Subroutine | dstode(3f) - [M_odepack] Performs one step of an ODEPACK integration. |
dstode | M_odepack.f90 | Subroutine | dstode(3f) - [M_odepack] Performs one step of an ODEPACK integration. |
dstodi | dstodi.inc | Subroutine | DSTODI performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations. |
dstodi | M_odepack.f90 | Subroutine | DSTODI performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations. |
dstodpk | dstodpk.inc | Subroutine | DSTODPK performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations. |
dstodpk | M_odepack | Subroutine | DSTODPK performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations. |
dstoka | dstoka.inc | Subroutine | DSTOKA performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations. |
dstoka | M_odepack | Subroutine | DSTOKA performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations. |
dusol | dusol.inc | Subroutine | This routine solves the linear system A * x = b using only a call to the user-supplied routine PSOL (no Krylov iteration). If the norm of the right-hand side vector b is smaller than DELTA, the vector X returned is X = b (if MNEWT = 0) or X = 0 otherwise. PSOL is called with an LR argument of 0. |
dvnorm | dvnorm.inc | Function | dvnorm(3f) - [M_odepack] Weighted root-mean-square vector norm. |
dvnorm | M_odepack | Function | dvnorm(3f) - [M_odepack] Weighted root-mean-square vector norm. |
idamax | idamax.inc | Function | idamax(3f) - [M_odepack::matrix] Find the smallest index of that component of a vector having the maximum magnitude. |
ixsav | ixsav.inc | Function | ixsav(3f) - [M_odesave::matrix] Save and recall error message control parameters. |
jgroup | jgroup.inc | Subroutine | This subroutine constructs groupings of the column indices of the Jacobian matrix, used in the numerical evaluation of the Jacobian by finite differences. |
jgroup | M_odepack | Subroutine | This subroutine constructs groupings of the column indices of the Jacobian matrix, used in the numerical evaluation of the Jacobian by finite differences. |
md | md.inc | Subroutine | md – minimum degree algorithm (based on element model) |
mdi | mdi.inc | Subroutine | mdi – initialization |
mdm | mdm.inc | Subroutine | mdm – form element from uneliminated neighbors of vk |
mdp | mdp.inc | Subroutine | mdp – purge inactive elements and do mass elimination |
mdu | mdu.inc | Subroutine | mdu – update degrees of uneliminated vertices in ek |
nnfc | nnfc.inc | Subroutine | nnfc(3f) - [M_odepack] numerical LDU-factorization of sparse nonsymmetric matrix |
nnsc | nnsc.inc | Subroutine | |
nntc | nntc.inc | Subroutine | numeric solution of the transpose of a sparse nonsymmetric system of linear equations given lu-factorization (compressed pointer storage) |
nroc | nroc.inc | Subroutine | nia - p - at the kth step, p is a linked list of the reordered - column indices of the kth row of a. p(n+1) points - to the first entry in the list. - size = n+1. nia - jar - at the kth step,jar contains the elements of the - reordered column indices of a. - size = n. fia - ar - at the kth step, ar contains the elements of the - reordered row of a. - size = n. |
nsfc | nsfc.inc | Subroutine | |
odrv | odrv.inc | Subroutine | odrv(3f) [M_odepack] - driver for sparse matrix reordering routines |
odrv | M_odepack | Subroutine | odrv(3f) [M_odepack] - driver for sparse matrix reordering routines |
sro | sro.inc | Subroutine | sro – symmetric reordering of sparse symmetric matrix |
xerrwd | xerrwd.inc | Subroutine | xerrwd(3f) - [M_odepack::Matrix] Write error message with values. |
xerrwd | M_odepack | Subroutine | xerrwd(3f) - [M_odepack::Matrix] Write error message with values. |
xsetf | xsetf.inc | Subroutine | xsetf(3f) - [M_odepack::matrix] Reset the error print control flag. |
xsetf | M_odepack | Subroutine | xsetf(3f) - [M_odepack::matrix] Reset the error print control flag. |
xsetun | xsetun.inc | Subroutine | xsetun(3f) - [M_odepack::matrix] Reset the logical unit number for error messages. |
xsetun | M_odepack | Subroutine | xsetun(3f) - [M_odepack::matrix] Reset the logical unit number for error messages. |