NAG Library
Advice on Replacement Calls for Withdrawn/Superseded Routines
C05 – Roots of One or More Transcendental Equations
c05adf
Withdrawn at Mark 25.
Replaced by
c05ayf.
Old: FUNCTION F(XX)
...
END FUNCTION F
...
CALL c05adf(A,B,EPS,ETA,F,X,IFAIL)
New: FUNCTION F(XX,IUSER,RUSER)
...
INTEGER, INTENT(INOUT) :: IUSER(*)
REAL (KIND=nag_wp), INTENT(INOUT) :: RUSER(*)
...
END FUNCTION F
...
INTEGER :: IUSER(1)
REAL (KIND=nag_wp) :: RUSER(1)
...
CALL c05ayf(A,B,EPS,ETA,F,X,IUSER,RUSER,IFAIL)
c05agf
Withdrawn at Mark 25.
Replaced by
c05auf.
Old: FUNCTION F(XX)
...
END FUNCTION F
...
CALL c05agf(X,H,EPS,ETA,F,A,B,IFAIL)
New: FUNCTION F(XX,IUSER,RUSER)
...
INTEGER, INTENT(INOUT) :: IUSER(*)
REAL (KIND=nag_wp), INTENT(INOUT) :: RUSER(*)
...
END FUNCTION F
...
INTEGER :: IUSER(1)
REAL (KIND=nag_wp) :: RUSER(1)
...
CALL c05auf(X,H,EPS,ETA,F,A,B,IUSER,RUSER,IFAIL)
c05ajf
Withdrawn at Mark 25.
Replaced by
c05awf.
Old: FUNCTION F(XX)
...
END FUNCTION F
...
CALL c05ajf(X,EPS,ETA,F,NFMAX,IFAIL)
New: FUNCTION F(XX,IUSER,RUSER)
...
INTEGER, INTENT(INOUT) :: IUSER(*)
REAL (KIND=nag_wp), INTENT(INOUT) :: RUSER(*)
...
END FUNCTION F
...
INTEGER :: IUSER(1)
REAL (KIND=nag_wp) :: RUSER(1)
...
CALL c05awf(X,EPS,ETA,F,NFMAX,IUSER,RUSER,IFAIL)
c05nbf
Withdrawn at Mark 25.
Replaced by
c05qbf.
Old: SUBROUTINE FCN(N,X,FVEC,IFLAG)
...
END SUBROUTINE FCN
...
CALL c05nbf(FCN,N,X,FVEC,XTOL,WA,LWA,IFAIL)
New: SUBROUTINE FCN(N,X,FVEC,IUSER,RUSER,IFLAG)
...
INTEGER, INTENT(INOUT) :: IUSER(*)
REAL (KIND=nag_wp), INTENT(INOUT) :: RUSER(*)
...
END FUNCTION FCN
...
INTEGER :: IUSER(1)
REAL (KIND=nag_wp) :: RUSER(1)
...
CALL c05qbf(FCN,N,X,FVEC,XTOL,IUSER,RUSER,IFAIL)
c05ncf
Withdrawn at Mark 25.
Replaced by
c05qcf.
Old: SUBROUTINE FCN(N,X,FVEC,IFLAG)
...
END SUBROUTINE FCN
...
REAL (KIND=nag_wp) :: FJAC(LDFJAC,N)
...
CALL c05ncf(FCN,N,X,FVEC,XTOL,MAXFEV,ML,MU,EPSFCN,DIAG,MODE,FACTOR, &
NPRINT,NFEV,FJAC,LDFJAC,R,LR,QTF,W,IFAIL)
New: SUBROUTINE FCN(N,X,FVEC,IUSER,RUSER,IFLAG)
...
INTEGER, INTENT(INOUT) :: IUSER(*)
REAL (KIND=nag_wp), INTENT(INOUT) :: RUSER(*)
...
END FUNCTION FCN
...
INTEGER :: IUSER(1)
REAL (KIND=nag_wp) :: FJAC(N,N), RUSER(1)
...
CALL c05qcf(FCN,N,X,FVEC,XTOL,MAXFEV,ML,MU,EPSFCN,MODE,DIAG,FACTOR, &
NPRINT,NFEV,FJAC,R,QTF,IUSER,RUSER,IFAIL)
c05ndf
Withdrawn at Mark 25.
Replaced by
c05qdf.
Old: REAL (KIND=nag_wp) :: FJAC(LDFJAC,N)
...
CALL c05ndf(IREVCM,N,X,FVEC,XTOL,ML,MU,EPSFCN,DIAG,MODE,FACTOR, &
FJAC,LDFJAC,R,LR,QTF,W,IFAIL)
New: REAL (KIND=nag_wp) :: FJAC(N,N), RWSAV(4*N+20)
INTEGER :: IWSAV(17)
...
CALL c05qdf(IREVCM,N,X,FVEC,XTOL,ML,MU,EPSFCN,MODE,DIAG,FACTOR, &
FJAC,R,QTF,IWSAV,RWSAV,IFAIL)
c05pbf/c05pba
Withdrawn at Mark 25.
Replaced by
c05rbf.
Old: SUBROUTINE FCN_C05PBF(N,X,FVEC,FJAC,LDFJAC,IFLAG)
...
END SUBROUTINE FCN_C05PBF
...
REAL (KIND=nag_wp) :: FJAC(LDFJAC,N)
...
CALL C05PBF(FCN_C05PBF,N,X,FVEC,FJAC,LDFJAC,XTOL,WA,LWA,IFAIL)
or
SUBROUTINE FCN_C05PBA(N,X,FVEC,FJAC,LDFJAC,IFLAG,IUSER,RUSER)
...
END SUBROUTINE FCN_C05PBA
...
REAL (KIND=nag_wp) :: FJAC(LDFJAC,N)
...
CALL C05PBA(FCN_C05PBA,N,X,FVEC,FJAC,LDFJAC,XTOL,WA,LWA,IUSER,RUSER,IFAIL)
New: SUBROUTINE FCN(N,X,FVEC,FJAC,IUSER,RUSER,IFLAG)
...
END SUBROUTINE FCN
...
REAL (KIND=nag_wp) :: FJAC(N,N)
...
CALL c05rbf(FCN,N,X,FVEC,FJAC,XTOL,IUSER,RUSER,IFAIL)
c05pcf/c05pca
Withdrawn at Mark 25.
Replaced by
c05rcf.
Old: SUBROUTINE FCN_C05PCF(N,X,FVEC,FJAC,LDFJAC,IFLAG)
...
END SUBROUTINE FCN_C05PCF
...
REAL (KIND=nag_wp) :: FJAC(LDFJAC,N)
...
CALL C05PCF(FCN_C05PCF,N,X,FVEC,FJAC,LDFJAC,XTOL,MAXFEV,DIAG,MODE,FACTOR, &
NPRINT,NFEV,NJEV,R,LR,QTF,W,IFAIL)
or
SUBROUTINE FCN_C05PCA(N,X,FVEC,FJAC,LDFJAC,IFLAG,IUSER,RUSER)
...
END SUBROUTINE FCN_C05PCA
...
REAL (KIND=nag_wp) :: FJAC(LDFJAC,N)
...
CALL C05PCA(FCN_C05PCA,N,X,FVEC,FJAC,LDFJAC,XTOL,MAXFEV,DIAG,MODE,FACTOR, &
NPRINT,NFEV,NJEV,R,LR,QTF,W,IUSER,RUSER,IFAIL)
New: SUBROUTINE FCN(N,X,FVEC,FJAC,IUSER,RUSER,IFLAG)
...
INTEGER, INTENT(INOUT) :: IUSER(*)
REAL (KIND=nag_wp), INTENT(INOUT) :: RUSER(*)
...
END FUNCTION FCN
...
REAL (KIND=nag_wp) :: FJAC(N,N)
...
CALL c05rcf(FCN,N,X,FVEC,FJAC,XTOL,MAXFEV,MODE,DIAG,FACTOR, &
NPRINT,NFEV,NJEV,R,QTF,IUSER,RUSER,IFAIL)
c05pdf/c05pda
Withdrawn at Mark 25.
Replaced by
c05rdf.
Old: REAL (KIND=nag_wp) :: FJAC(LDFJAC,N), RWSAV(10)
INTEGER :: IWSAV(15)
...
CALL C05PDF(IREVCM,N,X,FVEC,FJAC,LDFJAC,XTOL,DIAG,MODE,FACTOR, &
R,LR,QTF,W,IFAIL)
or
CALL C05PDA(IREVCM,N,X,FVEC,FJAC,LDFJAC,XTOL,DIAG,MODE,FACTOR, &
R,LR,QTF,W,LWSAV,IWSAV,RWSAV,IFAIL)
New: REAL (KIND=nag_wp) :: FJAC(N,N), RWSAV(4*N+10)
INTEGER :: IWSAV(17)
...
CALL c05rdf(IREVCM,N,X,FVEC,FJAC,XTOL,MODE,DIAG,FACTOR, &
R,QTF,IWSAV,RWSAV,IFAIL)
c05zaf
Withdrawn at Mark 25.
Replaced by
c05zdf.
Old: CALL c05zaf(M,N,X,FVEC,FJAC,LDFJAC,XP,FVECP,MODE,ERR)
New: IFAIL = 0
CALL c05zdf(MODE,M,N,X,FVEC,FJAC,LDFJAC,XP,FVECP,ERR,IFAIL)
The array
xp must now have dimension
n regardless of the value of
mode, and likewise
err must now have dimension
m regardless. The argument
ifail is the standard NAG argument for error trapping. If you are unfamiliar with this argument you should refer to
Section 3.4 in How to Use the NAG Library and its Documentation for details.
C06 – Summation of Series
c06dbf
Withdrawn at Mark 25.
Replaced by
c06dcf.
Old: DO I = 1, LX
RES(I) = c06dbf(X(I),C,N,S)
END DO
New: XMIN = -1.0D0
XMAX = 1.0D0
SELECT CASE (S)
CASE (1,2,3)
S_USE = S
CASE DEFAULT
S_USE = 2
END SELECT
IFAIL = 0
CALL c06dcf(X,LX,XMIN,XMAX,C,N,S_USE,RES,IFAIL)
The old routine
c06dbf returns a single sum at a time, whereas the new routine
c06dcf returns a vector of
lx values at once. The values supplied in
x to
c06dcf are un-normalized original variable values in the range
. The argument
ifail is the standard NAG argument for error trapping. If you are unfamiliar with this argument you should refer to
Section 3.4 in How to Use the NAG Library and its Documentation for details.
c06eaf
Withdrawn at Mark 26.
Replaced by
c06paf.
c06paf removes restrictions on sequence length and combines transform directions.
Old: CALL c06eaf(X,N,IFAIL)
New: CALL c06paf('F',X,N,WORK,IFAIL)
where
work is a real array of length
and
the dimension of the array
x has been extended from the original
n
to
.
The output values
x are stored in a different order with real and imaginary parts stored contiguously. The mapping of output elements is as follows:
- , for and
, for .
c06ebf
Withdrawn at Mark 26.
Replaced by
c06paf.
c06paf removes restrictions on sequence length and combines transform directions.
Old: CALL c06ebf(X,N,IFAIL)
New: CALL c06paf('B',X,N,WORK,IFAIL)
where
work is a real array of length
and
the dimension of the array
x has been extended from the original
n
to
.
The input values of
x are stored in a different order with real and imaginary parts stored contiguously. Also
c06paf performs the inverse transform without the need to first conjugate. If prior conjugation of original array
x is assumed then the mapping of input elements is:
- , for and
, for .
c06ecf
Withdrawn at Mark 26.
Replaced by
c06pcf.
c06pcf removes restrictions on sequence length, combines transform directions and uses complex types.
Old: CALL c06ecf(X,Y,N,IFAIL)
New: CALL c06pcf('F',Z,N,WORK,IFAIL)
where
work is a complex array of length
and
Z
is a complex array of length
n such that
, for
on input and output.
c06ekf
Withdrawn at Mark 26.
Replaced by
c06fkf.
c06fkf removes restrictions on sequence length.
Old: CALL c06ekf(IJOB,X,Y,N,IFAIL)
New: CALL c06fkf(IJOB,X,Y,N,WORK,IFAIL)
where
work is a real array of length
n.
c06fpf
Scheduled for withdrawal at Mark 28.
Replaced by
c06pqf.
c06pqf provides a simpler interface for both forward and backward transforms.
Old: CALL c06fpf(M,N,X,INIT,TRIG,WORK,IFAIL)
New: CALL c06pqf('F',N,M,X,WORK,IFAIL)
where the dimension of
work has been extended from
to
(to include TRIG) and the dimension of the array
x has been extended from the original
to
. The input values are stored stored slightly differently to allow for two extra storage spaces at the end of each sequence.
The mapping of input elements is as follows:
- for
- ; ;
- , for ;
- and need not be set.
The output values
x are stored in a different order with real and imaginary parts of each Hermitian sequence stored contiguously.
The mapping of output elements is as follows:
(Here
x begins at element zero
.)
For
- ; ;
- , for [real parts];
- , for [imaginary parts];
- is set to zero;
- is set to zero when n is even.
c06fqf
Scheduled for withdrawal at Mark 28.
Replaced by
c06pqf.
c06pqf provides a simpler interface for both forward and backward transforms.
Old: CALL c06fqf(M,N,X,INIT,TRIG,WORK,IFAIL)
New: CALL c06pqf('B',N,M,X,WORK,IFAIL)
where the dimension of
work has been extended from
to
(to include TRIG) and the dimension of the array
x has been extended from the original
to
.
The input values
x are stored in a different order with real and imaginary parts of each Hermitian sequence stored contiguously.
The mapping of input elements is as follows:
(Here
x begins at element zero
.)
For
- ; ;
- , for [real parts];
- , for [imaginary parts];
- must be zero;
- must zero when n is even.
The output values are stored stored slightly differently to allow for two extra storage spaces at the end of each sequence.
The mapping of output elements is as follows:
For
- ; ;
- , for ;
- and will be set to zero.
c06frf
Withdrawn at Mark 26.
Replaced by
c06psf.
c06psf provides a simpler interface for both forward and backward transforms.
Old: call c06frf(M,N,X,Y,INIT,TRIG,WORK,IFAIL)
New: Do j = 1, m*n
cx(j) = cmplx(x(j),y(j),kind=nag_wp)
End Do
Call c06psf('F',M,N,CX,CWORK,IFAIL)
x(1:m*n) = real(cx(1:m*n))
y(1:m*n) = aimag(cx(1:m*n))
where
and are complex array of length and respectively.
c06fuf
Withdrawn at Mark 26.
Replaced by
c06puf.
c06puf provides a simpler interface for both forward and backward transforms.
Old: Call c06fuf(M,N,X,Y,INIT,TRIGM,TRIGN,WORK,IFAIL)
New: Do j = 1, m*n
cx(j) = cmplx(x(j),y(j),kind=nag_wp)
End Do
Call c06puf('F',M,N,CX,CWORK,IFAIL)
x(1:m*n) = real(cx(1:m*n))
y(1:m*n) = aimag(cx(1:m*n))
where and are complex arrays of lengths and respectively.
c06gbf
Withdrawn at Mark 26.
There is no replacement for this routine.
c06gcf
Withdrawn at Mark 26.
There is no replacement for this routine.
c06gqf
Withdrawn at Mark 26.
There is no replacement for this routine.
c06gsf
Withdrawn at Mark 26.
There is no replacement for this routine.
c06haf
Withdrawn at Mark 26.
Replaced by
c06ref.
c06ref has a simpler interface, storing sequences by column.
Old: Call c06haf(M,N,X,INIT,TRIG,WORK,IFAIL)
New: Call c06ref(M,N,Y,IFAIL)
where is a two-dimensional real array such that .
c06hbf
Withdrawn at Mark 26.
Replaced by
c06rff.
c06rff has a simpler interface, storing sequences by column.
Old: Call c06hbf(M,N,X,INIT,TRIG,WORK,IFAIL)
New: Call c06rff(M,N,Y,IFAIL)
where is a two-dimensional real array such that .
c06hcf
Withdrawn at Mark 26.
Replaced by
c06rgf.
c06rgf has a simpler interface, storing sequences by column.
Old: Call c06hcf(DIRECT,M,N,X,INIT,TRIG,WORK,IFAIL)
New: Call c06rgf(IDIR,M,N,Y,IFAIL)
where is a two-dimensional real array such that ; or for forward and inverse transforms respectively.
c06hdf
Withdrawn at Mark 26.
Replaced by
c06rhf.
c06rhf has a simpler interface, storing sequences by column.
Old: Call c06hdf(DIRECT,M,N,X,INIT,TRIG,WORK,IFAIL)
New: Call c06rhf(IDIR,M,N,Y,IFAIL)
where is a two-dimensional real array such that ; or for forward and inverse transforms respectively.
D01 – Quadrature
d01baf
Withdrawn at Mark 26.
Replaced by
d01uaf.
Withdrawn to provide thread safety in passing of data to user supplied function and a simpler interface to select the quadrature rule.
Old : FUNCTION FUN(x)
...
real(kind=nag_wp) :: FUN
real(kind=nag_wp), intent(in) :: X
FUN = ...
END FUNCTION
DINEST = d01baf(D01XXX,A,B,N,FUN,IFAIL)
New : SUBROUTINE F(X,NX,FV,IFLAG,IUSER,RUSER)
...
! see example below
...
END SUBROUTINE F
...
integer :: key
integer, allocatable :: iuser(:)
real(kind=nag_wp), allocatable :: ruser(:)
! set KEY according to quadrature formula
! KEY = 0 : (D01XXX=D01BAZ)
! KEY = -3 : (D01XXX=D01BAY)
! KEY = -4 : (D01XXX=D01BAW)
! KEY = -5 : (D01XXX=D01BAX)
! KEY = ABS(KEY) for normal weights
KEY = 0
allocate(iuser(liuser), ruser(lruser))
CALL d01uaf(KEY,A,B,N,F,DINEST,IUSER,RUSER,IFAIL)
iuser and
ruser are arrays
available to allow you to pass information to the user-supplied subroutine
f.
iflag is an integer which you may use to force an immediate exit from
d01uaf in case of an error in the user-supplied subroutine
f.
f may be used to call the original
fun as follows, although it may be more efficient to recode the integrand.
SUBROUTINE F(X,NX,FV,IFLAG,IUSER,RUSER)
...
integer, intent(in) :: NX
integer, intent(inout) :: iflag
real(kind=nag_wp), intent(in) :: X(NX)
real(kind=nag_wp), intent(out) :: fv(nx)
real(kind=wp), intent(inout) :: ruser(*)
integer, intent(inout) :: iuser(*)
integer :: j
external FUN
do j=1,nx
FV(j) = FUN(x(j))
enddo
END SUBROUTINE F
d01bbf
Withdrawn at Mark 26.
Replaced by
d01tbf.
Withdrawn to provide thread safety in passing of data to the user-supplied routine and a simpler interface to select the quadrature rule.
Old : CALL d01bbf(D01XXX,A,B,ITYPE,N,WEIGHT,ABSCIS,IFAIL)
New : Integer :: key
CALL d01tbf(KEY,A,B,N,WEIGHT,ABSICS,IFAIL)
The supplied subroutines D01XXX and the argument
itype have been combined into a single argument
key.
is equivalent to
(adjusted weights).
is equivalent to
(normal weights).
indicates the quadrature rule.
- : Gauss–Legendre ()
- : Gauss–Laguerre ()
- : Gauss–Hermite ()
- : Rational Gauss ()
d01rbf
Scheduled for withdrawal at Mark 28.
There is no replacement for this routine.
Withdrawn as a separate diagnostic routine is not required. The details of the computation, as stored in the parameters
icom and
com, are specified in
Section 10.1 in
d01raf.
See
Section 10 in
d01raf for further details.
D02 – Ordinary Differential Equations
d02pcf
Withdrawn at Mark 26.
Replaced by
d02pef and associated D02P routines.
These replacements were made primarily for reasons of threadsafety.
Old: CALL d02pvf(N,TSTART,YINIT,TEND,TOL,THRESH,METHOD,'U',ERRASS, &
HSTART,W,LW,IFAIL)
...
CALL d02pcf(F,TWANT,T,Y,YP,YMAX,W,IFAIL)
New: IF (.Not. ERRASS) METHOD = -METHOD
CALL d02pqf(N,TSTART,TEND,YINIT,TOL,THRESH,METHOD,HSTART,IWSAV, &
RWSAV,IFAIL)
...
CALL d02pef(F2,N,TWANT,T,Y,YP,YMAX,IUSER,RUSER,IWSAV,RWSAV,IFAIL)
iwsav is an integer array of length
and
rwsav is a real array of length
.
iuser and
ruser are arrays available to allow you to pass information to the user defined routine F2 (see
f in
d02pef).
The definition of
F2
(see
f in
d02pef) can use the original routine
f as follows:
SUBROUTINE F2(T,N,Y,YP,IUSER,RUSER)
! .. Scalar Arguments ..
Real (Kind=wp), Intent (In) :: t
Integer, Intent (In) :: n
! .. Array Arguments ..
Real (Kind=wp), Intent (Inout) :: ruser(1)
Real (Kind=wp), Intent (In) :: y(n)
Real (Kind=wp), Intent (Out) :: yp(n)
Integer, Intent (Inout) :: iuser(1)
! .. Procedure Arguments ..
External :: f
! .. Executable Statements ..
Continue
Call f(t,y,yp)
Return
End Subroutine F2
d02pdf
Withdrawn at Mark 26.
Replaced by
d02pff or
d02pgf and associated D02P routines.
These replacements were made primarily for reasons of threadsafety.
d02pgf also offers a reverse communication approach.
Old: CALL d02pvf(N,TSTART,YINIT,TEND,TOL,THRESH,METHOD,'U',ERRASS, &
HSTART,W,LW,IFAIL)
...
CALL d02pdf(F,T,Y,YP,WORK,IFAIL)
New: IF (.Not. ERRASS) METHOD = -METHOD
CALL d02pqf(N,TSTART,TEND,YINIT,TOL,THRESH,METHOD,HSTART,IWSAV, &
RWSAV,IFAIL)
...
CALL d02pff(F2,N,T,Y,YP,IUSER,RUSER,IWSAV,RWSAV,IFAIL)
iwsav is an integer array of length
and
rwsav is a real array of length
.
iuser and
ruser are arrays
available to allow you to pass information to the user defined routine
F2
(see
f in
d02pef).
The definition of
F2
(see
f in
d02pef) can use the original routine
f as follows:
SUBROUTINE F2(T,N,Y,YP,IUSER,RUSER)
! .. Scalar Arguments ..
Real (Kind=wp), Intent (In) :: t
Integer, Intent (In) :: n
! .. Array Arguments ..
Real (Kind=wp), Intent (Inout) :: ruser(1)
Real (Kind=wp), Intent (In) :: y(n)
Real (Kind=wp), Intent (Out) :: yp(n)
Integer, Intent (Inout) :: iuser(1)
! .. Procedure Arguments ..
External :: f
! .. Executable Statements ..
Continue
Call f(t,y,yp)
Return
End Subroutine F2
d02pvf
Withdrawn at Mark 26.
Replaced by
d02pqf.
This replacement was made primarily for reasons of threadsafety.
See
d02pcf and
d02pdf for further information.
d02pwf
Withdrawn at Mark 26.
Replaced by
d02prf.
This replacement was made primarily for reasons of threadsafety.
Old: CALL d02pwf(TENDNU,IFAIL)
New: CALL d02prf(TENDNU,IWSAV,RWSAV,IFAIL)
iwsav is an integer array of length
and
rwsav is a real array of length
.
d02pxf
Withdrawn at Mark 26.
Replaced by
d02psf.
This replacement was made primarily for reasons of threadsafety.
Old: CALL d02pxf(TWANT,REQEST,NWANT,YWANT,YPWANT,F,WORK,WRKINT, &
LENINT,IFAIL)
New:
If (REQEST=='S' .or. REQEST=='s') Then
IDERIV = 0
Else if (REQEST=='D' .or. REQEST=='d') Then
IDERIV = 1
Else
IDERIV = 2
End If
CALL d02psf(TWANT,IDERIV,NWANT,YWANT,YPWANT,F2,WORKINT, &
LENINT,IUSER,RUSER,IWSAV,RWSAV,IFAIL)
iwsav is an integer array of length
and
rwsav is a real array of length
.
iuser and
ruser are arrays available to allow you to pass information to the user defined routine F2 (see
f in
d02psf).
wcomm is a real array of length
lwcomm. See the routine document for
d02psf for further information.
The definition of
F2
(see
f in
d02psf) can use the original routine
f as follows:
SUBROUTINE F2(T,N,Y,YP,IUSER,RUSER)
! .. Scalar Arguments ..
Real (Kind=wp), Intent (In) :: t
Integer, Intent (In) :: n
! .. Array Arguments ..
Real (Kind=wp), Intent (Inout) :: ruser(1)
Real (Kind=wp), Intent (In) :: y(n)
Real (Kind=wp), Intent (Out) :: yp(n)
Integer, Intent (Inout) :: iuser(1)
! .. Procedure Arguments ..
External :: f
! .. Executable Statements ..
Continue
Call f(t,y,yp)
Return
End Subroutine F2
d02pyf
Withdrawn at Mark 26.
Replaced by
d02ptf.
This replacement was made primarily for reasons of threadsafety.
Old: Call d02pyf(TOTFCN,STPCST,WASTE,STPSOK,HNEXT,IFAIL)
New: Call d02ptf(TOTFCN,STPCST,WASTE,STPSOK,HNEXT,IWSAV, &
RWSAV,IFAIL)
d02pzf
Withdrawn at Mark 26.
Replaced by
d02puf.
This replacement was made primarily for reasons of threadsafety.
Old: Call d02pzf(RMSERR,ERRMAX,TERRMX,WORK,IFAIL)
New: Call d02puf(N,RMSERR,ERRMAX,TERRMX,IWSAV,RWSAV,IFAIL)
n must be unchanged from that passed to
d02pqf.
iwsav is an integer array of length
and
rwsav is a real array of length
.
d02tkf
Scheduled for withdrawal at Mark 27.
Replaced by
d02tlf.
This replacement was made primarily for reasons of threadsafety.
Old: Call d02tkf(FFUN,FJAC,GAFUN,GBFUN,GAJAC,GBJAC,GUESS,RCOMM,ICOMM,IFAIL)
New: Call d02tlf(FFUN,FJAC,GAFUN,GBFUN,GAJAC,GBJAC,GUESS,RCOMM,ICOMM,IUSER, &
RUSER,IFAIL)
The arrays
iuser and
ruser are also supplied as an additional two arguments to the seven user-supplied routines. These arrays are free to use to supply information to the seven routine arguments.
D03 – Partial Differential Equations
d03ryf
Scheduled for withdrawal at Mark 27.
There is no replacement for this routine.
E01 – Interpolation
e01sef
Withdrawn at Mark 20.
Replaced by
e01sgf.
Old: CALL e01sef(M,X,Y,F,RNW,RNQ,NW,NQ,FNODES,MINNQ,WRK,IFAIL)
New: CALL e01sgf(M,X,Y,F,NW,NQ,IQ,LIQ,RQ,LRQ,IFAIL)
e01sef has been superseded by
e01sgf which gives improved accuracy, facilities for obtaining gradient values and a consistent interface with
e01tgf for interpolation of scattered data in three dimensions.
The interpolant generated by the two routines will not be identical, but similar results may be obtained by using the same values of
nw and
nq. Details of the interpolant are passed to the evaluator through the arrays
iq and
rq rather than
fnodes and
rnw.
e01sff
Withdrawn at Mark 20.
Replaced by
e01shf.
Old: CALL e01sff(M,X,Y,F,RNW,FNODES,PX,PY,PF,IFAIL)
New: CALL e01shf(M,X,Y,F,IQ,LIQ,RQ,LRQ,1,PX,PY,PF,QX,QY,IFAIL)
The two calls will not produce identical results due to differences in the generation routines
e01sef and
e01sgf. Details of the interpolant are passed from
e01sgf through the arrays
iq and
rq rather than
fnodes and
rnw.
e01shf also returns gradient values in
qx and
qy and allows evaluation at arrays of points rather than just single points.
E02 – Curve and Surface Fitting
e02acf
Scheduled for withdrawal at Mark 27.
Replaced by
e02alf.
Old: CALL e02acf(X, Y, N, A, M1, REF)
New: CALL e02alf(N, X, Y, M1, A, REF, IFAIL)
E04 – Minimizing or Maximizing a Function
e04ccf/e04cca
Withdrawn at Mark 24.
Replaced by
e04cbf.
Old: CALL e04ccf(N,X,F,TOL,IW,W1,W2,W3,W4,W5,W6,FUNCT,MONIT,MAXCAL, &
IFAIL)
or
CALL E04CCA(N,X,F,TOL,IW,W1,W2,W3,W4,W5,W6,FUNCT2,MONIT2,MAXCAL, &
IUSER,RUSER,IFAIL)
New: CALL e04cbf(N,X,F,TOLF,TOLX,FUNCT2,MONIT3,MAXCAL,IUSER,RUSER, &
IFAIL)
SUBROUTINE MONIT3(FMIN,FMAX,SIM,N,NCALL,SERROR,VRATIO,IUSER,
RUSER)
INTEGER N, NCALL, IUSER(*)
REAL (KIND=nag_wp) FMIN, FMAX, SIM(N+1,N), SERROR, VRATIO, RUSER(*)
CALL MONIT2(FMIN,FMAX,SIM,N,N+1,NCALL,IUSER,RUSER)
! Add code here to monitor the values of SERROR and VRATIO, if necessary
RETURN
END
e04fdf
Withdrawn at Mark 19.
Replaced by
e04fyf.
Old: CALL e04fdf(M,N,X,FSUMSQ,IW,LIW,W,LW,IFAIL)
New: CALL e04fyf(M,N,LSFUN,X,FSUMSQ,W,LW,IUSER,USER,IFAIL)
LSFUN appears in the argument list instead of the fixed-name subroutine
lsfun1 of
e04fdf.
LSFUN must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition it has an extra two arguments,
iuser and
USER, over and above those of
lsfun1. It may be derived from
lsfun1 as follows:
SUBROUTINE LSFUN(M,N,XC,FVECC,IUSER,USER)
INTEGER M, N, IUSER(*)
REAL (KIND=nag_wp) XC(N), FVECC(M), USER(*)
CALL LSFUN1(M,N,XC,FVECC)
RETURN
END
In general the extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing.
If however, a COMMON block was used to pass information into
lsfun1, or get information from
lsfun1, then the arrays
iuser and
USER should be declared appropriately and used for this purpose.
e04gcf
Withdrawn at Mark 19.
Replaced by
e04gyf.
Old: CALL e04gcf(M,N,X,FSUMSQ,IW,LIW,W,LW,IFAIL)
New: CALL e04gyf(M,N,LSFUN,X,FSUMSQ,W,LW,IUSER,USER,IFAIL)
LSFUN appears in the argument list instead of the fixed-name subroutine
lsfun2 of
e04gcf.
LSFUN must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition it has an extra two arguments,
iuser and
USER, over and above those of
lsfun2. It may be derived from
lsfun2 as follows:
SUBROUTINE LSFUN(M,N,XC,FVECC,FJACC,LJC,IUSER,USER)
INTEGER M, N, LJC, IUSER(*)
REAL (KIND=nag_wp) XC(N), FVECC(M), FJACC(LJC,N), USER(*)
CALL LSFUN2(M,N,XC,FVECC,FJACC,LJC)
RETURN
END
In general the extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing. If however, a COMMON block was used to pass information through
e04gcf into
lsfun2, or get information from
lsfun2, then the arrays
iuser and
USER should be declared appropriately and used for this purpose.
e04gef
Withdrawn at Mark 19.
Replaced by
e04gzf.
Old: CALL e04gef(M,N,X,FSUMSQ,IW,LIW,W,LW,IFAIL)
New: CALL e04gzf(M,N,LSFUN,X,FSUMSQ,W,LW,IUSER,USER,IFAIL)
LSFUN appears in the argument list instead of the fixed-name subroutine
lsfun2 of
e04gef.
LSFUN must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition it has an extra two arguments,
iuser and
USER, over and above those of
lsfun2. It may be derived from
lsfun2 as follows:
SUBROUTINE LSFUN(M,N,X,FVECC,FJACC,LJC,IUSER,USER)
INTEGER M, N, LJC, IUSER(*)
REAL (KIND=nag_wp) XC(N), FVECC(M), FJACC(LJC,N), USER(*)
CALL LSFUN2(M,N,XC,FVECC,FJACC,LJC)
RETURN
END
In general the extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing. If however, a COMMON block was used to pass information through
e04gef into
lsfun2, or get information from
lsfun2, then the arrays
iuser and
USER should be declared appropriately and used for this purpose.
e04hff
Withdrawn at Mark 19.
Replaced by
e04hyf.
Old: CALL e04hff(M,N,X,FSUMSQ,IW,LIW,W,LW,IFAIL)
New: CALL e04hyf(M,N,LSFUN,LSHES,X,FSUMSQ,W,LW,IUSER,USER,IFAIL)
LSFUN and
LSHES appear in the argument list instead of the fixed-name subroutines
lsfun2 and
lshes2 of
e04hff.
LSFUN and
LSHES must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition they have an extra two arguments,
iuser and
USER, over and above those of
lsfun2 and
lshes2. They may be derived from
lsfun2 and
lshes2 as follows:
SUBROUTINE LSFUN(M,N,XC,FVECC,FJACC,LJC,IUSER,USER)
INTEGER M, N, LJC, IUSER(*)
REAL (KIND=nag_wp) XC(N), FVECC(M), FJACC(LJC,N), USER(*)
CALL LSFUN2(M,N,XC,FVECC,FJACC,LJC)
RETURN
END
SUBROUTINE LSHES(M,N,FVECC,XC,B,LB,IUSER,USER)
INTEGER M, N, LB, IUSER(*)
REAL (KIND=nag_wp) FVECC(M), XC(N), B(LB), USER(*)
CALL LSHES2(M,N,FVECC,XC,B,LB)
RETURN
END
In general, the extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing. If, however, a COMMON block was used to pass information through
e04hff into
lsfun2 or
lshes2, or to get information from
lsfun2 or
lshes2, then the arrays
iuser and
ruser should be declared appropriately and used for this purpose.
e04jaf
Withdrawn at Mark 19.
Replaced by
e04jyf.
Old: CALL e04jaf(N,IBOUND,BL,BU,X,F,IW,LIW,LW,IFAIL)
New: CALL e04jyf(N,IBOUND,FUNCT,BL,BU,X,F,IW,LIW,W,LW,IUSER,USER,IFAIL)
FUNCT appears in the argument list instead of the fixed-name subroutine
funct1 of
e04jaf.
FUNCT must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition it has an extra two arguments,
iuser and
USER, over and above those of
funct1. It may be derived from
funct1 as follows:
SUBROUTINE FUNCT(N,XC,FC,IUSER,USER)
INTEGER N, IUSER(*)
REAL (KIND=nag_wp) XC(N), FC, USER(*)
CALL FUNCT1(N,XC,FC)
RETURN
END
The extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing.
e04kaf
Withdrawn at Mark 19.
Replaced by
e04kyf.
Old: CALL e04kaf(N,IBOUND,BL,BU,X,F,G,IW,LIW,W,LW,IFAIL)
New: CALL e04kyf(N,IBOUND,FUNCT,BL,BU,X,F,G,IW,LIW,W,LW,IUSER,USER,IFAIL)
FUNCT appears in the argument list instead of the fixed-name subroutine
funct2 of
e04kaf.
FUNCT must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition it has an extra two arguments,
iuser and
USER, over and above those of
funct2. It may be derived from
funct2 as follows:
SUBROUTINE FUNCT(N,XC,FC,GC,IUSER,USER)
INTEGER N, IUSER(*)
REAL (KIND=nag_wp) XC(N), FC, GC(N), USER(*)
CALL FUNCT2(N,XC,FC,GC)
RETURN
END
The extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing.
e04kcf
Withdrawn at Mark 19.
Replaced by
e04kzf.
Old: CALL e04kcf(N,IBOUND,BL,BU,X,F,G,IW,LIW,W,LW,IFAIL)
New: CALL e04kzf(N,IBOUND,FUNCT,BL,BU,X,F,G,IW,LIW,W,LW,IUSER,USER,IFAIL)
FUNCT appears in the argument list instead of the fixed-name subroutine
funct2 of
e04kcf.
FUNCT must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition it has an extra two arguments,
iuser and
USER, over and above those of
funct2. It may be derived from
funct2 as follows:
SUBROUTINE FUNCT(N,XC,FC,GC,IUSER,USER)
INTEGER N, IUSER(*)
REAL (KIND=nag_wp) XC(N), FC, GC(N), USER(*)
CALL FUNCT2(N,XC,FC,GC)
RETURN
END
The extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing.
e04laf
Withdrawn at Mark 19.
Replaced by
e04lyf.
Old: CALL e04laf(N,IBOUND,BL,BU,X,F,G,IW,LIW,W,LW,IFAIL)
New: CALL e04lyf(N,IBOUND,FUNCT,HESS,BL,BU,X,F,G,IW,LIW,W,LW,IUSER,USER, &
IFAIL)
FUNCT and
HESS appear in the argument list instead of the fixed-name subroutines
funct2 and
hess2 of
e04laf.
FUNCT and
HESS must be declared as EXTERNAL or be a module subprogram USEd in the calling (sub)program. In addition they have an extra two arguments,
iuser and
USER, over and above those of
funct2 and
hess2. They may be derived from
funct2 and
hess2 as follows:
SUBROUTINE FUNCT(N,XC,FC,GC,IUSER,USER)
INTEGER N, IUSER(*)
REAL (KIND=nag_wp) XC(N), FC, GC(N), USER(*)
CALL FUNCT2(N,XC,FC,GC)
RETURN
END
SUBROUTINE HESS(N,XC,HESLC,LH,HESDC,IUSER,USER)
INTEGER N, LH, IUSER(*)
REAL (KIND=nag_wp) XC(N), HESLC(LH), HESDC(N), USER(*)
CALL HESS2(N,XC,HESLC,LH,HESDC)
RETURN
END
In general, the extra arguments,
iuser and
USER, should be declared in the calling program as
and
, but will not need initializing.
e04unf
Withdrawn at Mark 22.
Replaced by
e04usf/e04usa.
Old: CALL e04unf(M,N,NCLIN,NCNLN,LDA,LDCJ,LDFJ, &
LDR,A,BL,BU,Y,CONFUN,OBJFUN,ITER, &
ISTATE,C,CJAC,F,FJAC,CLAMDA,OBJF, &
R,X,IWORK,LIWORK,WORK,LWORK,IUSER, &
RUSER,IFAIL)
New: CALL e04usf(M,N,NCLIN,NCNLN,LDA,LDCJ,LDFJ, &
LDR,A,BL,BU,Y,CONFUN,OBJFUN,ITER, &
ISTATE,C,CJAC,F,FJAC,CLAMDA,OBJF, &
R,X,IWORK,LIWORK,WORK,LWORK,IUSER, &
RUSER,IFAIL)
The specification of the subroutine
objfun must also be changed as follows:
Old: SUBROUTINE OBJFUN(MODE,M,N,LDFJ,X,F,FJAC,NSTATE,IUSER,RUSER)
INTEGER MODE,M,N,LDFJ,NSTATE,IUSER(*)
REAL (KIND=nag_wp) X(N),F(*),FJAC(LDFJ,*),RUSER(*)
New: SUBROUTINE OBJFUN(MODE,M,N,LDFJ,NEEDFI,X,F,FJAC,NSTATE, &
IUSER,RUSER)
INTEGER MODE,M,N,LDFJ,NEEDFI,NSTATE,IUSER(*)
REAL (KIND=nag_wp) X(N),F(*),FJAC(LDFJ,*),RUSER(*)
See the routine documents for further information.
e04upf
Withdrawn at Mark 19.
Replaced by
e04usf/e04usa.
Old: CALL e04upf(M,N,NCLIN,NCNLN,LDA,LDCJ,LDFJ,LDR,A,BL,BU, &
CONFUN,OBJFUN,ITER,ISTATE,C,CJAC,F,FJAC, &
CLAMDA,OBJF,R,X,IWORK,LIWORK,WORK,LWORK, &
IUSER,USER,IFAIL)
New: CALL e04usf(M,N,NCLIN,NCNLN,LDA,LDCJ,LDFJ,LDR,A,BL,BU, &
Y,CONFUN,OBJFUN,ITER,ISTATE,C,CJAC,F,FJAC, &
CLAMDA,OBJF, R,X,IWORK,LIWORK,WORK,LWORK, &
IUSER,USER,IFAIL)
e04usf/e04usa contains one additional argument as follows:
Note that a call to
e04upf is the same as a call to
e04usf/e04usa with
, for
.
The specification of the subroutine
objfun must also be changed as follows:
Old: SUBROUTINE OBJFUN(MODE,M,N,LDFJ,X,F,FJAC,NSTATE,IUSER,USER)
INTEGER MODE,M,N,LDFJ,NSTATE,IUSER(*)
REAL (KIND=nag_wp) X(N),F(*),FJAC(LDFJ,*),USER(*)
New: SUBROUTINE OBJFUN(MODE,M,N,LDFJ,NEEDFI,X,F,FJAC,NSTATE, &
IUSER,USER)
INTEGER MODE,M,N,NEEFI,NSTATE,IUSER(*)
REAL (KIND=nag_wp) X(N),F(*),FJAC(LDFJ,*),USER(*)
See the routine documents for further information.
e04zcf/e04zca
Withdrawn at Mark 24.
There is no replacement for this routine.
F01 – Matrix Operations, Including Inversion
f01maf
Withdrawn at Mark 19.
Replaced by
f11jaf.
Existing programs should be modified to call
f11jaf. The interfaces are significantly different and therefore precise details of a replacement call cannot be given. Please consult the appropriate routine document.
F02 – Eigenvalues and Eigenvectors
f02bbf
Withdrawn at Mark 19.
Replaced by
f08fbf (dsyevx).
Old: CALL f02bbf(A,LDA,N,RLB,RUB,M,MM,R,V,LDV,D,E,E2,X,G,C, &
ICOUNT,IFAIL)
New: CALL dsyevx('V','V','L',N,A,LDA,RLB,RUB, &
0,0,2*X02AMF(),MM,R,V,LDV,WORK,LWORK,IWORK, &
JFAIL,INFO)
where
R must have dimension at least
,
work is a real array of length at least
,
lwork is its actual length,
jfail is an integer array of length at least
, and
iwork is an integer array of length at least
. Note that in the call to
f02bbf R needs only to be of dimension (
m). Larger values of
lwork, up to some optimal value, may improve performance. Arguments
c,
icount,
x,
g,
e2,
e and
d are not used.
f02bcf
Withdrawn at Mark 19.
Replaced by
f02ecf.
Old: CALL f02bcf(A,IA,N,ALB,UB,M,MM,RR,RI,VR,IVR,VI,IVI, &
INTGER,ICNT,C,B,IB,U,V,IFAIL)
New: CALL f02ecf('Moduli',N,A,IA,ALB,UB,M,MM,RR,RI,VR,IVR, &
VI,IVI,WORK,LWORK,ICNT,C,IFAIL)
where
work is a real array of length at least (
) and
lwork is its actual length.
f02bdf
Withdrawn at Mark 19.
Replaced by
f02gcf.
Old: CALL f02bdf(AR,IAR,AI,IAI,N,ALB,UB,M,MM,RR,RI,VR,IVR, &
VI,IVI,INTGER,C,BR,IBR,BI,IBI,U,V,IFAIL)
New: DO 20 J = 1, N
DO 10 I = 1, N
A(I,J) = CMPLX(AR(I,J),AI(I,J),KIND=nag_wp)
10 CONTINUE
20 CONTINUE
CALL f02gcf('Moduli',N,A,IA,ALB,UB,M,MM,R,V,IV,WORK, &
LWORK,RWORK,INTGER,C,IFAIL)
DO 30 I = 1, N
RR(I) = REAL(R(I))
RI(I) = AIMAG(R(I))
30 CONTINUE
DO 50 J = 1, MM
DO 40 I = 1, N
VR(I,J) = REAL(V(I,J))
VI(I,J) = AIMAG(V(I,J))
40 CONTINUE
50 CONTINUE
where
a is a
complex
array of dimension
,
R is a
complex
array of dimension (
n),
v is a
complex
array of dimension
,
work is a
complex
array of length at least
,
lwork is its actual length, and
rwork is a real array of length at least
.
f02bjf
Withdrawn at Mark 23.
Replaced by
f08waf (dggev).
Old: CALL f02bjf(N,A,LDA,B,LDB,EPS1,ALFR,ALFI,BETA,MATV,V,LDV,ITER,IFAIL)
New: IF (MATV) THEN
JOBVR = 'V'
ELSE
JOBVR = 'N'
ENDIF
CALL dggev('N',JOBVR,N,A,LDA,B,LDB,ALFR,ALFI,BETA,VL,LDVL, &
VR,LDVL,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
...
f02eaf
Withdrawn at Mark 23.
Replaced by
f08paf (dgees).
Old: CALL f02eaf(JOB,N,A,LDA,WR,WI,Z,LDZ,WORK,LWORK,IFAIL)
New: LOGICAL SELECT
EXTERNAL SELECT
...
IF (JOB.EQ.'N') THEN
JOBVS = 'N'
ELSE
JOBVS = 'V'
END IF
CALL dgees(JOBVS,'N',SELECT,N,A,LDA,0,WR,WI,Z,LDZ,WORK, &
LWORK,BWORK,INFO)
IF (INFO.EQ.0) THEN
....
LOGICAL FUNCTION SELECT(AR,AI)
REAL (KIND=nag_wp) :: AR, AI
SELECT = .TRUE.
RETURN
ENDK
f02ebf
Withdrawn at Mark 23.
Replaced by
f08naf (dgeev).
Old: CALL f02ebf(JOB,N,A,LDA,WR,WI,VR,LDVR,VI,LDVI,WORK,LWORK, &
IFAIL)
New: IF (JOB.EQ.'N') THEN
JOBVR = 'N'
ELSE
JOBVR = 'V'
END IF
CALL dgeev('N',JOBVR,N,A,LDA,WR,WI,VL,LDVL,VR1,LDVR1, &
WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
! Eigenvector information is stored differently.
! For complex conjugate pairs (that is, corresponding
! to the j-th eigenvector such that WI(j) is nonzero,
! and WI(j) = -WI(j+1)), the real and imaginary parts
! of the first of the pair of eigenvectors are stored
! as consecutive columns of VR1: VR1(:,j), VR1(:,j+1).
! The second in the pair is just the conjugate of the
! first, so can be constructed by negating the
! elements in VR1(:,j+1).
! If the j-th eigenvector is real (WI(j)=0), the
! corresponding real eigenvector is stored in the
! j-th column of VR1, VR1(1:N,j).
f02faf
Withdrawn at Mark 23.
Replaced by
f08faf (dsyev).
Old: CALL f02faf(JOB,UPLO,N,A,LDA,W,WORK,LWORK,IFAIL)
New: CALL dsyev(JOB,UPLO,N,A,LDA,W,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f02fcf
Withdrawn at Mark 23.
Replaced by
f08fbf (dsyevx).
Old: CALL f02fcf(JOB,RANGE,UPLO,N,A,LDA,WL,WU,IL,IU,MEST,M, &
W,Z,LDZ,WORK,LWORK,IWORK,IFAIL)
New: CALL dsyevx(JOB,RANGE,UPLO,N,A,LDA,WL,WU,IL,IU,ABSTOL,M, &
W,Z,LDZ,WORK,LWORK,IWORK,JFAIL,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f02fdf
Withdrawn at Mark 23.
Replaced by
f08saf (dsygv).
Old: CALL f02fdf(ITYPE,JOB,UPLO,N,A,LDA,B,LDB,W,WORK,LWORK,IFAIL)
New: CALL dsygv(ITYPE,JOB,UPLO,N,A,LDA,B,LDB,W,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f02fhf
Withdrawn at Mark 23.
Replaced by
f08uaf (dsbgv).
Old: CALL f02fhf(N,MA,A,LDA,MB,B,LDB,D,WORK,LWORK,IFAIL)
New: CALL dsbgv('N','U',N,MA,MB,A,LDA,B,LDB,D,Z,LDZ,WORK,INFO)
IF (INFO.EQ.0) THEN
...
The order of eigenvalues in D changes from descending to ascending.
The minimum workspace requirement has changed to become
f02gaf
Withdrawn at Mark 23.
Replaced by
f08pnf (zgees).
Old: CALL f02gaf(JOB,N,A,LDA,W,Z,LDZ,RWORK,WORK,LWORK,IFAIL)
New: LOGICAL BWORK(1)
LOGICAL SELECT
EXTERNAL SELECT
...
IF (JOB.EQ.'N') THEN
JOBVS = 'N'
ELSE
JOBVS = 'V'
END IF
CALL zgees(JOBVS,'N',SELECT,N,A,LDA,0,W,Z,LDZ, &
WORK,LWORK,RWORK,BWORK,INFO)
IF (INFO.NE.0) THEN
...
LOGICAL FUNCTION SELECT(C)
COMPLEX*16 C
SELECT = .TRUE.
RETURN
END
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f02gbf
Withdrawn at Mark 23.
Replaced by
f08nnf (zgeev).
Old: CALL f02gbf(JOB,N,A,LDA,W,V,LDV,RWORK,WORK,LWORK,IFAIL)
New: CALL zgeev('N',JOB,N,A,LDA,W,VL,LDVL,V,LDV, &
WORK,LWORK,RWORK,INFO)
IF (INFO.EQ.0) THEN
...
f02gjf
Withdrawn at Mark 23.
Replaced by
f08wnf (zggev).
Old: CALL f02gjf(N,AR,LDAR,AI,LDAI,BR,LDBR,BI,LDBI,EPS1,ALFR, &
ALFI,BETA,MATV,VR,LDVR,VI,LDVI,ITER,IFAIL)
New: IF (MATV) THEN
JOBVR = 'V'
ELSE
JOBVR = 'N'
END IF
! Set A=AR + iAI and B = BR+iBI
CALL zggev('N',JOBVR,N,A,LDA,B,LDB,ALPHA,BETA1,VL,LDVL, &
V,LDV,WORK,LWORK,RWORK,INFO)
IF (INFO.EQ.0) THEN
...
Note that the separated real and imaginary parts of input and output data in
f02gjf has been replaced by combined complex types in
f08wnf (zggev).
f02haf
Withdrawn at Mark 23.
Replaced by
f08fnf (zheev).
Old: CALL f02haf(JOB,UPLO,N,A,LDA,W,RWORK,WORK,LWORK,IFAIL)
New: CALL zheev(JOB,UPLO,N,A,LDA,W,WORK,LWORK,RWORK,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f02hcf
Withdrawn at Mark 23.
Replaced by
f08fpf (zheevx).
Old: CALL f02hcf(JOB,RANGE,UPLO,N,A,LDA,WL,WU,IL,IU,MEST,M, &
W,Z,LDZ,WORK,LWORK,RWORK,IWORK,IFAIL)
New: CALL zheevx(JOB,RANGE,UPLO,N,A,LDA,WL,WU,IL,IU,ABSTOL,M, &
W,Z,LDZ,WORK,LWORK,RWORK,IWORK,JFAIL,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f02hdf
Withdrawn at Mark 23.
Replaced by
f08snf (zhegv).
Old: CALL f02hdf(ITYPE,JOB,UPLO,N,A,LDA,B,LDB,W,RWORK,WORK, &
LWORK,IFAIL)
New: CALL zhegv(ITYPE,JOB,UPLO,N,A,LDA,B,LDB,W,WORK,LWORK, &
RWORK,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f02sdf
Scheduled for withdrawal at Mark 27.
Replaced by
f12agf and
f12fgf.
The replacement routines
f12fgf (symmetric case) and
f12agf (nonsymmetric case) are threaded for parallel execution in multithreaded implementations. These routines are based on the ARPACK package and make calls to BLAS/LAPACK routines. These may be threaded within the vendor library used by the implementation, which provides an additional opportunity for multithreaded performance.
Old: CALL f02sdf(N,MA+1,MB+1,A,LDA,B,LDB,SYM,RELEP,RMU,VEC,D,IWORK,WORK, &
LWORK,IFAIL)
New: LICOMM = 140
LCOMM = 3*N + 3*NCV*NCV + 6*NCV + 60
ALLOCATE (COMM(LCOMM),DR(NCV),DI(NCV),RESID(N),V(N,NCV), &
ICOMM(LICOMM))
! B is symmetric definite:
IF (B_symm_def) THEN
CALL f12aff(N,1,NCV,ICOMM,LICOMM,COMM,LCOMM,IFAIL)
CALL f12adf('Generalized',ICOMM,COMM,IFAIL)
CALL f12adf('Shifted Inverse',ICOMM,COMM,IFAIL)
CALL f12agf(KL,KU,A,LDA,B,LDB,RMU,0.0,NCONV,DR,DI,V,N,RESID, &
V,LDV,COMM,ICOMM,IFAIL)
VEC(1:N) = V(1:N,1)
ELSE
CALL f12aaf(N,NEV,NCV,ICOMM,LICOMM,COMM,LCOMM,IFAIL)
ALLOCATE(C(LDA,N),IPIV(N),X(N),MX(N))
C = A - RMU*B
CALL dgbtrf(N,N,KL,KU,C,LDA,IPIV,INFO)
IREVCM = 0
DO WHILE (IREVCM/=5)
CALL f12abf(IREVCM,RESID,V,LDV,X,MX,NSHIFT,COMM,ICOMM,IFAIL)
IF (IREVCM==-1 .OR. IREVCM==1) THEN
! Perform x <--- OP*x = inv[A-SIGMA*B]*Bx.
CALL dgbmv('N',N,N,KL,KU,ONE,B,LDB,X,1,ZERO,MX,1)
X(1:N) = MX(1:N)
CALL dgbtrs('N',N,KL,KU,1,C,LDA,IPIV,X,N,INFO)
END IF
END DO
! Post-process using f12acf to compute eigenvalue.
CALL F12ACF(NCONV,DR,DI,V,LDV,RMU,0.0,RESID,V,N,COMM,ICOMM,IFAIL)
LR = DR(1)/(DR(1)**2+DI(1)**2) + RMU
END IF
f02wdf
Scheduled for withdrawal at Mark 27.
Replaced by
f02wuf and
f08aef (dgeqrf).
This routine is replaced for multithreaded performance and ability to benefit from vendor library performance (BLAS/LAPACK).
Note: only the multithreaded implementations of F02WDF were able to benefit from parallelism or vendor BLAS/LAPACK performance.
The Householder
factorization part of the functionality can be achieved with
f08aef (dgeqrf). The action
can be computed by a call to
f08agf (dormqr). The orthogonal matrix
can be explicitly constructed, in-place, by a subsequent call to
f08aff (dorgqr).
If the singular value decomposition (SVD) of
is required, the result of
f08aef (dgeqrf) must be fed to
f02wuf, remembering that the first orthogonal matrix of the SVD is called
in
f02wuf and
in
f02wdf
Old: IFAIL = 0
CALL f02wdf(M,N,A,LDA,WANTB,B,TOL,SVD,IRANK,Z,SV,WANTR,R, &
LDR,WANTPT,PT,LDPT,WORK,LWORK,IFAIL)
New: LWORK = -1
CALL dgeqrf(M,N,A,LDA,Z,WORK,LWORK,INFO)
LWORK = ANINT(WORK(1))
DEALLOCATE (WORK)
ALLOCATE (WORK(LWORK))
CALL dgeqrf(M,N,A,LDA,Z,WORK,LWORK,INFO)
NCOLB = 1
IF (WANTB) THEN
CALL dormqr('L','T',M,NCOLB,N,A,LDA,Z,B,M,WORK,LWORK,INFO)
END IF
IF (.NOT. SVD) THEN
! construct Q explicitly, overwrites A
CALL dorgqr(M,M,A,LDA,Z,WORK,LWORK,INFO)
ELSE
! SVD factorization, PT overwrites A
DEALLOCATE (WORK)
ALLOCATE (WORK(5*N))
CALL f02wuf(N,A,LDA,NCOLB,B,M,WANTR,R,LDR,SV,WANTPT,WORK,IFAIL)
! compute rank
IRANK = F06KLF(N,SV,1,TOL)
END IF
f02wef
Withdrawn at Mark 23.
Replaced by
f08kbf (dgesvd).
Old: CALL f02wef(M,N,A,LDA,NCOLB,B,LDB,WANTQ,Q,LDQ,SV,WANTP, &
PT,LDPT,WORK,IFAIL)
New: IF (WANTQ) THEN
JOBU = 'A'
ELSE
JOBU = 'N'
END IF
IF (WANTP) THEN
JOBVT = 'A'
ELSE
JOBVT = 'N'
END IF
LWORK = -1
CALL dgesvd(JOBU,JOBVT,M,N,A,LDA,SV,Q,LDQ,PT,LDPT,WORK,LWORK,INFO)
LWORK = ANINT(WORK(1))
ALLOCATE (W(LWORK))
CALL dgesvd(JOBU,JOBVT,M,N,A,LDA,SV,Q,LDQ,PT,LDPT,W,LWORK,INFO)
DEALLOCATE (W)
work must be a one-dimensional real array of length at least
lwork given by:
Larger values of
lwork, up to some optimal value, may improve performance.
Please note that the facility to return
is not provided so arguments
and
are not required. Instead,
f08kbf (dgesvd) has an option to return the entire
orthogonal matrix
, referred to as
in its documentation, through its 8th argument.
f02xef
Withdrawn at Mark 23.
Replaced by
f08kpf (zgesvd).
Old: CALL f02xef(M,N,A,LDA,NCOLB,B,LDB,WANTQ,Q,LDQ,SV,WANTP, &
PH,LDPH,RWORK,CWORK,IFAIL)
New: IF (WANTQ) THEN
JOBU = 'A'
ELSE
JOBU = 'N'
END IF
IF (WANTP) THEN
JOBVT = 'A'
ELSE
JOBVT = 'N'
END IF
LWORK = -1
CALL zgesvd(JOBU,JOBVT,M,N,A,LDA,SV,Q,LDQ,PT,LDPT,WORK, &
LWORK,RWORK,INFO)
LWORK = ANINT(WORK(1))
ALLOCATE (W(LWORK))
CALL zgesvd(JOBU,JOBVT,M,N,A,LDA,SV,Q,LDQ,PT,LDPT,W, &
LWORK,RWORK,INFO)
DEALLOCATE (W)
work must be a one-dimensional
complex
array of length at least
lwork given by
work must be a one-dimensional real array of length
.
Larger values of
lwork, up to some optimal value, may improve performance.
Please note that the facility to return
is not provided so arguments
wantb
and
are not required. Instead,
f08kpf (zgesvd) has an option to return the entire
unitary matrix
, referred to as
in its documentation, through its 8th argument.
F03 – Determinants
f03aaf
Withdrawn at Mark 25.
Replaced by
f07adf (dgetrf) and
f03baf.
Old: IFAIL = 0
CALL f03aaf(A,LDA,N,DET,WKSPCE,IFAIL)
New: INTEGER IPIV(N)
...
CALL dgetrf(N,N,A,LDA,IPIV,INFO)
IFAIL = 0
CALL f03baf(N,A,LDA,IPIV,D,ID,IFAIL)
DET = D*2**ID
Note: the real array
wkspce has been replaced by the integer array
ipiv for holding the pivots of the factorization.
f03abf
Withdrawn at Mark 25.
Replaced by
f07fdf (dpotrf) and
f03bff.
Old: IFAIL = 0
CALL f03abf(A,LDA,N,DET,WKSPCE,IFAIL)
New: CALL dpotrf('U',N,A,LDA,INFO)
IFAIL = 0
CALL f03bff(N,A,LDA,D,ID,IFAIL)
DET = D*2**ID
Note: the real array
wkspce is no longer required. Also the upper triangular part of
, stored in
a, has been replaced here by its Cholesky factorization; the lower triangular part of
can be used and overwritten by replacing 'U' by 'L' in the call to
dpotrf above.
f03acf
Withdrawn at Mark 25.
Replaced by
f07hdf (dpbtrf) and
f03bhf.
Old: IFAIL = 0
CALL f03acf(A,LDA,N,M,DET,RL,LDRL,M1,IFAIL)
New: CALL dpbtrf('L',N,M,AB,LDAB,INFO)
IFAIL = 0
CALL f03bhf('L',N,KD,AB,LDAB,D,ID,IFAIL)
DET = D*2**ID
Note: the storage of
in arrays
a and
ab is different. In fact
, for
and
which conforms to the LAPACK banded storage scheme. The factorization is returned in
ab rather than in a separate array (
rl). The upper part of matrix
can also be stored in
ab on input to
dpbtrf.
f03adf
Withdrawn at Mark 25.
Replaced by
f07arf (zgetrf) and
f03bnf.
Old: IFAIL = 0
CALL f03adf(A,LDA,N,DETR,DETI,WKSPCE,IFAIL)
New: INTEGER IPIV(N)
...
CALL zgetrf(N,N,A,LDA,IPIV,INFO)
IFAIL = 0
CALL f03bnf(N,A,LDA,IPIV,D,ID,IFAIL)
DETR = REAL(D)*2**ID(1)
DETI = AIMAG(D)*2**ID(2)
Note: the real array
wkspce has been replaced by the integer array
ipiv for holding the pivots of the factorization. The real and imaginary parts of the determinant are independently scaled.
f03aef
Withdrawn at Mark 25.
Replaced by
f07fdf (dpotrf) and
f03bff.
Old: IFAIL = 0
CALL f03aef(N,A,LDA,P,D1,ID,IFAIL)
New: CALL dpotrf('U',N,A,LDA,INFO)
IFAIL = 0
CALL f03bff(N,A,LDA,D1,ID,IFAIL)
Note: the upper triangular part of
, stored in
a, has been replaced here by its Cholesky factorization; the lower triangular part of
can be used and overwritten by replacing
by
in the call to
f07fdf (dpotrf) above.
f03aff
Withdrawn at Mark 25.
Replaced by
f07adf (dgetrf) and
f03baf.
Old: IFAIL = 0
CALL f03aff(N,EPS,A,LDA,D1,ID,P,IFAIL)
New: INTEGER IPIV(N)
...
CALL dgetrf(N,N,A,LDA,IPIV,INFO)
IFAIL = 0
CALL f03baf(N,A,LDA,IPIV,D1,ID,IFAIL)
Note: real array
p has been replaced by the integer array
ipiv for holding the pivots of the factorization.
F04 – Simultaneous Linear Equations
f04aaf
Withdrawn at Mark 23.
Replaced by
f07aaf (dgesv).
Old: CALL f04aaf(A,LDA,B,LDB,N,M,C,LDC,WKSPCE,IFAIL)
New: CALL dgesv(N,M,A,LDA,IPIV,B,LDB,INFO)
IF (INFO.EQ.0) THEN
! Answer now in B
...
f04abf
Scheduled for withdrawal at Mark 28.
Replaced by
f07fbf (dposvx).
f04abf and
f04asf have been replaced by
f07fbf (dposvx) for performance. The replacement routine is threaded by NAG and may also be threaded in the vendor library (BLAS/LAPACK).
Old: CALL f04abf(A,LDA,B,LDB,N,M,C,LDC,WKSPCE,BB,LDBB,IFAIL)
New: CALL f04abf_wrap(a,lda,b,ldb,n,m,c,ldc,wkspce,bb,ldbb,ifail)
Subroutine f04abf_wrap(a,lda,b,ldb,n,m,c,ldc,wkspce,bb,ldbb,ifail)
! .. Use Statements ..
Use nag_library, Only: dposvx, dsymm, nag_wp
! .. Scalar Arguments ..
Integer, Intent (In) :: lda, ldb, ldbb, ldc, m, n
Integer, Intent (Inout) :: ifail
! .. Array Arguments ..
Real (Kind=nag_wp), Intent (Inout) :: a(lda,*), b(ldb,*)
Real (Kind=nag_wp), Intent (Out) :: bb(ldbb,m), c(ldc,m), wkspce(1)
! .. Local Scalars ..
Real (Kind=nag_wp) :: rcond, alpha, beta
Integer :: info, ldaf
Character (1) :: equed
! .. Local Arrays ..
Real (Kind=nag_wp) :: s(1)
Real (Kind=nag_wp), Allocatable :: af(:,:), work(:), ferr(:), berr(:)
Integer, Allocatable :: iwork(:)
ldaf = n
Allocate (af(ldaf,n),ferr(m),berr(m),work(3*n),iwork(n))
! The NAG name equivalent of dposvx is f07fbf
Call dposvx('N','Upper',n,m,a,lda,af,ldaf,equed,s,b,ldb, &
c,ldc,rcond,ferr,berr,work,iwork,info)
ifail = info
bb(1:n,1:m) = b(1:n,1:m)
alpha = -1.0_nag_wp
beta = 1.0_nag_wp
! The NAG name equivalent of dgemm is f06yaf
Call dsymm('L','U',n,m,alpha,a,lda,c,ldc,beta,bb,ldbb)
End Subroutine f04abf_wrap
f04acf
Withdrawn at Mark 23.
Replaced by
f07haf (dpbsv).
Old: CALL f04acf(A,LDA,B,LDB,N,M,IR,C,LDC,RL,LDRL,M1,IFAIL)
New: CALL dpbsv('U',N,M,IR,AB,LDAB,B,LDB,INFO)
IF (INFO.EQ.0) THEN
! A and AB are stored differently.
! AB may be regarded as the transpose of A, with the 'U' option.
! Thus LDAB might be M+1
! Answer now in B
...
f04adf
Withdrawn at Mark 23.
Replaced by
f07anf (zgesv).
Old: CALL f04adf(A,LDA,B,LDB,N,M,C,LDC,WKSPCE,IFAIL)
New: CALL zgesv(N,M,A,LDA,IPIV,B,LDB,INFO)
IF (INFO.EQ.0) THEN
! Answer now in B
...
f04aef
Scheduled for withdrawal at Mark 28.
Replaced by
f07abf (dgesvx).
f04aef and
f04atf have been replaced by
f07abf (dgesvx) for performance. The replacement routine is threaded by NAG and may also be threaded in the vendor library (BLAS/LAPACK).
Old: CALL f04aef(A,LDA,B,LDB,N,M,C,LDC,WKSPCE,AA,LDAA,BB,LDBB,IFAIL)
New: CALL f04aef_wrap(a,lda,b,ldb,n,m,c,ldc,wkspce,aa,ldaa,bb,ldbb,ifail)
Subroutine f04aef_wrap(a,lda,b,ldb,n,m,c,ldc,wkspce,aa,ldaa,bb,ldbb,ifail)
! .. Use Statements ..
Use nag_library, Only: dgesvx, dgemm, nag_wp
! .. Scalar Arguments ..
Integer, Intent (In) :: lda, ldaa, ldb, ldbb, ldc, m, n
Integer, Intent (Inout) :: ifail
! .. Array Arguments ..
Real (Kind=nag_wp), Intent (Inout) :: a(lda,*), b(ldb,*)
Real (Kind=nag_wp), Intent (Out) :: bb(ldbb,m), c(ldc,m), aa(ldaa,n), &
wkspce(1)
! .. Local Scalars ..
Real (Kind=nag_wp) :: rcond, alpha, beta
Integer :: info
Character (1) :: equed
! .. Local Arrays ..
Real (Kind=nag_wp) :: cscl(1), rscl(1)
Real (Kind=nag_wp), Allocatable :: work(:), ferr(:), berr(:)
Integer, Allocatable :: ipiv(:), iwork(:)
Allocate (berr(m),ferr(m),work(4*n),ipiv(n),iwork(n))
! The NAG name equivalent of dgesvx is f07abf
Call dgesvx('N','N',n,m,a,lda,aa,ldaa,ipiv,equed,rscl,cscl,b,ldb, &
c,ldc,rcond,ferr,berr,work,iwork,info)
ifail = info
bb(1:n,1:m) = b(1:n,1:m)
alpha = -1.0_nag_wp
beta = 1.0_nag_wp
! The NAG name equivalent of dgemm is f06yaf
Call dgemm('N','N',n,m,n,alpha,a,lda,c,ldc,beta,bb,ldbb)
End Subroutine f04aef_wrap
f04aff
Withdrawn at Mark 25.
There is no replacement for this routine.
The factorization and solution of a positive definite linear system can be handled by calls to routines from
Chapter F07, e.g.,
f07fbf (dposvx).
For example:
Old: IFAIL = 0
CALL f03aef(N,A,LDA,P,D1,ID,IFAIL)
CALL f04aff(N,NRHS,A,LDA,P,B,LDB,EPS,X,LDX,BB,LDBB,K,IFAIL)
New: CALL dposvx('equil','upper',N,NRHS,A,LDA,AF,LDAF,'Yes',P,B, &
LDB,X,LDX,RCOND,FERR,BERR,WORK,IWORK,INFO)
IFAIL = 0
CALL f03bff(N,A,LDA,D1,ID,IFAIL)
f04agf
Withdrawn at Mark 25.
There is no replacement for this routine.
The factorization and solution of a positive definite linear system can be handled by calls to routines from
Chapter F07, e.g.,
f07faf (dposv).
For example:
Old: IFAIL = 0
CALL f03aef(N,A,LDA,P,D1,ID,IFAIL)
CALL f04agf(N,NRHS,A,LDA,P,B,LDB,X,LDX)
New: CALL dposv('upper',N,NRHS,A,LDA,B,LDB,INFO)
IFAIL = 0
CALL f03bff(N,A,LDA,D1,ID,IFAIL)
f04ahf
Withdrawn at Mark 25.
There is no replacement for this routine.
The factorization and solution of a real general linear system can be handled by calls to routines from the
Chapter F07, e.g.,
f07abf (dgesvx).
For example:
Old: IFAIL = 0
CALL f03aff(N,EPS,A,LDA,D1,ID,P,IFAIL)
CALL f04ahf(N,NRHS,A,LDA,AA,LDAA,P,B,LDB,EPS,X,LDX,BB, &
LDBB,K,IFAIL)
New: CALL dgesvx('Equil','No trans',N,NRHS,A,LDA,AA,LDAA,IPIV, &
'Yes',R,C,B,LDB,X,LDX,RCOND,FERR,BERR,WORK, &
IWORK,INFO)
IFAIL = 0
CALL f03baf(N,A,LDA,IPIV,D1,ID,IFAIL)
f04ajf
Withdrawn at Mark 25.
There is no replacement for this routine.
The factorization and solution of a real general linear system can be handled by calls to routines from
Chapter F07, e.g.,
f07aaf (dgesv).
For example:
Old: IFAIL = 0
CALL f03aff(N,EPS,A,LDA,D1,ID,P,IFAIL)
CALL f04ajf(N,NRHS,A,LDA,P,B,LDB)
New: CALL dgesv(N,NRHS,A,LDA,IPIV,B,LDB,INFO)
IFAIL = 0
CALL f03baf(N,A,LDA,IPIV,D1,ID,IFAIL)
f04arf
Withdrawn at Mark 23.
Replaced by
f07aaf (dgesv).
Old: CALL f04arf(A,LDA,B,N,C,WKSPCE,IFAIL)
New: CALL dgesv(N,1,A,LDA,IPIV,B,N,INFO)
IF (INFO.EQ.0) THEN
! Answer now in B
...
f04asf
Scheduled for withdrawal at Mark 28.
Replaced by
f07fbf (dposvx).
f04abf and
f04asf have been replaced by
f07fbf (dposvx) for performance. The replacement routine is threaded by NAG and may also be threaded in the vendor library (BLAS/LAPACK).
Old: CALL f04asf(A,LDA,B,N,C,WK1,WK2,IFAIL)
New: CALL f04asf_wrap(a,lda,b,n,c,wk1,wk2,ifail)
Subroutine f04asf_wrap(a,lda,b,n,c,wk1,wk2,ifail)
! .. Use Statements ..
Use nag_library, Only: dposvx, nag_wp
! .. Scalar Arguments ..
Integer, Intent (In) :: lda, n
Integer, Intent (Inout) :: ifail
! .. Array Arguments ..
Real (Kind=nag_wp), Intent (Inout) :: a(lda,n), b(n)
Real (Kind=nag_wp), Intent (Out) :: c(n), wk1(1), wk2(1)
! .. Local Scalars ..
Real (Kind=nag_wp) :: rcond
Integer :: info, ldaf, m
Character (1) :: equed
! .. Local Arrays ..
Real (Kind=nag_wp) :: s(1), ferr(1), berr(1)
Real (Kind=nag_wp), Allocatable :: af(:,:), work(:)
Integer, Allocatable :: iwork(:)
ldaf = n
m = 1
Allocate (af(ldaf,n),work(3*n),iwork(n))
! The NAG name equivalent of dposvx is f07fbf
Call dposvx('N','Upper',n,m,a,lda,af,ldaf,equed,s,b,n, &
c,n,rcond,ferr,berr,work,iwork,info)
wk1(1) = rcond
wk2(1) = berr(1)
ifail = info
End Subroutine f04asf_wrap
f04atf
Scheduled for withdrawal at Mark 28.
Replaced by
f07abf (dgesvx).
f04aef and
f04atf have been replaced by
f07abf (dgesvx) for performance. The replacement routine is threaded by NAG and may also be threaded in the vendor library (BLAS/LAPACK).
Old: Call f04atf(A,LDA,B,N,C,AA,LDAA,WKS1,WKS2,IFAIL)
New: CALL f04atf_wrap(a,lda,b,n,c,aa,ldaa,wks1,wks2,ifail)
Subroutine f04atf_wrap(a,lda,b,n,c,aa,ldaa,wks1,wks2,ifail)
! .. Use Statements ..
Use nag_library, Only: dgesvx, nag_wp
! .. Scalar Arguments ..
Integer, Intent (In) :: lda, ldaa, n
Integer, Intent (Inout) :: ifail
! .. Array Arguments ..
Real (Kind=nag_wp), Intent (Inout) :: a(lda,*), b(n)
Real (Kind=nag_wp), Intent (Out) :: c(n), aa(ldaa,n), wks1(1),
wks2(1)
! .. Local Scalars ..
Real (Kind=nag_wp) :: rcond
Integer :: info, m
Character (1) :: equed
! .. Local Arrays ..
Real (Kind=nag_wp) :: cscl(1), rscl(1), ferr(1),
berr(1)
Real (Kind=nag_wp), Allocatable :: work(:)
Integer, Allocatable :: ipiv(:), iwork(:)
m = 1
Allocate (work(4*n),ipiv(n),iwork(n))
! The NAG name equivalent of dgesvx is f07abf
Call dgesvx('N','N',n,m,a,lda,aa,ldaa,ipiv,equed,rscl,cscl,b,n, &
c,n,rcond,ferr,berr,work,iwork,info)
ifail = info
wks1(1) = rcond
wks2(1) = berr(1)
End Subroutine f04atf_wrap
f04eaf
Withdrawn at Mark 23.
Replaced by
f07caf (dgtsv).
Old: CALL f04eaf(N,D,DU,DL,B,IFAIL)
New: CALL dgtsv(N,1,DL(2),D,DU(2),B,N,INFO)
IF (INFO.EQ.0) THEN
! Answer now in B
...
f04faf
Withdrawn at Mark 23.
Replaced by
f07jaf (dptsv), or
f07jdf (dpttrf) and
f07jef (dpttrs).
Old: CALL f04faf(JOB,N,D,E,B,IFAIL)
New: CALL dptsv(N,1,D,E(2),B,1,INFO)
...
f04jaf
Withdrawn at Mark 23.
Replaced by
f08kaf (dgelss).
Old: CALL f04jaf(M,N,A,LDA,B,TOL,SIGMA,IRANK,WORK,LWORK,IFAIL)
New: CALL dgelss(M,N,1,A,LDA,B,1,S,RCOND,IRANK,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
! Answer now in B
! Singular values now in S, not WORK.
! The standard error is not computed
...
The minimum workspace requirement has changed from to .
f04jdf
Withdrawn at Mark 23.
Replaced by
f08kaf (dgelss).
Old: CALL f04jdf(M,N,A,LDA,B,TOL,SIGMA,IRANK,WORK,LWORK,IFAIL)
New: CALL dgelss(M,N,1,A,LDA,B,1,S,RCOND,IRANK,WORK,LWORK,INFO)
! Note workspace requirements are different.
IF (INFO.EQ.0) THEN
! Answer now in B
! Singular values now in S, not WORK.
! The standard error is not computed
...
The minimum workspace requirement has changed from to .
f04jlf
Withdrawn at Mark 23.
Replaced by
f08zbf (dggglm).
Old: CALL f04jlf(M,N,P,A,LDA,B,LDB,D,X,Y,WORK,LWORK,IFAIL)
New: CALL dggglm(M,N,P,A,LDA,B,LDB,D,X,Y,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f04jmf
Withdrawn at Mark 23.
Replaced by
f08zaf (dgglse).
Old: CALL f04jmf(M,N,P,A,LDA,B,LDB,C,D,X,WORK,LWORK,IFAIL)
New: CALL dgglse(M,N,P,A,LDA,B,LDB,C,D,X,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
...
The minimum workspace requirement has not increased but the requirement for optimal performance might be different. The workspace query mechanism () should be used to determine the requirement for optimal performance.
f04klf
Withdrawn at Mark 23.
Replaced by
f08zpf (zggglm).
Old: CALL f04klf(M,N,P,A,LDA,B,LDB,D,X,Y,WORK,LWORK,IFAIL)
New: CALL zggglm(M,N,P,A,LDA,B,LDB,D,X,Y,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
...
f04kmf
Withdrawn at Mark 23.
Replaced by
f08znf (zgglse).
Old: CALL f04kmf(M,N,P,A,LDA,B,LDB,C,D,X,WORK,LWORK,IFAIL)
New: CALL zgglse(M,N,P,A,LDA,B,LDB,C,D,X,WORK,LWORK,INFO)
IF (INFO.EQ.0) THEN
...
f04maf
Withdrawn at Mark 19.
Replaced by
f11jcf.
Existing programs should be modified to call
f11jcf. The interfaces are significantly different and therefore precise details of a replacement call cannot be given. Please consult the appropriate routine document.
f04mbf
Withdrawn at Mark 19.
Replaced by
f11gdf,
f11gef and
f11gff (or
f11jcf or
f11jef).
If a user-defined preconditioner is required existing programs should be modified to call
f11gdf,
f11gef and
f11gff. Otherwise
f11jcf or
f11jef may be used. The interfaces for these routines are significantly different from that for
f04mbf and therefore precise details of a replacement call cannot be given. Please consult the appropriate routine document.
f04ycf
Withdrawn at Mark 26.
Replaced by
f04ydf.
f04ydf employs a better algorithm (see Higham N J and Tisseur F (2000) A block algorithm for matrix
-norm estimation, with an application to
-norm pseudospectra
SIAM J. Matrix. Anal. Appl. 21 1185–1201).
Old: CALL f04ycf(ICASE,N,X,ESTNRM,WORK,IWORK,IFAIL)
New: CALL f04ydf(IREVCM,M,N,X,LDX,Y,LDY,ESTNRM,T,SEED,WORK,IWORK,IFAIL)
f04ydf returns an estimate of the
-norm of a rectangular
matrix, whereas
f04ycf only works with square matrices. The real array X, which was previously used to return matrix–vector products to
f04ycf, has been replaced with two real arrays
and
which are used to return matrix-matrix products to
f04ydf. Here,
,
and the second dimensions of
x and
y are at least of size
t, where you can choose argument
t. The sizes of the workspace arrays
work and
iwork have been increased to
and
respectively. The integer
seed provides a seed for the random number generator used by
f04ydf. The integer
icase has been replaced by
irevcm, which can take the values
,
or
. See the routine documentation for
f04ydf further details about the reverse communication interface.
f04zcf
Withdrawn at Mark 26.
Replaced by
f04zdf.
f04zdf employs a better algorithm (see Higham N J and Tisseur F (2000) A block algorithm for matrix
-norm estimation, with an application to
-norm pseudospectra
SIAM J. Matrix. Anal. Appl. 21 1185–1201).
Old: CALL f04zcf(ICASE,N,X,ESTNRM,WORK,IFAIL)
New: CALL f04zdf(IREVCM,M,N,X,LDX,Y,LDY,ESTNRM,T,SEED,WORK,RWORK,IWORK,IFAIL)
f04zdf returns an estimate of the
-norm of a rectangular
matrix, whereas f04zcf only works with square matrices. The complex array X, which was previously used to return matrix–vector products to
f04zcf, has been replaced with two complex arrays
and
which are used to return matrix-matrix products to
f04zdf. Here,
,
and the second dimensions of
x and
y are at least of size
t, where you can choose the argument
t. The sizes of the workspace arrays
work and
iwork have been increased to
and
respectively and there is an additional real workspace array
rwork of size
. The integer
seed provides a seed for the random number generator used by
f04zdf. The integer
icase has been replaced by
irevcm, which can take the values
,
or
. See the routine documentation for
f04zdf for further details about the reverse communication interface.
F11 – Large Scale Linear Systems
f11baf
Withdrawn at Mark 21.
Replaced by
f11bdf.
Old: CALL f11baf(METHOD,PRECON,NORM,WEIGHT,ITERM,N,M,TOL,MAXITN, &
ANORM,SIGMAX,MONIT,LWREQ,IFAIL)
New: CALL f11bdf(METHOD,PRECON,NORM,WEIGHT,ITERM,N,M,TOL,MAXITN, &
ANORM,SIGMAX,MONIT,WORK,LWORK,LWREQ,IFAIL)
f11bdf contains two additional arguments as follows:
See the routine document for further information.
f11bbf
Withdrawn at Mark 21.
Replaced by
f11bef.
Old: CALL f11bbf(IREVCM,U,V,WORK,LWORK,IFAIL)
New: CALL f11bef(IREVCM,U,V,WGT,WORK,LWORK,IFAIL)
wgt must be a one-dimensional real array of length at least
(the order of the matrix) if weights are to be used in the termination criterion, and
otherwise. Note that the call to
f11bef requires the weights to be supplied in
rather than
. The minimum value of the argument
lwork may also need to be changed.
f11bcf
Withdrawn at Mark 21.
Replaced by
f11bff.
Old: CALL f11bcf(ITN,STPLHS,STPRHS,ANORM,SIGMAX,IFAIL)
New: CALL f11bff(ITN,STPLHS,STPRHS,ANORM,SIGMAX,WORK,LWORK,IFAIL)
f11bff contains two additional arguments as follows:
- – real array.
- lwork – integer.
See the routine document for further information.
f11gaf
Withdrawn at Mark 22.
Replaced by
f11gdf.
Old: CALL f11gaf(METHOD,PRECON,SIGCMP,NORM,WEIGHT,ITERM,N,TOL,MAXITN, &
ANORM,SIGMAX,SIGTOL,MAXITS,MONIT,LWREQ,IFAIL)
New: CALL f11gdf(METHOD,PRECON,SIGCMP,NORM,WEIGHT,ITERM,N,TOL,MAXITN, &
ANORM,SIGMAX,SIGTOL,MAXITS,MONIT,LWREQ,WORK,LWORK,IFAIL)
f11gdf contains two additional arguments as follows:
- – real array.
- lwork – integer.
See the routine document for further information.
f11gbf
Withdrawn at Mark 22.
Replaced by
f11gef.
Old: CALL f11gbf(IREVCM,U,V,WORK,LWORK,IFAIL)
New: CALL f11gef(IREVCM,U,V,WGT,WORK,LWORK,IFAIL)
wgt must be a one-dimensional real array of length at least
(the order of the matrix) if weights are to be used in the termination criterion, and
otherwise. Note that the call to
f11gef requires the weights to be supplied in
rather than
. The minimum value of the argument
lwork may also need to be changed.
f11gcf
Withdrawn at Mark 22.
Replaced by
f11gff.
Old: CALL f11gcf(ITN,STPLHS,STPRHS,ANORM,SIGMAX,ITS,SIGERR,IFAIL)
New: CALL f11gff(ITN,STPLHS,STPRHS,ANORM,SIGMAX,ITS,SIGERR, &
WORK,LWORK,IFAIL)
f11gff contains two additional arguments as follows:
- – real array.
- lwork – integer.
See the routine document for further information.
G01 – Simple Calculations on Statistical Data
g01aaf
Withdrawn at Mark 26.
Replaced by
g01atf.
Withdrawn because on output, additional information was needed to allow large datasets to be processed in blocks and the results combined through a call to
g01auf. This information is returned in
rcomm.
Old:
CALL g01aaf(N,X,IWT,WT,XMEAN,S2,S3,S4,XMIN,XMAX,WTSUM,IFAIL)
New:
PN = 0
CALL g01atf(N,X,IWT,WT,PN,XMEAN,S2,S3,S4,XMIN,XMAX,RCOMM,IFAIL)
IWT = PN
WTSUM = RCOMM(1)
g01agf
Scheduled for withdrawal at Mark 27.
There is no replacement for this routine.
g01ahf
Scheduled for withdrawal at Mark 27.
There is no replacement for this routine.
g01ajf
Scheduled for withdrawal at Mark 27.
There is no replacement for this routine.
G05 – Random Number Generators
g05caf
Withdrawn at Mark 22.
Replaced by
g05saf.
Old: DO 20 I = 1, N
X(I) = g05caf(X(I))
20 CONTINUE
New: CALL g05saf(N,STATE,X,IFAIL)
The integer array
state in the call to
g05saf contains information on the base generator being used. This array must have been initialized prior to calling
g05saf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05saf is likely to be different from those produced by
g05caf.
g05cbf
Withdrawn at Mark 22.
Replaced by
g05kff.
Old: CALL g05cbf(I)
New: LSEED = 1
SEED(1) = I
GENID = 1
SUBID = 1
CALL g05kff(GENID,SUBID,SEED,LSEED,STATE,LSTATE,IFAIL)
The integer array
state in the call to
g05kff contains information on the base generator being used. The base generator is chosen via the integer arguments
genid and
subid. The required length of the array
state depends on the base generator chosen. Due to changes in the underlying code a sequence of values produced by using a random number generator initialized via a call to
g05kff is likely to be different from a sequence produced by a generator initialized by
g05cbf, even if the same value for
I is used.
g05ccf
Withdrawn at Mark 22.
Replaced by
g05kgf.
Old: CALL g05ccf
New: GENID = 1
SUBID = 1
CALL g05kgf(GENID,SUBID,STATE,LSTATE,IFAIL)
The integer array
state in the call to
g05kgf contains information on the base generator being used. The base generator is chosen via the integer arguments
genid and
subid. The required length of the array
state depends on the base generator chosen.
g05cff
Withdrawn at Mark 22.
Replaced by
f06dff.
Old: CALL g05cff(IA,NI,XA,NX,IFAIL)
New: LSTATE = STATE(1)
CALL f06dff(LSTATE,STATE,1,CSTATE,1)
The state of the base generator for the group of routines
g05kff,
g05kgf,
g05khf,
g05kjf,
g05ncf,
g05ndf,
g05pdf–
g05pzf,
g05rcf–
g05rzf, G05S and G05T can be saved by simply creating a local copy of the array
state. The first element of the
state array contains the number of elements that are used by the random number generating routines, therefore either this number of elements can be copied, or the whole array (as defined in the calling program).
g05cgf
Withdrawn at Mark 22.
Replaced by
f06dff.
Old: CALL g05cgf(IA,NI,XA,NX,IFAIL)
New: LSTATE = CSTATE(1)
CALL f06dff(LSTATE,CSTATE,1,STATE,1)
The state of the base generator for the group of routines
g05kff,
g05kgf,
g05khf,
g05kjf,
g05ncf,
g05ndf,
g05pdf–
g05pzf,
g05rcf–
g05rzf, G05S and G05T can be restored by simply copying back the previously saved copy of the
state array. The first element of the
state array contains the number of elements that are used by the random number generating routines, therefore either this number of elements can be copied, or the whole array (as defined in the calling program).
g05daf
Withdrawn at Mark 22.
Replaced by
g05sqf.
Old: DO 10 I = 1, N
X(I) = g05daf(AA,BB)
10 CONTINUE
New: A = MIN(AA,BB)
B = MAX(AA,BB)
IFAIL = 0
CALL g05sqf(N,A,B,STATE,X,IFAIL)
The old routine
g05daf returns a single variate at a time, whereas the new routine
g05sqf returns a vector of
n values in one go. In
g05sqf the minimum value must be held in the argument
a and the maximum in argument
b, therefore
. This was not the case for the equivalent arguments in
g05daf.
The integer array
state in the call to
g05sqf contains information on the base generator being used. This array must have been initialized prior to calling
g05sqf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05sqf is likely to be different from those produced by
g05daf.
g05dbf
Withdrawn at Mark 22.
Replaced by
g05sff.
Old: DO 10 I = 1, N
X(I) = g05dbf(AA)
10 CONTINUE
New: A = ABS(AA)
IFAIL = 0
CALL g05sff(N,A,STATE,X,IFAIL)
The old routine
g05dbf returns a single variate at a time, whereas the new routine
g05sff returns a vector of
n values in one go. In
g05sff argument
a must be non-negative, this was not the case for the equivalent argument in
g05dbf.
The integer array
state in the call to
g05sff contains information on the base generator being used. This array must have been initialized prior to calling
g05sff with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05sff is likely to be different from those produced by
g05dbf.
g05dcf
Withdrawn at Mark 22.
Replaced by
g05slf.
Old: DO 10 I = 1, N
X(I) = g05dcf(A,BB)
10 CONTINUE
New: B = ABS(BB)
IFAIL = 0
CALL g05slf(N,A,B,STATE,X,IFAIL)
The old routine
g05dcf returns a single variate at
a time, whereas the new routine
g05slf returns a
vector of
n values in one go. In
g05slf the spread (argument
a) must be positive, this was not the case for the equivalent arguments
in
g05dcf.
The integer array
state in the call to
g05slf
contains information on the base generator being used. This array must have
been initialized prior to calling
g05slf with a call
to either
g05kff or
g05kgf.
The required length of the array
state
will depend on the base generator chosen during initialization.
Due to changes
in the underlying code the sequence of values produced by
g05slf is likely to be different from those produced by
g05dcf.
g05ddf
Withdrawn at Mark 22.
Replaced by
g05skf.
Old: DO 10 I = 1, N
X(I) = g05ddf(XMU,SD)
10 CONTINUE
New: VAR = SD**2
IFAIL = 0
CALL g05skf(N,XMU,VAR,STATE,X,IFAIL)
The old routine
g05ddf returns a single variate at
a time, whereas the new routine
g05skf returns a
vector of
n values in one go.
g05skf expects the variance of the Normal distribution
(argument
var), compared to
g05ddf which expected the standard deviation.
The
integer array
state in the call to
g05skf contains information on the base generator being
used. This array must have been initialized prior to calling
g05skf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during
initialization.
Due to changes in the underlying code the sequence of values
produced by
g05skf is likely to be different from those
produced by
g05ddf.
g05def
Withdrawn at Mark 22.
Replaced by
g05smf.
Old: DO 10 I = 1, N
X(I) = g05def(XMU,SD)
10 CONTINUE
New: VAR = SD**2
IFAIL = 0
CALL g05smf(N,XMU,VAR,STATE,X,IFAIL)
The old routine
g05def returns a single variate at
a time, whereas the new routine
g05smf returns a
vector of
n values in one go.
g05smf expects the variance of the corresponding Normal
distribution (argument
var), compared
to
g05def which expected the standard deviation.
The integer array
state in the call
to
g05smf contains information on the base generator
being used. This array must have been initialized prior to calling
g05smf with a call to either
g05kff
or
g05kgf.
The required length of the array
state will depend on the base generator chosen
during initialization.
Due to changes in the underlying code the sequence of
values produced by
g05smf is likely to be different from
those produced by
g05def.
g05dff
Withdrawn at Mark 22.
Replaced by
g05scf.
Old: DO 10 I = 1, N
X(I) = g05dff(XMED,B)
10 CONTINUE
New: SEMIQR = ABS(B)
IFAIL = 0
CALL g05scf(N,XMED,SEMIQR,STATE,X,IFAIL)
The old routine
g05dff returns a single variate at
a time, whereas the new routine
g05scf returns a
vector of
n values in one go.
g05scf expects the semi-interquartile range (argument
semiqr) to be non-negative, this was not the
case for the equivalent argument in
g05dff.
The integer array
state in the call
to
g05scf contains information on the base generator
being used. This array must have been initialized prior to calling
g05scf with a call to either
g05kff
or
g05kgf.
The required length of the array
state will depend on the base generator chosen
during initialization.
Due to changes in the underlying code the sequence of
values produced by
g05scf is likely to be different from
those produced by
g05dff.
g05dhf
Withdrawn at Mark 22.
Replaced by
g05sdf.
Old: DO 10 I = 1, N
X(I) = g05dhf(DF,IFAIL)
10 CONTINUE
New: CALL g05sdf(N,DF,STATE,X,IFAIL)
The old routine
g05dhf returns a single variate at
a time, whereas the new routine
g05sdf returns a
vector of
n values in one go.
The
integer array
state in the call to
g05sdf contains information on the base generator being
used. This array must have been initialized prior to calling
g05sdf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during
initialization.
Due to changes in the underlying code the sequence of values
produced by
g05sdf is likely to be different from those
produced by
g05dhf.
g05djf
Withdrawn at Mark 22.
Replaced by
g05snf.
Old: DO 10 I = 1, N
X(I) = g05djf(DF,IFAIL)
10 CONTINUE
New: CALL g05snf(N,DF,STATE,X,IFAIL)
The old routine
g05djf returns a single variate at
a time, whereas the new routine
g05snf returns a
vector of
n values in one go.
The
integer array
state in the call to
g05snf contains information on the base generator being
used. This array must have been initialized prior to calling
g05snf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during
initialization.
Due to changes in the underlying code the sequence of values
produced by
g05snf is likely to be different from those
produced by
g05djf.
g05dkf
Withdrawn at Mark 22.
Replaced by
g05shf.
Old: DO 10 I = 1, N
X(I) = g05dkf(DF1,DF2,IFAIL)
10 CONTINUE
New: CALL g05shf(N,DF1,DF2,STATE,X,IFAIL)
The old routine
g05dkf returns a single variate at
a time, whereas the new routine
g05shf returns a
vector of
n values in one go.
The
integer array
state in the call to
g05shf contains information on the base generator being
used. This array must have been initialized prior to calling
g05shf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during
initialization.
Due to changes in the underlying code the sequence of values
produced by
g05shf is likely to be different from those
produced by
g05dkf.
g05dpf
Withdrawn at Mark 22.
Replaced by
g05ssf.
Old: DO 10 I = 1, N
X(I) = g05dpf(A,B,IFAIL)
10 CONTINUE
New: CALL g05ssf(N,A,B,STATE,X,IFAIL)
The old routine
g05dpf returns a single variate at
a time, whereas the new routine
g05ssf returns a
vector of
n values in one go.
The
integer array
state in the call to
g05ssf contains information on the base generator being
used. This array must have been initialized prior to calling
g05ssf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during
initialization.
Due to changes in the underlying code the sequence of values
produced by
g05ssf is likely to be different from those
produced by
g05dpf.
g05drf
Withdrawn at Mark 22.
Replaced by
g05tkf.
Old: DO 10 I = 1, N
X(I) = g05drf(LAMDA,IFAIL)
10 CONTINUE
New: MODE = 3
CALL g05tjf(MODE,N,LAMBDA,R,LR,STATE,X,IFAIL)
The old routine
g05drf returns a single variate at
a time, whereas the new routine
g05tjf returns a
vector of
n values in one go. For
efficiency, the new routine can make use of a reference vector,
r. If, as in this case, the integer argument
mode is set to 3, the real reference
vector
r is not
referenced, and its
length,
lr, need only be at least
one.
The integer array
state in
the call to
g05tjf contains information on the base
generator being used. This array must have been initialized prior to calling
g05tjf with a call to either
g05kff or
g05kgf.
The required length of the
array
state will depend on the base
generator chosen during initialization.
Due to changes in the underlying code
the sequence of values produced by
g05tjf is likely to
be different from those produced by
g05drf.
g05dyf
Withdrawn at Mark 22.
Replaced by
g05tlf.
Old: DO 10 I = 1, N
X(I) = g05dyf(AA,BB)
10 CONTINUE
New: IFAIL = 0
A = MIN(AA,BB)
B = MAX(AA,BB)
CALL g05tlf(N,A,B,STATE,X,IFAIL)
The old routine
g05dyf returns a single variate at a time, whereas the new routine
g05tlf returns a vector of
n values in one go. In
g05tlf the minimum value must be held in the argument
a and the maximum in argument
b, therefore
. This was not the case for the equivalent arguments in
g05dyf.
The integer array
state in the call to
g05tlf contains information on the base generator being used. This array must have been initialized prior to calling
g05tlf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05tlf is likely to be different from those produced by
g05dyf.
g05dzf
Withdrawn at Mark 22.
Replaced by
g05tbf.
Old: DO 20 I = 1, N
X(I) = g05dzf(PP)
20 CONTINUE
New: P = MAX(0.0D0,MIN(PP,1.0D0))
IFAIL = 0
CALL g05tbf(N,P,STATE,X,IFAIL)
The old routine
g05dzf returns a single variate at
a time, whereas the new routine
g05tbf returns a
vector of
n values in one go. The
real argument
p in
g05tbf must not be less than zero or greater than one, this was not the
case for the equivalent argument in
g05dzf.
The integer array
state in the call
to
g05tbf contains information on the base generator
being used. This array must have been initialized prior to calling
g05tbf with a call to either
g05kff
or
g05kgf.
The required length of the array
state will depend on the base generator chosen
during initialization.
Due to changes in the underlying code the sequence of
values produced by
g05tbf is likely to be different from
those produced by
g05dzf.
g05eaf
Withdrawn at Mark 22.
Replaced by
g05rzf.
Old: CALL g05eaf(XMU,M,C,LDC,EPS,R1,LR1,IFAIL)
New: MODE = 0
CALL g05rzf(MODE,N,M,XMU,C,LDC,R,LR,STATE,X,LDX,IFAIL)
The old routine
g05eaf sets up a reference vector for use by
g05ezf. The functionality of both these routines has been combined into the single new routine
g05rzf. Setting
in the call to
g05rzf only sets up the real reference vector
r and hence mimics the functionality of
g05eaf.
The length of the real reference vector,
r, in
g05rzf must be at least
. In contrast to the equivalent argument in
g05eaf, this array must be allocated in the calling program.
g05ebf
Withdrawn at Mark 22.
Replaced by
g05tlf.
There is no direct replacement for routine
g05ebf.
g05ebf sets up a reference vector for use by
g05eyf, this reference vector is no longer required. The replacement routine for
g05eyf is
g05tlf.
g05ecf
Withdrawn at Mark 22.
Replaced by
g05tjf.
Old: CALL g05ecf(LAMBDA,R1,LR1,IFAIL)
DO 10 I = 1, N
X(I) = g05eyf(R1,LR1)
10 CONTINUE
New: MODE = 2
CALL g05tjf(MODE,N,LAMBDA,R,LR,STATE,X,IFAIL)
The old routine
g05ecf sets up a reference vector for use by
g05eyf. The replacement routine
g05tjf is now used to both set up a reference vector and generate the required variates. Setting
in the call to
g05tjf sets up the real reference vector
r and hence mimics the functionality of
g05ecf. Setting
generates a series of variates from a reference vector mimicking the functionality of
g05eyf for this particular distribution. Setting
initializes the reference vector and generates the variates in one go.
The routine
g05eyf returns a single variate at a time, whereas the new routine
g05tjf returns a vector of
n values in one go.
The length of the real reference vector,
r, in
g05tjf, must be allocated in the calling program in contrast to the equivalent argument in
g05ecf, see the documentation for more details.
The integer array
state in the call to
g05tjf contains information on the base generator being used. This array must have been initialized prior to calling
g05tjf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05tjf is likely to be different from those produced by a combination of
g05ecf and
g05eyf.
g05edf
Withdrawn at Mark 22.
Replaced by
g05taf.
Old: CALL g05edf(M,P,R1,LR1,IFAIL)
DO 10 I = 1, N
X(I) = g05eyf(R1,LR1)
10 CONTINUE
New: MODE = 2
CALL g05taf(MODE,N,M,P,R,LR,STATE,X,IFAIL)
The old routine
g05edf sets up a reference vector for use by
g05eyf. The replacement routine
g05taf is now used to both set up a reference vector and generate the required variates. Setting
in the call to
g05taf sets up the real reference vector
r and hence mimics the functionality of
g05edf. Setting
generates a series of variates from a reference vector mimicking the functionality of
g05eyf for this particular distribution. Setting
initializes the reference vector and generates the variates in one go.
The routine
g05eyf returns a single variate at a time, whereas the new routine
g05taf returns a vector of
n values in one go.
The length of the real reference vector,
r, in
g05taf, needs to be a different length from the equivalent argument in
g05edf, see the documentation for more details.
The integer array
state in the call to
g05taf contains information on the base generator being used. This array must have been initialized prior to calling
g05taf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05taf is likely to be different from those produced by a combination of
g05edf and
g05eyf.
g05eef
Withdrawn at Mark 22.
Replaced by
g05thf.
Old: CALL g05eef(M,P,R1,LR1,IFAIL)
DO 10 I = 1, N
X(I) = g05eyf(R1,LR1)
10 CONTINUE
New: MODE = 2
CALL g05thf(MODE,N,M,P,R,LR,STATE,X,IFAIL)
The old routine
g05eef sets up a reference vector for use by
g05eyf. The replacement routine
g05thf is now used to both set up a reference vector and generate the required variates. Setting
in the call to
g05thf sets up the real reference vector
r and hence mimics the functionality of
g05eef. Setting
generates a series of variates from a reference vector mimicking the functionality of
g05eyf for this particular distribution. Setting
initializes the reference vector and generates the variates in one go.
The routine
g05eyf returns a single variate at a time, whereas the new routine
g05thf returns a vector of
n values in one go.
The length of the real reference vector,
r, in
g05thf, needs to be a different length from the equivalent argument in
g05eef, see the documentation for
g05thf for more details.
The integer array
state in the call to
g05thf contains information on the base generator being used. This array must have been initialized prior to calling
g05thf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05thf is likely to be different from those produced by a combination of
g05eef and
g05eyf.
g05eff
Withdrawn at Mark 22.
Replaced by
g05tef.
Old: CALL g05eff(NS,M,NP,R1,LR1,IFAIL)
DO 10 I = 1, N
X(I) = g05eyf(R1,LR1)
10 CONTINUE
New: MODE = 2
CALL g05tef(MODE,N,NS,NP,M,R,LR,STATE,X,IFAIL)
The old routine
g05eff sets up a reference vector for use by
g05eyf. The replacement routine
g05tef is now used to both set up a reference vector and generate the required variates. Setting
in the call to
g05tef sets up the real reference vector
r and hence mimics the functionality of
g05eff. Setting
generates a series of variates from a reference vector mimicking the functionality of
g05eyf for this particular distribution. Setting
initializes the reference vector and generates the variates in one go.
The routine
g05eyf returns a single variate at a time, whereas the new routine
g05tef returns a vector of
n values in one go.
The length of the real reference vector,
r, in
g05tef, needs to be a different length from the equivalent argument in
g05eff, see the documentation for more details.
The integer array
state in the call
to
g05tef contains information on the base generator
being used. This array must have been initialized prior to calling
g05tef with a call to either
g05kff
or
g05kgf.
The required length of the array
state will depend on the base generator chosen
during initialization.
Due to changes in the underlying code the sequence of
values produced by
g05tef is likely to be different from
those produced by a combination of
g05eff and
g05eyf.
g05egf
Withdrawn at Mark 22.
Replaced by
g05phf.
Old: CALL g05egf(E,A,NA,B,NB,R,NR,VAR,IFAIL)
New: AVAR = B(1)**2
IQ = NB - 1
IF (AVAR.GT.0.0D0) THEN
DO 10 I = 1, IQ
THETA(I) = -B(I+1)/B(1)
10 CONTINUE
ELSE
DO 20 I = 1, IQ
THETA(I) = 0.0D0
20 CONTINUE
END IF
MODE = 0
CALL g05phf(MODE,N,E,NA,A,IQ,THETA,AVAR,R,LR,STATE,VAR,X,IFAIL)
The real vector
theta must be of length at least
.
The old routine
g05egf sets up a reference vector for use by
g05ewf. The replacement routine
g05phf is now used to both set up a reference vector and generate the required variates. Setting
in the call to
g05phf sets up the real reference vector
r and hence mimics the functionality of
g05egf. When
, the integer array
state in the call to
g05phf need not be set.
g05ehf
Withdrawn at Mark 22.
Replaced by
g05ncf.
Old: CALL g05ehf(INDEX,N,IFAIL)
New: CALL g05ncf(INDEX,N,STATE,IFAIL)
The integer array
state in the call to
g05ncf contains information on the base generator being used. This array must have been initialized prior to calling
g05ncf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05ncf is likely to be different from those produced by
g05ehf.
g05ejf
Withdrawn at Mark 22.
Replaced by
g05ndf.
Old: CALL g05ejf(IA,N,IZ,M,IFAIL)
New: CALL g05ndf(IA,N,IZ,M,STATE,IFAIL)
The integer array
state in the call to
g05ndf contains information on the base generator being used. This array must have been initialized prior to calling
g05ndf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05ndf is likely to be different from those produced by
g05ejf.
g05ewf
Withdrawn at Mark 22.
Replaced by
g05phf.
Old: CALL g05egf(E,A,NA,B,NB,R,NR,VAR,IFAIL)
DO 10 I = 1, N
X(I) = g05ewf(R,NR,IFAIL)
10 CONTINUE
New: AVAR = B(1)**2
IQ = NB - 1
IF (AVAR.GT.0.0D0) THEN
DO 10 I = 1, IQ
THETA(I) = -B(I+1)/B(1)
10 CONTINUE
ELSE
DO 20 I = 1, IQ
THETA(I) = 0.0D0
20 CONTINUE
END IF
MODE = 2
CALL g05phf(MODE,N,E,NA,A,NB-1,THETA,AVAR,VAR,R,LR,STATE,X,IFAIL)
The real vector
theta must be of length at least
.
The old routine
g05egf sets up a reference vector for use by
g05ewf. The replacement routine
g05phf is now used to both set up a reference vector and generate the required variates. Setting the integer argument
mode to 0 in the call to
g05phf sets up the real reference vector
r and hence mimics the functionality of
g05egf. Setting
mode to 1 generates a series of variates from a reference vector mimicking the functionality of
g05ewf. Setting
mode to 2 initializes the reference vector and generates the variates in one go.
The integer array
state in the call to
g05phf contains information on the base generator being used. This array must have been initialized prior to calling
g05phf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05phf is likely to be different from those produced by
g05egf.
g05exf
Withdrawn at Mark 22.
Replaced by
g05tdf.
Old: CALL g05exf(P,NP,IP1,ITYPE,R1,LR1,IFAIL)
DO 10 I = 1, N
X(I) = g05eyf(R1,LR1)
10 CONTINUE
New: MODE = 2
CALL g05tdf(MODE,N,P,NP,IP1,ITYPE,R,LR,STATE,X,IFAIL)
The old routine
g05exf sets up a reference vector for use by
g05eyf. The replacement routine
g05tdf is now used to both set up a reference vector and generate the required variates. Setting
in the call to
g05tdf sets up the real reference vector
r and hence mimics the functionality of
g05exf. Setting
generates a series of variates from a reference vector mimicking the functionality of
g05eyf for this particular distribution. Setting
initializes the reference vector and generates the variates in one go.
The routine
g05eyf returns a single variate at a time, whereas the new routine
g05tdf returns a vector of
n values in one go.
The length of the real reference vector,
r, in
g05tdf must be allocated in the calling program in contrast to the equivalent argument in
g05exf, see the documentation for more details.
The integer array
state in the call to
g05tdf contains information on the base generator being used. This array must have been initialized prior to calling
g05tdf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05tdf is likely to be different from those produced by a combination of
g05exf and
g05eyf.
g05eyf
Withdrawn at Mark 22.
Replaced by
g05tdf.
There is no direct replacement routine for
g05eyf.
g05eyf is designed to generate random draws from a distribution defined by a reference vector. These reference vectors are created by other routines in
Chapter G05, for example
g05ebf,
which have themselves been superseded. In order to replace a call to
g05eyf you must identify which NAG routine generated the reference vector being used and look up its replacement. For example, to replace a call to
g05eyf preceded by a call to
g05ebf,
as in:
CALL g05ebf(M,IB,R,NR,IFAIL)
X = g05eyf(R,NR)
you would need to look at the replacement routine for
g05ebf.
g05ezf
Withdrawn at Mark 22.
Replaced by
g05rzf.
Old: CALL g05eaf(XMU,N,C,LDC,EPS,R1,LR1,IFAIL)
DO 20 I = 1, N
CALL g05ezf(CX,M,R,NR,IFAIL)
DO 30 J = 1, M
X(I,J) = CX(J)
30 CONTINUE
20 CONTINUE
New: MODE = 2
CALL g05rzf(MODE,N,M,XMU,C,LDC,R,LR,STATE,X,LDX,IFAIL)
The old routine
g05eaf sets up a reference vector for use by
g05ezf. The functionality of both these routines has been combined into the single new routine
g05rzf. Setting
in the call to
g05rzf sets up the real reference vector
r and generates the draws from the multivariate Normal distribution in one go.
The old routine
g05ezf returns a single (
m-dimensional vector) draw from the multivariate Normal distribution at a time, whereas the new routine
g05rzf returns an
n by
m matrix of
n draws in one go.
The integer array
state in the call to
g05rzf contains information on the base generator being used. This array must have been initialized prior to calling
g05rzf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05rzf is likely to be different from those produced by
g05ezf.
g05faf
Withdrawn at Mark 22.
Replaced by
g05sqf.
Old: CALL g05faf(AA,BB,N,X)
New: A = MIN(AA,BB)
B = MAX(AA,BB)
IFAIL = 0
CALL g05sqf(N,A,B,STATE,X,IFAIL)
In
g05sqf the minimum value must be held in the argument A and the maximum in argument
b, therefore
. This was not the case for the equivalent arguments in
g05faf.
The integer array
state in the call to
g05sqf contains information on the base generator being used. This array must have been initialized prior to calling
g05sqf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05sqf is likely to be different from those produced by
g05faf.
g05fbf
Withdrawn at Mark 22.
Replaced by
g05sff.
Old: CALL g05fbf(AA,N,X)
New: A = ABS(AA)
IFAIL = 0
CALL g05sff(N,A,STATE,X,IFAIL)
In
g05sff argument
a must be non-negative, this was not the case for the equivalent argument in
g05fbf.
The integer array
state in the call to
g05sff contains information on the base generator being used. This array must have been initialized prior to calling
g05sff with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05sff is likely to be different from those produced by
g05fbf.
g05fdf
Withdrawn at Mark 22.
Replaced by
g05skf.
Old: CALL g05fdf(XMU,SD,N,X)
New: VAR = SD**2
IFAIL = 0
CALL g05skf(N,XMU,VAR,STATE,X,IFAIL)
g05skf expects the variance of the Normal distribution (argument
var), compared to
g05fdf which expected the standard deviation.
The integer array
state in the call to
g05skf contains information on the base generator being used. This array must have been initialized prior to calling
g05skf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05skf is likely to be different from those produced by
g05fdf.
g05fef
Withdrawn at Mark 22.
Replaced by
g05sbf.
Old: CALL g05fef(A,B,N,X,IFAIL)
New: CALL g05sbf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05sbf contains information on the base generator being used. This array must have been initialized prior to calling
g05sbf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05sbf is likely to be different from those produced by
g05fef.
g05fff
Withdrawn at Mark 22.
Replaced by
g05sjf.
Old: CALL g05fff(A,B,N,X,IFAIL)
New: CALL g05sjf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05sjf contains information on the base generator being used. This array must have been initialized prior to calling
g05sjf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05sjf is likely to be different from those produced by
g05fff.
g05fsf
Withdrawn at Mark 22.
Replaced by
g05srf.
Old: CALL g05fsf(VK,N,X,IFAIL)
New: CALL g05srf(N,VK,STATE,X,IFAIL)
The integer array
state in the call to
g05srf contains information on the base generator being used. This array must have been initialized prior to calling
g05srf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05srf is likely to be different from those produced by
g05fsf.
g05gaf
Withdrawn at Mark 22.
Replaced by
g05pxf.
Old: CALL g05gaf(SIDE,INIT,M,N,A,LDA,WK,IFAIL)
New: CALL g05pxf(SIDE,INIT,M,N,STATE,A,LDA,IFAIL)
The integer array
state in the call to
g05pxf contains information on the base generator being used. This array must have been initialized prior to calling
g05pxf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05pxf is likely to be different from those produced by
g05gaf.
g05gbf
Withdrawn at Mark 22.
Replaced by
g05pyf.
Old: CALL g05gbf(N,D,C,LDC,EPS,WK,IFAIL)
New: CALL g05pyf(N,D,EPS,STATE,C,LDC,IFAIL)
The integer array
state in the call to
g05pyf contains information on the base generator being used. This array must have been initialized prior to calling
g05pyf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05pyf is likely to be different from those produced by
g05gbf.
g05hdf
Withdrawn at Mark 22.
Replaced by
g05pjf.
Old: CALL g05hdf(MODE,K,IP,IQ,MEAN,PAR,LPAR,QQ,LDQQ,N,W,REF,LREF, &
IWORK,LIWORK,IFAIL)
New: IF (MODE.EQ.'S') THEN
IMODE = 0
ELSE IF (MODE.EQ.'C') THEN
IMODE = 1
ELSE IF (MODE.EQ.'R') THEN
IMODE = 3
END IF
LL = 0
DO 30 L = 1, IP
DO 20 I = 1, K
DO 10 J = 1, K
LL = LL + 1
PHI(I,J,L) = PAR(LL)
10 CONTINUE
20 CONTINUE
30 CONTINUE
DO 60 L = 1, IQ-1
DO 50 I = 1, K
DO 40 J = 1, K
LL = LL + 1
THETA(I,J,L) = PAR(LL)
40 CONTINUE
50 CONTINUE
60 CONTINUE
IF (MEAN.EQ.'M') THEN
DO 70 I = 1, K
LL = LL + 1
XMEAN(I) = PAR(LL)
70 CONTINUE
ELSE
DO 80 I = 1, K
XMEAN(I) = 0.0D0
80 CONTINUE
END IF
LDW = N
CALL g05pjf(IMODE,N,K,XMEAN,IP,PHI,IQ,THETA,QQ,LDQQ,REF,LREF, &
STATE,W,LDW,IWORK,LIWORK,IFAIL)
The integer argument
IMODE should be set to 0, 1 or 3 in place of the argument
mode having settings of 'S', 'C' or 'R' respectively. The real array
phi should have length at least
; if dimensioned as
(as in the above example) then
will contain the element
. The real array
theta should have length at least
; if dimensioned as
(as in the above example) then
will contain the element
. The real array
xmean should have length at least
k; if
then
will contain the element
, otherwise
xmean should contain an array of zero values.
The integer array
state in the call to
g05pjf contains information on the base generator being used. This array must have been initialized prior to calling
g05pjf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05pjf is likely to be different from those produced by
g05hdf.
g05hkf
Withdrawn at Mark 24.
Replaced by
g05pdf.
Old: CALL g05hkf(DIST,NUM,IP,IQ,THETA,GAMMA,DF,HT,ET,FCALL,RVEC,IGEN, &
ISEED,RWSAV,IFAIL)
New: CALL g05pdf(DIST,NUM,IP,IQ,THETA,GAMMA,DF,HT,ET,FCALL,R,LR,STATE, &
IFAIL)
The integer array
state in the call to
g05pdf contains information on the base generator being used. This array must have been initialized prior to calling
g05pdf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05pdf is likely to be different from those produced by
g05hkf.
g05hlf
Withdrawn at Mark 24.
Replaced by
g05pef.
Old: CALL g05hlf(DIST,NUM,IP,IQ,THETA,GAMMA,DF,HT,ET,FCALL,RVEC,IGEN, &
ISEED,RWSAV,IFAIL)
New: CALL g05pef(DIST,NUM,IP,IQ,THETA,GAMMA,DF,HT,ET,FCALL,R,LR,STATE, &
IFAIL)
The integer array
state in the call to
g05pef contains information on the base generator being used. This array must have been initialized prior to calling
g05pef with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05pef is likely to be different from those produced by
g05hlf.
g05hmf
Withdrawn at Mark 24.
Replaced by
g05pff.
Old: CALL g05hmf(DIST,NUM,IP,IQ,THETA,GAMMA,DF,HT,ET,FCALL,RVEC,IGEN, &
ISEED,RWSAV,IFAIL)
New: CALL g05pff(DIST,NUM,IP,IQ,THETA,GAMMA,DF,HT,ET,FCALL,R,LR,STATE, &
IFAIL)
The integer array
state in the call to
g05pff contains information on the base generator being used. This array must have been initialized prior to calling
g05pff with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
Due to changes in the underlying code the sequence of values produced by
g05pff is likely to be different from those produced by
g05hmf.
g05hnf
Withdrawn at Mark 24.
Replaced by
g05pgf.
Old: CALL g05hnf(DIST,NUM,IP,IQ,THETA,DF,HT,ET,FCALL,RVEC,IGEN,ISEED, &
RWSAV,IFAIL)
New: CALL g05pgf(DIST,NUM,IP,IQ,THETA,DF,HT,ET,FCALL,RVEC,STATE, &
IFAIL)
The integer array
state in the call to
g05pgf contains information on the base generator being used. This array must have been initialized prior to calling
g05pgf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05kaf
Withdrawn at Mark 24.
Replaced by
g05saf.
Old: DO 20 I = 1, N
X(I) = g05kaf(IGEN,ISEED)
20 CONTINUE
New: CALL g05saf(N,STATE,X,IFAIL)
The old routine
g05kaf returns a single variate at a time, whereas the new routine
g05saf returns a vector of
n values in one go.
The integer array
state in the call to
g05saf contains information on the base generator being used. This array must have been initialized prior to calling
g05saf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05kbf
Withdrawn at Mark 24.
Replaced by
g05kff.
Old: g05kbf(IGEN,ISEED)
New: IF (IGEN.EQ.0) THEN
CALL g05kff(1,1,ISEED,LSEED,STATE,LSTATE,IFAIL)
ELSE
CALL g05kff(2,IGEN,ISEED,LSEED,STATE,LSTATE,IFAIL)
END IF
g05kcf
Withdrawn at Mark 24.
Replaced by
g05kgf.
Old: CALL g05kcf(IGEN,ISEED)
New: IF (IGEN.EQ.0) THEN
CALL g05kgf(1,1,STATE,LSTATE,IFAIL)
ELSE
CALL g05kgf(2,IGEN,STATE,LSTATE,IFAIL)
END IF
g05kef
Withdrawn at Mark 24.
Replaced by
g05tbf.
Old: DO 20 I = 1, N
X(I) = g05kef(P,IGEN,ISEED,IFAIL)
20 CONTINUE
New: CALL g05tbf(N,P,STATE,X,IFAIL)
The old routine
g05kef returns a single variate at a time, whereas the new routine
g05tbf returns a vector of
n values in one go.
The integer array
state in the call to
g05tbf contains information on the base generator being used. This array must have been initialized prior to calling
g05tbf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05laf
Withdrawn at Mark 24.
Replaced by
g05skf.
Old: CALL g05laf(XMU,VAR,N,X,IGEN,ISEED,IFAIL)
New: CALL g05skf(N,XMU,VAR,STATE,X,IFAIL)
The integer array
state in the call to
g05skf contains information on the base generator being used. This array must have been initialized prior to calling
g05skf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lbf
Withdrawn at Mark 24.
Replaced by
g05snf.
Old: CALL g05lbf(DF,N,X,IGEN,ISEED,IFAIL)
New: CALL g05snf(N,DF,STATE,X,IFAIL)
The integer array
state in the call to
g05snf contains information on the base generator being used. This array must have been initialized prior to calling
g05snf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lcf
Withdrawn at Mark 24.
Replaced by
g05sdf.
Old: CALL g05lcf(DF,N,X,IGEN,ISEED,IFAIL)
New: CALL g05sdf(N,DF,STATE,X,IFAIL)
The integer array
state in the call to
g05sdf contains information on the base generator being used. This array must have been initialized prior to calling
g05sdf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05ldf
Withdrawn at Mark 24.
Replaced by
g05shf.
Old: CALL g05ldf(DF1,DF2,N,X,IGEN,ISEED,IFAIL)
New: CALL g05shf(N,DF1,DF2,STATE,X,IFAIL)
The integer array
state in the call to
g05shf contains information on the base generator being used. This array must have been initialized prior to calling
g05shf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lef
Withdrawn at Mark 24.
Replaced by
g05sbf.
Old: CALL g05lef(A,B,N,X,IGEN,ISEED,IFAIL)
New: CALL g05sbf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05sbf contains information on the base generator being used. This array must have been initialized prior to calling
g05sbf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lff
Withdrawn at Mark 24.
Replaced by
g05sjf.
Old: CALL g05lff(A,B,N,X,IGEN,ISEED,IFAIL)
New: CALL g05sjf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05sjf contains information on the base generator being used. This array must have been initialized prior to calling
g05sjf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lgf
Withdrawn at Mark 24.
Replaced by
g05sqf.
Old: CALL g05lgf(A,B,N,X,IGEN,ISEED,IFAIL)
New: CALL g05sqf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05sqf contains information on the base generator being used. This array must have been initialized prior to calling
g05sqf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lhf
Withdrawn at Mark 24.
Replaced by
g05spf.
Old: CALL g05lhf(XMIN,XMAX,XMED,N,X,IGEN,ISEED,IFAIL)
New: CALL g05spf(N,XMIN,XMED,XMAX,STATE,X,IFAIL)
The integer array
state in the call to
g05spf contains information on the base generator being used. This array must have been initialized prior to calling
g05spf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05ljf
Withdrawn at Mark 24.
Replaced by
g05sff.
Old: CALL g05ljf(A,N,X,IGEN,ISEED,IFAIL)
New: CALL g05sff(N,A,STATE,X,IFAIL)
The integer array
state in the call to
g05sff contains information on the base generator being used. This array must have been initialized prior to calling
g05sff with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lkf
Withdrawn at Mark 24.
Replaced by
g05smf.
Old: CALL g05lkf(XMU,VAR,N,X,IGEN,ISEED,IFAIL)
New: CALL g05smf(N,XMU,VAR,STATE,X,IFAIL)
The integer array
state in the call to
g05smf contains information on the base generator being used. This array must have been initialized prior to calling
g05smf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05llf
Withdrawn at Mark 24.
Replaced by
g05sjf.
Old: CALL g05llf(XMED,SEMIQR,N,X,IGEN,ISEED,IFAIL)
New: CALL g05scf(N,XMED,SEMIQR,STATE,X,IFAIL)
The integer array
state in the call to
g05scf contains information on the base generator being used. This array must have been initialized prior to calling
g05scf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lmf
Withdrawn at Mark 24.
Replaced by
g05ssf.
Old: CALL g05lmf(A,B,N,X,IGEN,ISEED,IFAIL)
New: CALL g05ssf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05ssf contains information on the base generator being used. This array must have been initialized prior to calling
g05ssf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lnf
Withdrawn at Mark 24.
Replaced by
g05slf.
Old: CALL g05lnf(A,B,N,X,IGEN,ISEED,IFAIL)
New: CALL g05slf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05slf contains information on the base generator being used. This array must have been initialized prior to calling
g05slf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lpf
Withdrawn at Mark 24.
Replaced by
g05srf.
Old: CALL g05lpf(VK,N,X,IGEN,ISEED,IFAIL)
New: CALL g05srf(N,VK,STATE,X,IFAIL)
The integer array
state in the call to
g05srf contains information on the base generator being used. This array must have been initialized prior to calling
g05srf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lqf
Withdrawn at Mark 24.
Replaced by
g05sgf.
Old: CALL g05lqf(NMIX,A,WGT,N,X,IGEN,ISEED,IFAIL)
New: CALL g05sgf(N,NMIX,A,WGT,STATE,X,IFAIL)
The integer array
state in the call to
g05sgf contains information on the base generator being used. This array must have been initialized prior to calling
g05sgf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lxf
Withdrawn at Mark 24.
Replaced by
g05ryf.
Old: CALL g05lxf(MODE,DF,M,XMU,C,LDC,N,X,LDX,IGEN,ISEED,R,LR,IFAIL)
New: IF (MODE == 0) THEN
NMODE = 1
ELSE IF (MODE == 1) THEN
NMODE = 0
ELSE
NMODE = MODE
END IF
CALL g05ryf(NMODE,N,DF,M,XMU,C,LDC,R,LR,STATE,X,LDX,IFAIL)
The integer array
state in the call to
g05ryf contains information on the base generator being used. This array must have been initialized prior to calling
g05ryf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lyf
Withdrawn at Mark 24.
Replaced by
g05rzf.
Old: g05lyf(MODE,M,XMU,C,LDC,N,X,LDX,IGEN,ISEED,R,LR,IFAIL)
New: IF (MODE == 0) THEN
NMODE = 1
ELSE IF (MODE == 1) THEN
NMODE = 0
ELSE
NMODE = MODE
END IF
CALL g05rzf(NMODE,N,M,XMU,C,LDC,R,LR,STATE,X,LDX,IFAIL)
The integer array
state in the call to
g05rzf contains information on the base generator being used. This array must have been initialized prior to calling
g05rzf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05lzf
Withdrawn at Mark 24.
Replaced by
g05rzf.
Old: CALL g05lzf(MODE,M,XMU,C,LDC,X,IGEN,ISEED,R,LR,IFAIL)
New: IF (MODE == 0) THEN
NMODE = 1
ELSE IF (MODE == 1) THEN
NMODE = 0
ELSE
NMODE = MODE
END IF
CALL g05rzf(NMODE,N,M,XMU,C,LDC,R,LR,STATE,X,LDX,IFAIL)
The integer array
state in the call to
g05rzf contains information on the base generator being used. This array must have been initialized prior to calling
g05rzf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05maf
Withdrawn at Mark 24.
Replaced by
g05tlf.
Old: CALL g05maf(A,B,N,X,IGEN,ISEED,IFAIL)
New: CALL g05tlf(N,A,B,STATE,X,IFAIL)
The integer array
state in the call to
g05tlf contains information on the base generator being used. This array must have been initialized prior to calling
g05tlf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mbf
Withdrawn at Mark 24.
Replaced by
g05tcf.
Old: CALL g05mbf(MODE,P,N,X,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05tcf(MODE,N,P,R,LR,STATE,X,IFAIL)
DO 20 I = 1, N
X(I) = X(I) + 1
20 CONTINUE
g05mbf returned the number of trials required to get the first success, whereas
g05tcf returns the number of failures before the first success, therefore the value returned by
g05tcf is one less than the equivalent value returned from g05mbf.
The integer array
state in the call to
g05tcf contains information on the base generator being used. This array must have been initialized prior to calling
g05tcf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mcf
Withdrawn at Mark 24.
Replaced by
g05thf.
Old: CALL g05mcf(MODE,M,P,N,X,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05thf(MODE,N,M,P,R,LR,STATE,X,IFAIL)
The integer array
state in the call to
g05thf contains information on the base generator being used. This array must have been initialized prior to calling
g05thf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mdf
Withdrawn at Mark 24.
Replaced by
g05tff.
Old: CALL g05mdf(MODE,A,N,X,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05tff(MODE,N,A,R,LR,STATE,X,IFAIL)
The integer array
state in the call to
g05tff contains information on the base generator being used. This array must have been initialized prior to calling
g05tff with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mef
Withdrawn at Mark 24.
Replaced by
g05tkf.
Old: CALL g05mef(M,VLAMDA,X,IGEN,ISEED,IFAIL)
New: CALL g05tkf(M,VLAMDA,STATE,X,IFAIL)
The integer array
state in the call to
g05tkf contains information on the base generator being used. This array must have been initialized prior to calling
g05tkf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mjf
Withdrawn at Mark 24.
Replaced by
g05taf.
Old: CALL g05mjf(MODE,M,P,N,X,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05taf(MODE,N,M,P,R,LR,STATE,X,IFAIL)
The integer array
state in the call to
g05taf contains information on the base generator being used. This array must have been initialized prior to calling
g05taf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mkf
Withdrawn at Mark 24.
Replaced by
g05tjf.
Old: CALL g05mkf(MODE,LAMBDA,N,X,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05tjf(MODE,N,LAMBDA,R,LR,STATE,X,IFAIL)
The integer array
state in the call to
g05tjf contains information on the base generator being used. This array must have been initialized prior to calling
g05tjf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mlf
Withdrawn at Mark 24.
Replaced by
g05tef.
Old: CALL g05mlf(MODE,NS,NP,M,N,X,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05tef(MODE,N,NS,NP,M,R,LR,STATE,X,IFAIL)
The integer array
state in the call to
g05tef contains information on the base generator being used. This array must have been initialized prior to calling
g05tef with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mrf
Withdrawn at Mark 24.
Replaced by
g05tgf.
Old: CALL g05mrf(MODE,M,K,P,N,X,LDX,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05tgf(MODE,N,M,K,P,R,LR,STATE,X,LDX,IFAIL)
The integer array
state in the call to
g05tgf contains information on the base generator being used. This array must have been initialized prior to calling
g05tgf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05mzf
Withdrawn at Mark 24.
Replaced by
g05tdf.
Old: CALL g05mzf(MODE,P,NP,IP1,ITYPE,N,X,IGEN,ISEED,R,NR,IFAIL)
New: CALL g05tdf(MODE,N,P,NP,IP1,ITYPE,R,LR,STATE,X,IFAIL)
The integer array
state in the call to
g05tdf contains information on the base generator being used. This array must have been initialized prior to calling
g05tdf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05naf
Withdrawn at Mark 24.
Replaced by
g05ncf.
Old: CALL g05naf(INDEX,N,IGEN,ISEED,IFAIL)
New: CALL g05ncf(INDEX,N,STATE,IFAIL)
The integer array
state in the call to
g05ncf contains information on the base generator being used. This array must have been initialized prior to calling
g05ncf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05nbf
Withdrawn at Mark 24.
Replaced by
g05ndf.
Old: CALL g05nbf(IPOP,N,ISAMPL,M,IGEN,ISEED,IFAIL)
New: CALL g05ndf(IPOP,N,ISAMPL,M,STATE,IFAIL)
The integer array
state in the call to
g05ndf contains information on the base generator being used. This array must have been initialized prior to calling
g05ndf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05paf
Withdrawn at Mark 24.
Replaced by
g05phf.
Old: CALL g05paf(MODE,XMEAN,IP,PHI,IQ,THETA,AVAR,VAR,N,X,IGEN,ISEED,R, &
NR,IFAIL)
New: CALL g05phf(MODE,N,XMEAN,IP,PHI,IQ,THETA,AVAR,R,LR,STATE,VAR,X, &
IFAIL)
The integer array
state in the call to
g05phf contains information on the base generator being used. This array must have been initialized prior to calling
g05phf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05pcf
Withdrawn at Mark 24.
Replaced by
g05pjf.
Old: CALL g05pcf(MODE,K,XMEAN,IP,PHI,IQ,THETA,VAR,LDV,N,X,IGEN,ISEED,R, &
NR,IWORK,LIWORK,IFAIL)
New: CALL g05pjf(MODE,N,K,XMEAN,IP,PHI,IQ,THETA,VAR,LDV,R,LR,STATE,X,LDX, &
IFAIL)
The integer array
state in the call to
g05pjf contains information on the base generator being used. This array must have been initialized prior to calling
g05pjf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05qaf
Withdrawn at Mark 24.
Replaced by
g05pxf.
Old: CALL g05qaf(SIDE,INIT,M,N,A,LDA,IGEN,ISEED,WK,IFAIL)
New: CALL g05pxf(SIDE,INIT,M,N,STATE,A,LDA,IFAIL)
The integer array
state in the call to
g05pxf contains information on the base generator being used. This array must have been initialized prior to calling
g05pxf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05qbf
Withdrawn at Mark 24.
Replaced by
g05pyf.
Old: CALL g05qbf(N,D,C,LDC,EPS,IGEN,ISEED,WK,IFAIL)
New: CALL g05pyf(N,D,EPS,STATE,C,LDC,IFAIL)
The integer array
state in the call to
g05pyf contains information on the base generator being used. This array must have been initialized prior to calling
g05pyf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05qdf
Withdrawn at Mark 24.
Replaced by
g05pzf.
Old: CALL g05qdf(MODE,NROW,NCOL,TOTR,TOTC,X,LDX,IGEN,ISEED,R,NR,IW,LIW, &
IFAIL)
New: CALL g05pzf(MODE,NROW,NCOL,TOTR,TOTC,R,LR,STATE,X,LDX,IFAIL)
The integer array
state in the call to
g05pzf contains information on the base generator being used. This array must have been initialized prior to calling
g05pzf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05raf
Withdrawn at Mark 24.
Replaced by
g05rdf.
Old: CALL g05raf(MODE,M,C,LDC,N,X,LDX,IGEN,ISEED,R,LR,IFAIL)
New: IF (MODE == 0) THEN
NMODE = 1
ELSE IF (MODE == 1) THEN
NMODE = 0
ELSE
NMODE = MODE
END IF
CALL CALL g05rdf(NMODE,N,M,C,LDC,R,LR,STATE,X,LDX,IFAIL)
The integer array
state in the call to
g05rdf contains information on the base generator being used. This array must have been initialized prior to calling
g05rdf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05rbf
Withdrawn at Mark 24.
Replaced by
g05rcf.
Old: CALL g05rbf(MODE,DF,M,C,LDC,N,X,LDX,IGEN,ISEED,R,LR,IFAIL)
New: IF (MODE == 0) THEN
NMODE = 1
ELSE IF (MODE == 1) THEN
NMODE = 0
ELSE
NMODE = MODE
END IF
CALL CALL g05rcf(NMODE,N,DF,M,C,LDC,R,LR,STATE,X,LDX,IFAIL)
The integer array
state in the call to
g05rcf contains information on the base generator being used. This array must have been initialized prior to calling
g05rcf with a call to either
g05kff or
g05kgf.
The required length of the array
state will depend on the base generator chosen during initialization.
g05yaf
Withdrawn at Mark 23.
Replaced by
g05ylf and
g05ymf.
|
Faure quasi-random numbers
Old: CALL g05yaf(.TRUE.,'F',ISKIP,IDIM,QUAS,IREF,IFAIL)
New: CALL g05ylf(4,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05yaf(.FALSE.,'F',ISKIP,IDIM,QUAS,IREF,IFAIL)
New: CALL g05ymf(1,2,QUAS,LDQUAS,IREF,IFAIL) |
|
Sobol quasi-random numbers
Old: CALL g05yaf(.TRUE.,'S',ISKIP,IDIM,QUAS,IREF,IFAIL)
New: CALL g05ylf(2,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05yaf(.FALSE.,'S',ISKIP,IDIM,QUAS,IREF,IFAIL)
New: CALL g05ymf(1,2,QUAS,LDQUAS,IREF,IFAIL) |
|
Neiderreiter quasi-random numbers
Old: CALL g05yaf(.TRUE.,'N',ISKIP,IDIM,QUAS,IREF,IFAIL)
New: CALL g05ylf(3,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05yaf(.FALSE.,'N',ISKIP,IDIM,QUAS,IREF,IFAIL)
New: CALL g05ymf(1,2,QUAS,LDQUAS,IREF,IFAIL) |
g05ybf
Withdrawn at Mark 23.
Replaced by
g05ylf and either
g05yjf or
g05ykf.
This routine has been replaced by a suite of routines consisting of the relevant initialization routine followed by one of two possible generator routines.
|
Faure quasi-random numbers with Gaussian probability:
Old: CALL g05ybf(.TRUE.,'F',.FALSE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ylf(4,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05ybf(.FALSE.,'F',.FALSE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05yjf(MEAN,STD,N,QUASI,IREF,IFAIL) |
|
Sobol quasi-random numbers with Gaussian probability:
Old: CALL g05ybf(.TRUE.,'S',.FALSE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ylf(2,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05ybf(.FALSE.,'S',.FALSE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05yjf(MEAN,STD,N,QUASI,IREF,IFAIL) |
|
Neiderreiter quasi-random numbers with Gaussian probability:
Old: CALL g05ybf(.TRUE.,'N',.FALSE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ylf(3,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05ybf(.FALSE.,'N',.FALSE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05yjf(MEAN,STD,N,QUASI,IREF,IFAIL) |
|
Faure quasi-random numbers with log Normal probability:
Old: CALL g05ybf(.TRUE.,'F',.TRUE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ylf(4,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05ybf(.FALSE.,'F',.TRUE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ykf(MEAN,STD,N,QUASI,IREF,IFAIL) |
|
Sobol quasi-random numbers with log Normal probability:
Old: CALL g05ybf(.TRUE.,'S',.TRUE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ylf(2,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05ybf(.FALSE.,'S',.TRUE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ykf(MEAN,STD,N,QUASI,IREF,IFAIL) |
|
Neiderreiter quasi-random numbers with log Normal probability:
Old: CALL g05ybf(.TRUE.,'N',.TRUE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ylf(3,IDIM,IREF,LIREF,ISKIP,IFAIL)
Old: CALL g05ybf(.FALSE.,'N',.TRUE.,MEAN,STD,ISKIP,IDIM,QUASI,IREF,IFAIL)
New: CALL g05ykf(MEAN,STD,N,QUASI,IREF,IFAIL) |
g05ycf
Withdrawn at Mark 24.
Replaced by
g05ylf.
Old: CALL g05ycf(IDIM,IREF,IFAIL)
New: GENID = 4
CALL g05ylf(GENID,IDIM,IREF,LIREF,ISKIP,IFAIL)
g05ydf
Withdrawn at Mark 24.
Replaced by
g05ymf.
Old: CALL g05ydf(N,QUASI,IREF,IFAIL)
New: CALL g05ymf(N,QUAS,LDQUAS,IREF,IFAIL)
g05yef
Withdrawn at Mark 24.
Replaced by
g05ylf.
Old: CALL g05yef(IDIM, IREF, ISKIP, IFAIL)
New: GENID = 2
CALL g05ylf(GENID,IDIM,IREF,LIREF,ISKIP,IFAIL)
g05yff
Withdrawn at Mark 24.
Replaced by
g05ymf.
Old: CALL g05yff(N,QUASI,IREF,IFAIL)
New: CALL g05ymf(N,QUAS,LDQUAS,IREF,IFAIL)
g05ygf
Withdrawn at Mark 24.
Replaced by
g05ylf.
Old: CALL g05ygf(IDIM,IREF,ISKIP,IFAIL)
New: GENID = 3
CALL g05ylf(GENID,IDIM,IREF,LIREF,ISKIP,IFAIL)
g05yhf
Withdrawn at Mark 24.
Replaced by
g05ymf.
Old: CALL g05yhf(N,QUASI,IREF,IFAIL)
New: CALL g05ymf(N,RCORD,QUAS,LDQUAS,IREF,IFAIL)
g05zaf
Withdrawn at Mark 22.
There is no replacement for this routine.
g05zaf was used to select the underlying generator for the old style random number generation routines. These routines are no longer available and hence no direct replacement routine for
g05zaf is required. See
g05kff and
g05kgf for details on how to select the underlying generator for the newer style routines.
G10 – Smoothing in Statistics
g10baf
Scheduled for withdrawal at Mark 27.
Replaced by
g10bbf.
Withdrawn primarily due to threadsafety.
The replacement routine also introduces new functionality with respect to the automatic selection of a suitable window width.
Old: CALL g10baf(N,X,WINDOW,SLO,SHI,NS,SMOOTH,T,USEFFT,FFT,IFAIL)
New: ALLOCATE(RCOMM,NS+20)
CALL g10bbf(N,X,1,WINDOW,SLO,SHI,NS,SMOOTH,T,USEFFT,RCOMM,IFAIL)
! the next step is only required if the information in FFT
! was being used outside another call to G10BAF
FFT(1:NS) = RCOMM(21:NS+20)
G13 – Time Series Analysis
g13dcf
Withdrawn at Mark 24.
Replaced by
g13ddf.
Old: CALL g13dcf(K,N,IP,IQ,MEAN,PAR,NPAR,QQ,KMAX,W,PARHLD,EXACT,IPRINT, &
CGETOL,MAXCAL,ISHOW,NITER,RLOGL,V,G,CM,LDCM,WORK,LWORK, &
IW,LIW,IFAIL)
New: CALL g13ddf(K,N,IP,IQ,MEAN,PAR,NPAR,QQ,KMAX,W,PARHLD,EXACT,IPRINT, &
CGETOL,MAXCAL,ISHOW,NITER,RLOGL,V,G,CM,LDCM,IFAIL)
The workspace arguments
work,
lwork,
iw and
liw are no longer required in the call to
g13ddf.
P01 – Error Trapping
p01abf
Withdrawn at Mark 24.
There is no replacement for this routine.
X02 – Machine Constants
x02daf
Withdrawn at Mark 24.
There is no replacement for this routine.
x02djf
Withdrawn at Mark 24.
There is no replacement for this routine.