dla_gerfsx_extended - ear equations for general matrices by performing extra-precise itera- tive refinement and provide error bounds and backward error estimates for the solution
SUBROUTINE DLA_GERFSX_EXTENDED(PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO) INTEGER INFO, LDA, LDAF, LDB, LDY, N, NRHS, PREC_TYPE, TRANS_TYPE, N_NORMS, ITHRESH LOGICAL COLEQU, IGNORE_CWISE DOUBLE PRECISION RTHRESH, DZ_UB INTEGER IPIV(*) DOUBLE PRECISION A(LDA,*), AF(LDAF,*), B(LDB,*), Y(LDY,*), RES(*),DY(*), Y_TAIL(*) DOUBLE PRECISION C(*), AYB(*), RCOND, BERR_OUT(*), ERRS_N(NRHS,*), ERRS_C(NRHS,*) SUBROUTINE DLA_GERFSX_EXTENDED_64(PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO) INTEGER*8 INFO, LDA, LDAF, LDB, LDY, N, NRHS, PREC_TYPE, TRANS_TYPE, N_NORMS, ITHRESH LOGICAL*8 COLEQU, IGNORE_CWISE DOUBLE PRECISION RTHRESH, DZ_UB INTEGER*8 IPIV(*) DOUBLE PRECISION A(LDA,*), AF(LDAF,*), B(LDB,*), Y(LDY,*), RES(*),DY(*), Y_TAIL(*) DOUBLE PRECISION C(*), AYB(*), RCOND, BERR_OUT(*), ERRS_N(NRHS,*), ERRS_C(NRHS,*) F95 INTERFACE SUBROUTINE LA_GERFSX_EXTENDED(PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO) INTEGER :: PREC_TYPE, TRANS_TYPE, N, NRHS, LDA, LDAF, LDB, LDY, N_NORMS, ITHRESH, INFO LOGICAL :: COLEQU, IGNORE_CWISE INTEGER, DIMENSION(:) :: IPIV REAL(8), DIMENSION(:,:) :: A, AF, B, Y, ERRS_N, ERRS_C REAL(8), DIMENSION(:) :: C, BERR_OUT, RES, AYB, DY, Y_TAIL REAL(8) :: RCOND, RTHRESH, DZ_UB SUBROUTINE LA_GERFSX_EXTENDED_64(PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO) INTEGER(8) :: PREC_TYPE, TRANS_TYPE, N, NRHS, LDA, LDAF, LDB, LDY, N_NORMS, ITHRESH, INFO LOGICAL(8) :: COLEQU, IGNORE_CWISE INTEGER(8), DIMENSION(:) :: IPIV REAL(8), DIMENSION(:,:) :: A, AF, B, Y, ERRS_N, ERRS_C REAL(8), DIMENSION(:) :: C, BERR_OUT, RES, AYB, DY, Y_TAIL REAL(8) :: RCOND, RTHRESH, DZ_UB C INTERFACE #include <sunperf.h> void dla_gerfsx_extended (int prec_type, int trans_type, int n, int nrhs, double *a, int lda, double *af, int ldaf, int *ipiv, int colequ, double *c, double *b, int ldb, double *y, int ldy, double *berr_out, int n_norms, double *errs_n, double *errs_c, double rcond, int ithresh, double rthresh, double dz_ub, int ignore_cwise, int *info); void dla_gerfsx_extended_64 (long prec_type, long trans_type, long n, long nrhs, double *a, long lda, double *af, long ldaf, long *ipiv, long colequ, double *c, double *b, long ldb, double *y, long ldy, double *berr_out, long n_norms, double *errs_n, double *errs_c, double rcond, long ithresh, double rthresh, double dz_ub, long ignore_cwise, long *info);
Oracle Solaris Studio Performance Library dla_gerfsx_extended(3P)
NAME
dla_gerfsx_extended - improve the computed solution to a system of lin-
ear equations for general matrices by performing extra-precise itera-
tive refinement and provide error bounds and backward error estimates
for the solution
SYNOPSIS
SUBROUTINE DLA_GERFSX_EXTENDED(PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA,
AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS,
ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH,
RTHRESH, DZ_UB, IGNORE_CWISE, INFO)
INTEGER INFO, LDA, LDAF, LDB, LDY, N, NRHS, PREC_TYPE, TRANS_TYPE,
N_NORMS, ITHRESH
LOGICAL COLEQU, IGNORE_CWISE
DOUBLE PRECISION RTHRESH, DZ_UB
INTEGER IPIV(*)
DOUBLE PRECISION A(LDA,*), AF(LDAF,*), B(LDB,*), Y(LDY,*),
RES(*),DY(*), Y_TAIL(*)
DOUBLE PRECISION C(*), AYB(*), RCOND, BERR_OUT(*), ERRS_N(NRHS,*),
ERRS_C(NRHS,*)
SUBROUTINE DLA_GERFSX_EXTENDED_64(PREC_TYPE, TRANS_TYPE, N, NRHS, A,
LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT,
N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND,
ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO)
INTEGER*8 INFO, LDA, LDAF, LDB, LDY, N, NRHS, PREC_TYPE, TRANS_TYPE,
N_NORMS, ITHRESH
LOGICAL*8 COLEQU, IGNORE_CWISE
DOUBLE PRECISION RTHRESH, DZ_UB
INTEGER*8 IPIV(*)
DOUBLE PRECISION A(LDA,*), AF(LDAF,*), B(LDB,*), Y(LDY,*),
RES(*),DY(*), Y_TAIL(*)
DOUBLE PRECISION C(*), AYB(*), RCOND, BERR_OUT(*), ERRS_N(NRHS,*),
ERRS_C(NRHS,*)
F95 INTERFACE
SUBROUTINE LA_GERFSX_EXTENDED(PREC_TYPE, TRANS_TYPE, N, NRHS, A, LDA,
AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT, N_NORMS,
ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND, ITHRESH,
RTHRESH, DZ_UB, IGNORE_CWISE, INFO)
INTEGER :: PREC_TYPE, TRANS_TYPE, N, NRHS, LDA, LDAF, LDB, LDY,
N_NORMS, ITHRESH, INFO
LOGICAL :: COLEQU, IGNORE_CWISE
INTEGER, DIMENSION(:) :: IPIV
REAL(8), DIMENSION(:,:) :: A, AF, B, Y, ERRS_N, ERRS_C
REAL(8), DIMENSION(:) :: C, BERR_OUT, RES, AYB, DY, Y_TAIL
REAL(8) :: RCOND, RTHRESH, DZ_UB
SUBROUTINE LA_GERFSX_EXTENDED_64(PREC_TYPE, TRANS_TYPE, N, NRHS, A,
LDA, AF, LDAF, IPIV, COLEQU, C, B, LDB, Y, LDY, BERR_OUT,
N_NORMS, ERRS_N, ERRS_C, RES, AYB, DY, Y_TAIL, RCOND,
ITHRESH, RTHRESH, DZ_UB, IGNORE_CWISE, INFO)
INTEGER(8) :: PREC_TYPE, TRANS_TYPE, N, NRHS, LDA, LDAF, LDB, LDY,
N_NORMS, ITHRESH, INFO
LOGICAL(8) :: COLEQU, IGNORE_CWISE
INTEGER(8), DIMENSION(:) :: IPIV
REAL(8), DIMENSION(:,:) :: A, AF, B, Y, ERRS_N, ERRS_C
REAL(8), DIMENSION(:) :: C, BERR_OUT, RES, AYB, DY, Y_TAIL
REAL(8) :: RCOND, RTHRESH, DZ_UB
C INTERFACE
#include <sunperf.h>
void dla_gerfsx_extended (int prec_type, int trans_type, int n, int
nrhs, double *a, int lda, double *af, int ldaf, int *ipiv,
int colequ, double *c, double *b, int ldb, double *y, int
ldy, double *berr_out, int n_norms, double *errs_n, double
*errs_c, double rcond, int ithresh, double rthresh, double
dz_ub, int ignore_cwise, int *info);
void dla_gerfsx_extended_64 (long prec_type, long trans_type, long n,
long nrhs, double *a, long lda, double *af, long ldaf, long
*ipiv, long colequ, double *c, double *b, long ldb, double
*y, long ldy, double *berr_out, long n_norms, double *errs_n,
double *errs_c, double rcond, long ithresh, double rthresh,
double dz_ub, long ignore_cwise, long *info);
PURPOSE
dla_gerfsx_extended improves the computed solution to a system of lin-
ear equations by performing extra-precise iterative refinement and pro-
vides error bounds and backward error estimates for the solution. This
subroutine is called by DGERFSX to perform iterative refinement. In
addition to normwise error bound, the code provides maximum component-
wise error bound if possible. See comments for ERRS_N and ERRS_C for
details of the error bounds. Note that this subroutine is only resonsi-
ble for setting the second fields of ERRS_N and ERRS_C.
ARGUMENTS
PREC_TYPE (input)
PREC_TYPE is INTEGER
Specifies the intermediate precision to be used in refine-
ment. The value is defined by ILAPREC(P) where P is a CHAR-
ACTER and
P = 'S': Single
= 'D': Double
= 'I': Indigenous
= 'X', 'E': Extra
TRANS_TYPE (input)
TRANS_TYPE is INTEGER
Specifies the transposition operation on A. The value is
defined by ILATRANS(T) where T is a CHARACTER and
T = 'N': No transpose
= 'T': Transpose
= 'C': Conjugate transpose
N (input)
N is INTEGER
The number of linear equations, i.e., the order of the matrix
A. N >= 0.
NRHS (input)
NRHS is INTEGER
The number of right-hand-sides, i.e., the number of columns
of the matrix B.
A (input)
A is DOUBLE PRECISION array, dimension (LDA,N)
On entry, the N-by-N matrix A.
LDA (input)
LDA is INTEGER
The leading dimension of the array A.
LDA >= max(1,N).
AF (input)
AF is DOUBLE PRECISION array, dimension (LDAF,N)
The factors L and U from the factorization A=P*L*U as com-
puted by DGETRF.
LDAF (input)
LDAF is INTEGER
The leading dimension of the array AF.
LDAF >= max(1,N).
IPIV (input)
IPIV is INTEGER array, dimension (N)
The pivot indices from the factorization A=P*L*U
as computed by DGETRF; row i of the matrix was interchanged
with row IPIV(i).
COLEQU (input)
COLEQU is LOGICAL
If .TRUE. then column equilibration was done to A before
calling this routine. This is needed to compute the solution
and error bounds correctly.
C (input)
C is DOUBLE PRECISION array, dimension (N)
The column scale factors for A. If COLEQU = .FALSE., C is not
accessed. If C is input, each element of C should be a power
of the radix to ensure a reliable solution and error esti-
mates. Scaling by powers of the radix does not cause round-
ing errors unless the result underflows or overflows. Round-
ing errors during scaling lead to refining with a matrix that
is not equivalent to the input matrix, producing error esti-
mates that may not be reliable.
B (input)
B is DOUBLE PRECISION array, dimension (LDB,NRHS)
The right-hand-side matrix B.
LDB (input)
LDB is INTEGER
The leading dimension of the array B.
LDB >= max(1,N).
Y (input/output)
Y is DOUBLE PRECISION array, dimension (LDY,NRHS)
On entry, the solution matrix X, as computed by DGETRS.
On exit, the improved solution matrix Y.
LDY (input)
LDY is INTEGER
The leading dimension of the array Y.
LDY >= max(1,N).
BERR_OUT (output)
BERR_OUT is DOUBLE PRECISION array, dimension (NRHS)
On exit, BERR_OUT(j) contains the componentwise relative
backward error for right-hand-side j from the formula
max(i)(abs(RES(i))/(abs(op(A_s))*abs(Y)+abs(B_s))(i))
where abs(Z) is the componentwise absolute value of the
matrix or vector Z. This is computed by DLA_LIN_BERR.
N_NORMS (input)
N_NORMS is INTEGER
Determines which error bounds to return (see ERRS_N and
ERRS_C).
If N_NORMS >= 1 return normwise error bounds.
If N_NORMS >= 2 return componentwise error bounds.
ERRS_N (input/output)
ERRS_N is DOUBLE PRECISION array, dimension (NRHS, N_NORMS)
For each right-hand side, this array contains information
about various error bounds and condition numbers correspond-
ing to the normwise relative error, which is defined as fol-
lows: Normwise relative error in the ith solution vector:
max_j (abs(XTRUE(j,i) - X(j,i)))
------------------------------
max_j abs(X(j,i))
The array is indexed by the type of error information as
described below. There currently are up to three pieces of
information returned.
The first index in ERRS_N(i,:) corresponds to the ith right-
hand side.
The second index in ERRS_N(:,err) contains the following
three fields:
err = 1 "Trust/don't trust" boolean. Trust the answer if the
reciprocal condition number is less than the threshold
sqrt(n) * slamch('Epsilon').
err = 2 "Guaranteed" error bound: The estimated forward
error, almost certainly within a factor of 10 of the true
error so long as the next entry is greater than the threshold
sqrt(n) * slamch('Epsilon'). This error bound should only be
trusted if the previous boolean is true.
err = 3 Reciprocal condition number: Estimated normwise
reciprocal condition number. Compared with the threshold
sqrt(n) * slamch('Epsilon') to determine if the error esti-
mate is "guaranteed". These reciprocal condition numbers are
1/(norm(Z^{-1},inf)*norm(Z,inf)) for some appropriately
scaled matrix Z.
Let Z = S*A, where S scales each row by a power of the radix
so all absolute row sums of Z are approximately 1. This sub-
routine is only responsible for setting the second field
above.
See Lapack Working Note 165 for further details and extra
cautions.
ERRS_C (input/output)
ERRS_C is DOUBLE PRECISION array, dimension (NRHS, N_NORMS)
For each right-hand side, this array contains information
about various error bounds and condition numbers correspond-
ing to the componentwise relative error, which is defined as
follows:
Componentwise relative error in the ith solution vector:
abs(XTRUE(j,i) - X(j,i))
max_j ----------------------
abs(X(j,i))
The array is indexed by the right-hand side i (on which the
componentwise relative error depends), and the type of error
information as described below. There currently are up to
three pieces of information returned for each right-hand
side. If componentwise accuracy is not requested (PARAMS(3) =
0.0), then ERRS_C is not accessed. If N_NORMS .LT. 3, then
at most the first (:,N_NORMS) entries are returned.
The first index in ERRS_C(i,:) corresponds to the ith right-
hand side.
The second index in ERRS_C(:,err) contains the following
three fields:
err = 1 "Trust/don't trust" boolean. Trust the answer if the
reciprocal condition number is less than the threshold
sqrt(n) * slamch('Epsilon').
err = 2 "Guaranteed" error bound: The estimated forward
error, almost certainly within a factor of 10 of the true
error so long as the next entry is greater than the threshold
sqrt(n) * slamch('Epsilon'). This error bound should only be
trusted if the previous boolean is true.
err = 3 Reciprocal condition number: Estimated componentwise
reciprocal condition number. Compared with the threshold
sqrt(n) * slamch('Epsilon') to determine if the error esti-
mate is "guaranteed". These reciprocal condition numbers are
1/(norm(Z^{-1},inf)*norm(Z,inf)) for some appropriately
scaled matrix Z.
Let Z = S*(A*diag(x)), where x is the solution for the cur-
rent right-hand side and S scales each row of A*diag(x) by a
power of the radix so all absolute row sums of Z are approxi-
mately 1.
This subroutine is only responsible for setting the second
field above. See Lapack Working Note 165 for further details
and extra cautions.
RES (input)
RES is DOUBLE PRECISION array, dimension (N)
Workspace to hold the intermediate residual.
AYB (input)
AYB is DOUBLE PRECISION array, dimension (N)
Workspace. This can be the same workspace passed for Y_TAIL.
DY (input)
DY is DOUBLE PRECISION array, dimension (N)
Workspace to hold the intermediate solution.
Y_TAIL (input)
Y_TAIL is DOUBLE PRECISION array, dimension (N)
Workspace to hold the trailing bits of the intermediate solu-
tion.
RCOND (input)
RCOND is DOUBLE PRECISION
Reciprocal scaled condition number. This is an estimate of
the reciprocal Skeel condition number of the matrix A after
equilibration (if done). If this is less than the machine
precision (in particular, if it is zero), the matrix is sin-
gular to working precision. Note that the error may still be
small even if this number is very small and the matrix
appears ill- conditioned.
ITHRESH (input)
ITHRESH is INTEGER
The maximum number of residual computations allowed for
refinement. The default is 10. For 'aggressive' set to 100 to
permit convergence using approximate factorizations or fac-
torizations other than LU. If the factorization uses a tech-
nique other than Gaussian elimination, the guarantees in
ERRS_N and ERRS_C may no longer be trustworthy.
RTHRESH (input)
RTHRESH is DOUBLE PRECISION
Determines when to stop refinement if the error estimate
stops decreasing. Refinement will stop when the next solution
no longer satisfies norm(dx_{i+1}) < RTHRESH * norm(dx_i)
where norm(Z) is the infinity norm of Z. RTHRESH satisfies 0
< RTHRESH <= 1. The default value is 0.5. For 'aggressive'
set to 0.9 to permit convergence on extremely ill-conditioned
matrices. See LAWN 165 for more details.
DZ_UB (input)
DZ_UB is DOUBLE PRECISION
Determines when to start considering componentwise conver-
gence. Componentwise convergence is only considered after
each component of the solution Y is stable, which we definte
as the relative change in each component being less than
DZ_UB. The default value is 0.25, requiring the first bit to
be stable. See LAWN 165 for more details.
IGNORE_CWISE (input)
IGNORE_CWISE is LOGICAL
If .TRUE. then ignore componentwise convergence. Default
value is .FALSE..
INFO (output)
INFO is INTEGER
= 0: Successful exit.
< 0: if INFO = -i, the ith argument to DGETRS had an illegal
value
7 Nov 2015 dla_gerfsx_extended(3P)