Procedures

ProcedureLocationProcedure TypeDescription
adjlr adjlr.inc Subroutine

This routine computes an adjustment, LDIF, to the required integer storage space in IWK (sparse matrix work space).

Read more…
adjlr M_odepack Subroutine

This routine computes an adjustment, LDIF, to the required integer storage space in IWK (sparse matrix work space).

Read more…
cdrv cdrv.inc Subroutine

cdrv(3f) - [M_odepack ] driver for solving sparse non-symmetric systems of linear equations

Read more…
cdrv M_odepack Subroutine

cdrv(3f) - [M_odepack ] driver for solving sparse non-symmetric systems of linear equations

Read more…
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.

Read more…
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.

Read more…
daigbt daigbt.inc Subroutine

This subroutine computes the initial value of the vector YDOT satisfying

Read more…
daigbt M_odepack Subroutine

This subroutine computes the initial value of the vector YDOT satisfying

Read more…
dainvg dainvg.inc Subroutine

This subroutine computes the initial value of the vector YDOT satisfying

Read more…
dainvg M_odepack Subroutine

This subroutine computes the initial value of the vector YDOT satisfying

Read more…
dainvgs dainvgs.inc Subroutine

This subroutine computes the initial value of the vector YDOT satisfying

Read more…
dainvgs M_odepack.f90 Subroutine

This subroutine computes the initial value of the vector YDOT satisfying

Read more…
datp datp.inc Subroutine

This routine computes the product

Read more…
datv datv.inc Subroutine

This routine computes the product

Read more…
daxpy daxpy.inc Subroutine

daxpy(3f) - [M_odepack::matrix] Compute a constant times a vector plus a vector.

Read more…
daxpy M_odepack Subroutine

daxpy(3f) - [M_odepack::matrix] Compute a constant times a vector plus a vector.

Read more…
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:

Read more…
dcfode dcfode.inc Subroutine

dcfode(3f) - [M_odepack] Set ODE integrator coefficients.

Read more…
dcfode M_odepack Subroutine

dcfode(3f) - [M_odepack] Set ODE integrator coefficients.

Read more…
dcopy dcopy.inc Subroutine

dcopy(3f) - [M_odepack::matrix] copy a vector

Read more…
dcopy M_odepack Subroutine

dcopy(3f) - [M_odepack::matrix] copy a vector

Read more…
ddecbt ddecbt.inc Subroutine

ddecbt(3f) -[M_odepack] Block-tridiagonal matrix decomposition routine.

Read more…
ddot ddot.inc Function

ddot(3f) - [M_odepack::matrix] Compute the inner product of two vectors.

Read more…
dewset dewset.inc Subroutine

dewset(3f) - [M_odepack] Set error weight vector.

Read more…
dewset M_odepack Subroutine

dewset(3f) - [M_odepack] Set error weight vector.

Read more…
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:

Read more…
dgbfa dgbfa.inc Subroutine

dgbfa(3f) - [M_odepack::matrix] Factor a band matrix using Gaussian elimination.

Read more…
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().

Read more…
dgefa dgefa.inc Subroutine

dgefa(3f) - [M_odepack::matrix] Factor a matrix using Gaussian elimination.

Read more…
dgefa M_odepack Subroutine

dgefa(3f) - [M_odepack::matrix] Factor a matrix using Gaussian elimination.

Read more…
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.

Read more…
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.

Read more…
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:

Read more…
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.

Read more…
dheqr dheqr.inc Subroutine

This routine performs a QR decomposition of an upper Hessenberg matrix A. There are two options available:

Read more…
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.

Read more…
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.)

Read more…
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.)

Read more…
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:

Read more…
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:

Read more…
diprepi diprepi.inc Subroutine

This routine serves as an interface between the driver and Subroutine DPREPI. Tasks performed here are:

Read more…
diprepi M_odepack Subroutine

This routine serves as an interface between the driver and Subroutine DPREPI. Tasks performed here are:

Read more…
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

Read more…
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

Read more…
dlsoda dlsoda.inc Subroutine

DLSODA solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form

Read more…
dlsoda M_odepack Subroutine

DLSODA solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form

Read more…
dlsodar dlsodar.inc Subroutine

DLSODAR solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form

Read more…
dlsodar M_odepack Subroutine

DLSODAR solves the initial value problem for stiff or nonstiff systems of first order ODEs of the form

Read more…
dlsode dlsode.inc Subroutine

DLSODE solves the initial-value problem for stiff or nonstiff systems of first-order ODE’s,

Read more…
dlsode M_odepack Subroutine

DLSODE solves the initial-value problem for stiff or nonstiff systems of first-order ODE’s,

Read more…
dlsodes dlsodes.inc Subroutine

DLSODES solves the initial value problem for stiff or nonstiff systems of first order ODEs,

Read more…
dlsodes M_odepack Subroutine

DLSODES solves the initial value problem for stiff or nonstiff systems of first order ODEs,

Read more…
dlsodi dlsodi.inc Subroutine

DLSODI solves the initial value problem for linearly implicit systems of first order ODEs,

Read more…
dlsodi M_odepack Subroutine

DLSODI solves the initial value problem for linearly implicit systems of first order ODEs,

Read more…
dlsodis dlsodis.inc Subroutine

DLSODIS solves the initial value problem for linearly implicit systems of first order ODEs,

Read more…
dlsodis M_odepack Subroutine

DLSODIS solves the initial value problem for linearly implicit systems of first order ODEs,

Read more…
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.

Read more…
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.

Read more…
dlsodpk dlsodpk.inc Subroutine

DLSODPK: Livermore Solver for Ordinary Differential equations, with Preconditioned Krylov iteration methods for the Newton correction linear systems.

Read more…
dlsodpk M_odepack Subroutine

DLSODPK: Livermore Solver for Ordinary Differential equations, with Preconditioned Krylov iteration methods for the Newton correction linear systems.

Read more…
dlsoibt dlsoibt.inc Subroutine

DLSOIBT: Livermore Solver for Ordinary differential equations given in Implicit form, with Block-Tridiagonal Jacobian treatment.

Read more…
dlsoibt M_odepack Subroutine

DLSOIBT: Livermore Solver for Ordinary differential equations given in Implicit form, with Block-Tridiagonal Jacobian treatment.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
dprep M_odepack.f90 Subroutine

This routine performs preprocessing related to the sparse linear systems that must be solved if MITER = 1 or 2.

Read more…
dprep dprep.inc Subroutine

This routine performs preprocessing related to the sparse linear systems that must be solved if MITER = 1 or 2.

Read more…
dprepi M_odepack.f90 Subroutine

This routine performs preprocessing related to the sparse linear systems that must be solved.

Read more…
dprepi dprepi.inc Subroutine

This routine performs preprocessing related to the sparse linear systems that must be solved.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
dscal dscal.inc Subroutine

dscal(3f) - [M_odepack::matrix] Multiply a vector by a constant.

Read more…
dscal M_odepack Subroutine

dscal(3f) - [M_odepack::matrix] Multiply a vector by a constant.

Read more…
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.

Read more…
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:

Read more…
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:

Read more…
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.

Read more…
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:

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
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.

Read more…
dsrcom dsrcom.inc Subroutine

dsrcom(3f) - [M_odepack] Save/restore ODEPACK COMMON blocks.

Read more…
dsrcom M_odepack Subroutine

dsrcom(3f) - [M_odepack] Save/restore ODEPACK COMMON blocks.

Read more…
dsrcpk dsrcpk.inc Subroutine

This routine saves or restores (depending on JOB) the contents of the internal types used internally by the DLSODPK solver.

Read more…
dsrcpk M_odepack Subroutine

This routine saves or restores (depending on JOB) the contents of the internal types used internally by the DLSODPK solver.

Read more…
dstoda dstoda.inc Subroutine

DSTODA performs one step of the integration of an initial value problem for a system of ordinary differential equations.

Read more…
dstoda M_odepack Subroutine

DSTODA performs one step of the integration of an initial value problem for a system of ordinary differential equations.

Read more…
dstode dstode.inc Subroutine

dstode(3f) - [M_odepack] Performs one step of an ODEPACK integration.

Read more…
dstode M_odepack.f90 Subroutine

dstode(3f) - [M_odepack] Performs one step of an ODEPACK integration.

Read more…
dstodi dstodi.inc Subroutine

DSTODI performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations.

Read more…
dstodi M_odepack.f90 Subroutine

DSTODI performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations.

Read more…
dstodpk dstodpk.inc Subroutine

DSTODPK performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations.

Read more…
dstodpk M_odepack Subroutine

DSTODPK performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations.

Read more…
dstoka dstoka.inc Subroutine

DSTOKA performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations.

Read more…
dstoka M_odepack Subroutine

DSTOKA performs one step of the integration of an initial value problem for a system of Ordinary Differential Equations.

Read more…
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.

Read more…
dvnorm dvnorm.inc Function

dvnorm(3f) - [M_odepack] Weighted root-mean-square vector norm.

Read more…
dvnorm M_odepack Function

dvnorm(3f) - [M_odepack] Weighted root-mean-square vector norm.

Read more…
idamax idamax.inc Function

idamax(3f) - [M_odepack::matrix] Find the smallest index of that component of a vector having the maximum magnitude.

Read more…
ixsav ixsav.inc Function

ixsav(3f) - [M_odesave::matrix] Save and recall error message control parameters.

Read more…
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.

Read more…
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.

Read more…
md md.inc Subroutine

md – minimum degree algorithm (based on element model)

Read more…
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

Read more…
nnsc nnsc.inc Subroutine Read more…
nntc nntc.inc Subroutine

numeric solution of the transpose of a sparse nonsymmetric system of linear equations given lu-factorization (compressed pointer storage)

Read more…
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.

Read more…
nsfc nsfc.inc Subroutine Read more…
odrv odrv.inc Subroutine

odrv(3f) [M_odepack] - driver for sparse matrix reordering routines

Read more…
odrv M_odepack Subroutine

odrv(3f) [M_odepack] - driver for sparse matrix reordering routines

Read more…
sro sro.inc Subroutine

sro – symmetric reordering of sparse symmetric matrix

Read more…
xerrwd xerrwd.inc Subroutine

xerrwd(3f) - [M_odepack::Matrix] Write error message with values.

Read more…
xerrwd M_odepack Subroutine

xerrwd(3f) - [M_odepack::Matrix] Write error message with values.

Read more…
xsetf xsetf.inc Subroutine

xsetf(3f) - [M_odepack::matrix] Reset the error print control flag.

Read more…
xsetf M_odepack Subroutine

xsetf(3f) - [M_odepack::matrix] Reset the error print control flag.

Read more…
xsetun xsetun.inc Subroutine

xsetun(3f) - [M_odepack::matrix] Reset the logical unit number for error messages.

Read more…
xsetun M_odepack Subroutine

xsetun(3f) - [M_odepack::matrix] Reset the logical unit number for error messages.

Read more…
call~~graph~~CallGraph none~approximate dspiom::approximate daxpy daxpy none~approximate->daxpy dhesl dhesl none~approximate->dhesl none~approximate~2 dspigmr::approximate none~approximate~2->daxpy dhels dhels none~approximate~2->dhels none~wrapup dprepj::wrapup dgbfa dgbfa none~wrapup->dgbfa none~wrapup400 dprep::wrapup400 none~wrapup400~2 dprep::wrapup400 none~wrapup500 dprep::wrapup500 none~wrapup500~2 dprep::wrapup500 none~wrapup600 dprep::wrapup600 proc~cntnzu~2 M_odepack::cntnzu none~wrapup600->proc~cntnzu~2 none~wrapup600~2 dprep::wrapup600 none~wrapup600~2->proc~cntnzu~2 none~wrapup700 dprep::wrapup700 none~wrapup700~2 dprep::wrapup700 none~wrapup~2 dprjs::wrapup cdrv cdrv none~wrapup~2->cdrv none~wrapup~3 dprepji::wrapup none~wrapup~3->dgbfa none~wrapup~4 dprja::wrapup dbnorm dbnorm none~wrapup~4->dbnorm none~wrapup~4->dgbfa proc~adjlr adjlr.inc::adjlr proc~adjlr~2 M_odepack::adjlr proc~cdrv M_odepack::cdrv proc~cdrv~2 cdrv.inc::cdrv nnfc nnfc proc~cdrv~2->nnfc nnsc nnsc proc~cdrv~2->nnsc nntc nntc proc~cdrv~2->nntc nroc nroc proc~cdrv~2->nroc nsfc nsfc proc~cdrv~2->nsfc proc~cntnzu cntnzu.inc::cntnzu proc~daigbt daigbt.inc::daigbt ddecbt ddecbt proc~daigbt->ddecbt dsolbt dsolbt proc~daigbt->dsolbt proc~daigbt~2 M_odepack::daigbt proc~dgefa~2 M_odepack::dgefa proc~daigbt~2->proc~dgefa~2 proc~dgesl M_odepack::dgesl proc~daigbt~2->proc~dgesl proc~dainvg dainvg.inc::dainvg proc~dainvg->dgbfa dgbsl dgbsl proc~dainvg->dgbsl dgefa dgefa proc~dainvg->dgefa dgesl dgesl proc~dainvg->dgesl proc~dainvgs dainvgs.inc::dainvgs proc~dainvgs->proc~cdrv proc~dainvgs~2 M_odepack.f90::dainvgs proc~dainvgs~2->proc~cdrv proc~dainvg~2 M_odepack::dainvg proc~daxpy~2 M_odepack::daxpy proc~dainvg~2->proc~daxpy~2 proc~dainvg~2->proc~dgefa~2 proc~dainvg~2->proc~dgesl proc~dscal M_odepack::dscal proc~dainvg~2->proc~dscal proc~datp datp.inc::datp dvnorm dvnorm proc~datp->dvnorm proc~datv datv.inc::datv dnrm2 dnrm2 proc~datv->dnrm2 proc~daxpy daxpy.inc::daxpy proc~dbnorm dbnorm.inc::dbnorm proc~dcfode dcfode.inc::dcfode proc~dcfode~2 M_odepack::dcfode proc~dcopy dcopy.inc::dcopy proc~dcopy~2 M_odepack::dcopy proc~ddecbt~2 ddecbt.inc::ddecbt ddot ddot proc~ddecbt~2->ddot proc~ddecbt~2->dgefa proc~ddecbt~2->dgesl proc~ddot ddot.inc::ddot proc~dewset dewset.inc::dewset proc~dewset~2 M_odepack::dewset proc~dfnorm dfnorm.inc::dfnorm proc~dgbfa dgbfa.inc::dgbfa proc~dgbfa->daxpy dscal dscal proc~dgbfa->dscal idamax idamax proc~dgbfa->idamax proc~dgbsl~2 dgbsl.inc::dgbsl proc~dgbsl~2->daxpy proc~dgbsl~2->ddot proc~dgefa dgefa.inc::dgefa proc~dgefa->daxpy proc~dgefa->dscal proc~dgefa->idamax proc~dgefa~2->proc~daxpy~2 proc~dgefa~2->proc~dscal proc~dgesl->proc~daxpy~2 proc~dgesl~2 dgesl.inc::dgesl proc~dgesl~2->daxpy proc~dgesl~2->ddot proc~dhefa dhefa.inc::dhefa proc~dhefa->daxpy proc~dhefa->idamax proc~dhels~2 dhels.inc::dhels proc~dhels~2->daxpy proc~dheqr dheqr.inc::dheqr proc~dhesl~2 dhesl.inc::dhesl proc~dhesl~2->daxpy proc~dintdy dintdy.inc::dintdy xerrwd xerrwd proc~dintdy->xerrwd proc~dintdy~2 M_odepack::dintdy proc~xerrwd~2 M_odepack::xerrwd proc~dintdy~2->proc~xerrwd~2 proc~diprep diprep.inc::diprep dprep dprep proc~diprep->dprep proc~diprepi diprepi.inc::diprepi dprepi dprepi proc~diprepi->dprepi proc~diprepi~2 M_odepack::diprepi proc~diprepi~2->dprepi proc~diprep~2 M_odepack::diprep proc~diprep~2->dprep proc~dlhin M_odepack::dlhin proc~dvnorm~2 M_odepack::dvnorm proc~dlhin->proc~dvnorm~2 proc~dlhin~2 dlhin.inc::dlhin proc~dlhin~2->dvnorm proc~dlsoda dlsoda.inc::dlsoda dewset dewset proc~dlsoda->dewset dintdy dintdy proc~dlsoda->dintdy dmnorm dmnorm proc~dlsoda->dmnorm dstoda dstoda proc~dlsoda->dstoda proc~dlsoda->xerrwd proc~dlsodar dlsodar.inc::dlsodar proc~dlsodar->dewset proc~dlsodar->dintdy proc~dlsodar->dmnorm drchek drchek proc~dlsodar->drchek proc~dlsodar->dstoda proc~dlsodar->xerrwd proc~dlsodar~2 M_odepack::dlsodar proc~dlsodar~2->proc~dewset~2 proc~dlsodar~2->proc~dintdy~2 proc~dmnorm~2 M_odepack::dmnorm proc~dlsodar~2->proc~dmnorm~2 proc~drchek M_odepack::drchek proc~dlsodar~2->proc~drchek proc~dstoda~2 M_odepack::dstoda proc~dlsodar~2->proc~dstoda~2 proc~dlsodar~2->proc~xerrwd~2 proc~dlsoda~2 M_odepack::dlsoda proc~dlsoda~2->proc~dewset~2 proc~dlsoda~2->proc~dintdy~2 proc~dlsoda~2->proc~dmnorm~2 proc~dlsoda~2->proc~dstoda~2 proc~dlsoda~2->proc~xerrwd~2 proc~dlsode dlsode.inc::dlsode proc~dlsode->dewset proc~dlsode->dintdy dstode dstode proc~dlsode->dstode proc~dlsode->dvnorm proc~dlsode->xerrwd proc~dlsodes dlsodes.inc::dlsodes proc~dlsodes->dewset proc~dlsodes->dintdy diprep diprep proc~dlsodes->diprep proc~dlsodes->dstode proc~dlsodes->dvnorm proc~dlsodes->xerrwd proc~dlsodes~2 M_odepack::dlsodes proc~dlsodes~2->proc~dewset~2 proc~dlsodes~2->proc~dintdy~2 proc~dlsodes~2->proc~diprep~2 proc~dlsodes~2->proc~dvnorm~2 proc~dlsodes~2->proc~xerrwd~2 proc~dlsodes~2->dstode proc~dlsode~2 M_odepack::dlsode proc~dlsode~2->proc~dewset~2 proc~dlsode~2->proc~dintdy~2 proc~dlsode~2->proc~dvnorm~2 proc~dlsode~2->proc~xerrwd~2 proc~dlsode~2->dstode proc~dlsodi dlsodi.inc::dlsodi dainvg dainvg proc~dlsodi->dainvg proc~dlsodi->dewset proc~dlsodi->dintdy dstodi dstodi proc~dlsodi->dstodi proc~dlsodi->dvnorm proc~dlsodi->xerrwd proc~dlsodis dlsodis.inc::dlsodis dainvgs dainvgs proc~dlsodis->dainvgs proc~dlsodis->dewset proc~dlsodis->dintdy diprepi diprepi proc~dlsodis->diprepi proc~dlsodis->dstodi proc~dlsodis->dvnorm proc~dlsodis->xerrwd proc~dlsodis~2 M_odepack::dlsodis proc~dlsodis~2->proc~dewset~2 proc~dlsodis~2->proc~dintdy~2 proc~dlsodis~2->proc~diprepi~2 proc~dlsodis~2->proc~dvnorm~2 proc~dlsodis~2->proc~xerrwd~2 proc~dlsodis~2->dainvgs proc~dlsodis~2->dstodi proc~dlsodi~2 M_odepack::dlsodi proc~dlsodi~2->proc~dainvg~2 proc~dlsodi~2->proc~dewset~2 proc~dlsodi~2->proc~dintdy~2 proc~dlsodi~2->proc~dvnorm~2 proc~dlsodi~2->proc~xerrwd~2 proc~dlsodi~2->dstodi proc~dlsodkr dlsodkr.inc::dlsodkr proc~dlsodkr->dewset proc~dlsodkr->dintdy dlhin dlhin proc~dlsodkr->dlhin proc~dlsodkr->drchek dstoka dstoka proc~dlsodkr->dstoka proc~dlsodkr->dvnorm proc~dlsodkr->xerrwd proc~dlsodkr~2 M_odepack::dlsodkr proc~dlsodkr~2->proc~dewset~2 proc~dlsodkr~2->proc~dintdy~2 proc~dlsodkr~2->proc~dlhin proc~dlsodkr~2->proc~drchek proc~dstoka~2 M_odepack::dstoka proc~dlsodkr~2->proc~dstoka~2 proc~dlsodkr~2->proc~dvnorm~2 proc~dlsodkr~2->proc~xerrwd~2 proc~dlsodpk dlsodpk.inc::dlsodpk proc~dlsodpk->dewset proc~dlsodpk->dintdy dstodpk dstodpk proc~dlsodpk->dstodpk proc~dlsodpk->dvnorm proc~dlsodpk->xerrwd proc~dlsodpk~2 M_odepack::dlsodpk proc~dlsodpk~2->proc~dewset~2 proc~dlsodpk~2->proc~dintdy~2 proc~dstodpk M_odepack::dstodpk proc~dlsodpk~2->proc~dstodpk proc~dlsodpk~2->proc~dvnorm~2 proc~dlsodpk~2->proc~xerrwd~2 proc~dlsoibt dlsoibt.inc::dlsoibt daigbt daigbt proc~dlsoibt->daigbt proc~dlsoibt->dewset proc~dlsoibt->dintdy proc~dlsoibt->dstodi proc~dlsoibt->dvnorm proc~dlsoibt->xerrwd proc~dlsoibt~2 M_odepack::dlsoibt proc~dlsoibt~2->proc~daigbt~2 proc~dlsoibt~2->proc~dewset~2 proc~dlsoibt~2->proc~dintdy~2 proc~dlsoibt~2->proc~dvnorm~2 proc~dlsoibt~2->proc~xerrwd~2 proc~dlsoibt~2->dstodi proc~dmnorm dmnorm.inc::dmnorm proc~dnrm2 dnrm2.inc::DNRM2 proc~dorthog dorthog.inc::dorthog proc~dorthog->daxpy proc~dorthog->ddot proc~dorthog->dnrm2 proc~dpcg dpcg.inc::dpcg datp datp proc~dpcg->datp proc~dpcg->daxpy proc~dpcg->ddot proc~dpcg->dvnorm proc~dpcgs dpcgs.inc::dpcgs proc~dpcgs->datp proc~dpcgs->daxpy proc~dpcgs->dvnorm proc~dpjibt dpjibt.inc::dpjibt proc~dpjibt->ddecbt proc~dpjibt~2 M_odepack::dpjibt proc~dpjibt~2->proc~dgefa~2 proc~dpjibt~2->proc~dgesl proc~dpkset dpkset.inc::dpkset proc~dprep M_odepack.f90::dprep proc~dprep->none~wrapup400 proc~dprep->none~wrapup500 proc~dprep->none~wrapup600 proc~dprep->none~wrapup700 proc~dprep->proc~adjlr~2 proc~dprep->proc~cdrv proc~jgroup M_odepack::jgroup proc~dprep->proc~jgroup proc~odrv~2 M_odepack::odrv proc~dprep->proc~odrv~2 proc~dprepi M_odepack.f90::dprepi proc~dprepi->proc~adjlr~2 proc~dprepi->proc~cdrv proc~dprepi->proc~cntnzu~2 proc~dprepi->proc~jgroup proc~dprepi->proc~odrv~2 proc~dprepi~2 dprepi.inc::dprepi proc~dprepi~2->proc~adjlr~2 proc~dprepi~2->proc~cdrv proc~dprepi~2->proc~cntnzu~2 proc~dprepi~2->proc~jgroup proc~dprepi~2->proc~odrv~2 proc~dprepj dprepj.inc::dprepj proc~dprepj->none~wrapup proc~dprepj->dgefa proc~dprepj->dvnorm proc~dprepji dprepji.inc::dprepji proc~dprepji->none~wrapup~3 proc~dprepji->dgefa proc~dprepji~2 M_odepack::dprepji proc~dprepji~2->proc~daxpy~2 proc~dprepji~2->proc~dgefa~2 proc~dprepji~2->proc~dscal proc~dprepj~2 M_odepack::dprepj proc~dprepj~2->proc~daxpy~2 proc~dprepj~2->proc~dgefa~2 proc~dprepj~2->proc~dscal proc~dprepj~2->proc~dvnorm~2 proc~dprep~2 dprep.inc::dprep proc~dprep~2->none~wrapup400~2 proc~dprep~2->none~wrapup500~2 proc~dprep~2->none~wrapup600~2 proc~dprep~2->none~wrapup700~2 proc~dprep~2->proc~adjlr~2 proc~dprep~2->proc~cdrv proc~dprep~2->proc~jgroup proc~dprep~2->proc~odrv~2 proc~dprja dprja.inc::dprja proc~dprja->none~wrapup~4 dfnorm dfnorm proc~dprja->dfnorm proc~dprja->dgefa proc~dprja->dmnorm proc~dprja~2 M_odepack::dprja proc~dprja~2->proc~daxpy~2 proc~dprja~2->proc~dgefa~2 proc~dprja~2->proc~dmnorm~2 proc~dprja~2->proc~dscal proc~dprjis dprjis.inc::dprjis proc~dprjis->cdrv proc~dprjis~2 M_odepack::dprjis proc~dprjis~2->proc~cdrv proc~dprjs dprjs.inc::dprjs proc~dprjs->none~wrapup~2 proc~dprjs->dvnorm proc~dprjs~2 M_odepack::dprjs proc~dprjs~2->proc~cdrv proc~dprjs~2->proc~dvnorm~2 proc~drchek->proc~dintdy~2 proc~drchek~2 drchek.inc::drchek proc~drchek~2->dintdy droots droots proc~drchek~2->droots proc~droots droots.inc::droots proc~dscal~2 dscal.inc::dscal proc~dsetpk dsetpk.inc::dsetpk proc~dslsbt dslsbt.inc::dslsbt proc~dslsbt->dsolbt proc~dslsbt~2 M_odepack::dslsbt proc~dslsbt~2->proc~dgesl proc~dsolbt~2 dsolbt.inc::dsolbt proc~dsolbt~2->ddot proc~dsolbt~2->dgesl proc~dsolpk dsolpk.inc::dsolpk dpcg dpcg proc~dsolpk->dpcg dpcgs dpcgs proc~dsolpk->dpcgs proc~dsolpk->dscal dspigmr dspigmr proc~dsolpk->dspigmr dspiom dspiom proc~dsolpk->dspiom dusol dusol proc~dsolpk->dusol proc~dsolss dsolss.inc::dsolss proc~dsolss->cdrv proc~dsolss~2 M_odepack::dsolss proc~dsolss~2->proc~cdrv proc~dsolsy dsolsy.inc::dsolsy proc~dsolsy->dgbsl proc~dsolsy->dgesl proc~dsolsy~2 M_odepack::dsolsy proc~dsolsy~2->proc~daxpy~2 proc~dsolsy~2->proc~dgesl proc~dspigmr dspigmr.inc::dspigmr proc~dspigmr->none~approximate~2 datv datv proc~dspigmr->datv dheqr dheqr proc~dspigmr->dheqr proc~dspigmr->dnrm2 dorthog dorthog proc~dspigmr->dorthog proc~dspigmr->dscal proc~dspiom dspiom.inc::dspiom proc~dspiom->none~approximate proc~dspiom->datv dhefa dhefa proc~dspiom->dhefa proc~dspiom->dnrm2 proc~dspiom->dorthog proc~dspiom->dscal proc~dsrcar M_odepack::dsrcar proc~dsrcar~2 dsrcar.inc::dsrcar cm1 cm1 proc~dsrcar~2->cm1 cm2 cm2 proc~dsrcar~2->cm2 return_dls1_int return_dls1_int proc~dsrcar~2->return_dls1_int return_dls1_real return_dls1_real proc~dsrcar~2->return_dls1_real set_dls1_int set_dls1_int proc~dsrcar~2->set_dls1_int set_dls1_real set_dls1_real proc~dsrcar~2->set_dls1_real proc~dsrckr M_odepack::dsrckr proc~dsrckr~2 dsrckr.inc::dsrckr proc~dsrckr~2->return_dls1_int proc~dsrckr~2->return_dls1_real proc~dsrckr~2->set_dls1_int proc~dsrckr~2->set_dls1_real proc~dsrcma dsrcma.inc::dsrcma proc~dsrcma->cm1 proc~dsrcma->cm2 proc~dsrcma->return_dls1_int proc~dsrcma->return_dls1_real proc~dsrcma->set_dls1_int proc~dsrcma->set_dls1_real proc~dsrcma~2 M_odepack::dsrcma proc~dsrcms dsrcms.inc::dsrcms proc~dsrcms->return_dls1_int proc~dsrcms->return_dls1_real proc~dsrcms->set_dls1_int proc~dsrcms->set_dls1_real proc~dsrcms~2 M_odepack::dsrcms proc~dsrcom dsrcom.inc::dsrcom proc~dsrcom->return_dls1_int proc~dsrcom->return_dls1_real proc~dsrcom->set_dls1_int proc~dsrcom->set_dls1_real proc~dsrcom~2 M_odepack::dsrcom proc~dsrcpk dsrcpk.inc::dsrcpk proc~dsrcpk->return_dls1_int proc~dsrcpk->return_dls1_real proc~dsrcpk->set_dls1_int proc~dsrcpk->set_dls1_real proc~dsrcpk~2 M_odepack::dsrcpk proc~dstoda dstoda.inc::dstoda proc~dstoda->cm1 proc~dstoda->cm2 dcfode dcfode proc~dstoda->dcfode proc~dstoda->dmnorm el el proc~dstoda->el elco elco proc~dstoda->elco tesco tesco proc~dstoda->tesco proc~dstoda~2->proc~dcfode~2 proc~dstoda~2->proc~dmnorm~2 proc~dstode dstode.inc::dstode proc~dstode->proc~dcfode~2 proc~dstode->proc~dvnorm~2 proc~dstode~2 M_odepack.f90::dstode proc~dstode~2->proc~dcfode~2 proc~dstode~2->proc~dvnorm~2 proc~dstodi dstodi.inc::dstodi proc~dstodi->proc~dcfode~2 proc~dstodi->proc~dvnorm~2 proc~dstodi~2 M_odepack.f90::dstodi proc~dstodi~2->proc~dcfode~2 proc~dstodi~2->proc~dvnorm~2 proc~dstodpk->proc~daxpy~2 proc~dstodpk->proc~dcfode~2 proc~dstodpk->proc~dscal proc~dstodpk->proc~dvnorm~2 proc~dstodpk~2 dstodpk.inc::dstodpk proc~dstodpk~2->dcfode dpkset dpkset proc~dstodpk~2->dpkset dsolpk dsolpk proc~dstodpk~2->dsolpk proc~dstodpk~2->dvnorm proc~dstodpk~2->el proc~dstodpk~2->elco proc~dstodpk~2->tesco proc~dstoka dstoka.inc::dstoka proc~dstoka->dcfode dsetpk dsetpk proc~dstoka->dsetpk proc~dstoka->dsolpk proc~dstoka->dvnorm proc~dstoka->el proc~dstoka->elco proc~dstoka->tesco proc~dstoka~2->proc~daxpy~2 proc~dstoka~2->proc~dcfode~2 proc~dstoka~2->proc~dscal proc~dstoka~2->proc~dvnorm~2 proc~dusol dusol.inc::dusol proc~dusol->dvnorm proc~dvnorm dvnorm.inc::dvnorm proc~idamax idamax.inc::idamax proc~ixsav~2 ixsav.inc::ixsav proc~jgroup~2 jgroup.inc::jgroup proc~md md.inc::md mdi mdi proc~md->mdi mdm mdm proc~md->mdm mdp mdp proc~md->mdp mdu mdu proc~md->mdu proc~mdi~2 mdi.inc::mdi proc~mdm~2 mdm.inc::mdm proc~mdp mdp.inc::mdp proc~mdu~2 mdu.inc::mdu proc~nnfc nnfc.inc::nnfc proc~nnsc nnsc.inc::nnsc proc~nntc~2 nntc.inc::nntc proc~nroc~2 nroc.inc::nroc proc~nsfc~2 nsfc.inc::nsfc proc~odrv odrv.inc::odrv md md proc~odrv->md sro sro proc~odrv->sro proc~sro sro.inc::sro proc~xerrwd xerrwd.inc::xerrwd ixsav ixsav proc~xerrwd->ixsav proc~xsetf xsetf.inc::xsetf proc~xsetf->ixsav proc~xsetf~2 M_odepack::xsetf proc~xsetun xsetun.inc::xsetun proc~xsetun->ixsav proc~xsetun~2 M_odepack::xsetun
Help