OpenRadioss 2025.1.11
OpenRadioss project
Loading...
Searching...
No Matches
cqrt17.f
Go to the documentation of this file.
1*> \brief \b CQRT17
2*
3* =========== DOCUMENTATION ===========
4*
5* Online html documentation available at
6* http://www.netlib.org/lapack/explore-html/
7*
8* Definition:
9* ===========
10*
11* REAL FUNCTION CQRT17( TRANS, IRESID, M, N, NRHS, A,
12* LDA, X, LDX, B, LDB, C, WORK, LWORK )
13*
14* .. Scalar Arguments ..
15* CHARACTER TRANS
16* INTEGER IRESID, LDA, LDB, LDX, LWORK, M, N, NRHS
17* ..
18* .. Array Arguments ..
19* COMPLEX A( LDA, * ), B( LDB, * ), C( LDB, * ),
20* $ WORK( LWORK ), X( LDX, * )
21* ..
22*
23*
24*> \par Purpose:
25* =============
26*>
27*> \verbatim
28*>
29*> CQRT17 computes the ratio
30*>
31*> norm(R**H * op(A)) / ( norm(A) * alpha * max(M,N,NRHS) * EPS ),
32*>
33*> where R = B - op(A)*X, op(A) is A or A**H, depending on TRANS, EPS
34*> is the machine epsilon, and
35*>
36*> alpha = norm(B) if IRESID = 1 (zero-residual problem)
37*> alpha = norm(R) if IRESID = 2 (otherwise).
38*>
39*> The norm used is the 1-norm.
40*> \endverbatim
41*
42* Arguments:
43* ==========
44*
45*> \param[in] TRANS
46*> \verbatim
47*> TRANS is CHARACTER*1
48*> Specifies whether or not the transpose of A is used.
49*> = 'N': No transpose, op(A) = A.
50*> = 'C': Conjugate transpose, op(A) = A**H.
51*> \endverbatim
52*>
53*> \param[in] IRESID
54*> \verbatim
55*> IRESID is INTEGER
56*> IRESID = 1 indicates zero-residual problem.
57*> IRESID = 2 indicates non-zero residual.
58*> \endverbatim
59*>
60*> \param[in] M
61*> \verbatim
62*> M is INTEGER
63*> The number of rows of the matrix A.
64*> If TRANS = 'N', the number of rows of the matrix B.
65*> If TRANS = 'C', the number of rows of the matrix X.
66*> \endverbatim
67*>
68*> \param[in] N
69*> \verbatim
70*> N is INTEGER
71*> The number of columns of the matrix A.
72*> If TRANS = 'N', the number of rows of the matrix X.
73*> If TRANS = 'C', the number of rows of the matrix B.
74*> \endverbatim
75*>
76*> \param[in] NRHS
77*> \verbatim
78*> NRHS is INTEGER
79*> The number of columns of the matrices X and B.
80*> \endverbatim
81*>
82*> \param[in] A
83*> \verbatim
84*> A is COMPLEX array, dimension (LDA,N)
85*> The m-by-n matrix A.
86*> \endverbatim
87*>
88*> \param[in] LDA
89*> \verbatim
90*> LDA is INTEGER
91*> The leading dimension of the array A. LDA >= M.
92*> \endverbatim
93*>
94*> \param[in] X
95*> \verbatim
96*> X is COMPLEX array, dimension (LDX,NRHS)
97*> If TRANS = 'N', the n-by-nrhs matrix X.
98*> If TRANS = 'C', the m-by-nrhs matrix X.
99*> \endverbatim
100*>
101*> \param[in] LDX
102*> \verbatim
103*> LDX is INTEGER
104*> The leading dimension of the array X.
105*> If TRANS = 'N', LDX >= N.
106*> If TRANS = 'C', LDX >= M.
107*> \endverbatim
108*>
109*> \param[in] B
110*> \verbatim
111*> B is COMPLEX array, dimension (LDB,NRHS)
112*> If TRANS = 'N', the m-by-nrhs matrix B.
113*> If TRANS = 'C', the n-by-nrhs matrix B.
114*> \endverbatim
115*>
116*> \param[in] LDB
117*> \verbatim
118*> LDB is INTEGER
119*> The leading dimension of the array B.
120*> If TRANS = 'N', LDB >= M.
121*> If TRANS = 'C', LDB >= N.
122*> \endverbatim
123*>
124*> \param[out] C
125*> \verbatim
126*> C is COMPLEX array, dimension (LDB,NRHS)
127*> \endverbatim
128*>
129*> \param[out] WORK
130*> \verbatim
131*> WORK is COMPLEX array, dimension (LWORK)
132*> \endverbatim
133*>
134*> \param[in] LWORK
135*> \verbatim
136*> LWORK is INTEGER
137*> The length of the array WORK. LWORK >= NRHS*(M+N).
138*> \endverbatim
139*
140* Authors:
141* ========
142*
143*> \author Univ. of Tennessee
144*> \author Univ. of California Berkeley
145*> \author Univ. of Colorado Denver
146*> \author NAG Ltd.
147*
148*> \ingroup complex_lin
149*
150* =====================================================================
151 REAL function cqrt17( trans, iresid, m, n, nrhs, a,
152 $ lda, x, ldx, b, ldb, c, work, lwork )
153*
154* -- LAPACK test routine --
155* -- LAPACK is a software package provided by Univ. of Tennessee, --
156* -- Univ. of California Berkeley, Univ. of Colorado Denver and NAG Ltd..--
157*
158* .. Scalar Arguments ..
159 CHARACTER trans
160 INTEGER iresid, lda, ldb, ldx, lwork, m, n, nrhs
161* ..
162* .. Array Arguments ..
163 COMPLEX a( lda, * ), b( ldb, * ), c( ldb, * ),
164 $ work( lwork ), X( ldx, * )
165* ..
166*
167* =====================================================================
168*
169* .. Parameters ..
170 REAL zero, one
171 parameter( zero = 0.0e0, one = 1.0e0 )
172* ..
173* .. Local Scalars ..
174 INTEGER info, ISCL, ncols, NROWS
175 REAL err, norma, NORMB, normrs, smlnum
176* ..
177* .. Local Arrays ..
178 REAL rwork( 1 )
179* ..
180* .. External Functions ..
181 LOGICAL lsame
182 REAL clange, slamch
183 EXTERNAL lsame, clange, slamch
184* ..
185* .. External Subroutines ..
186 EXTERNAL cgemm, clacpy, clascl, xerbla
187* ..
188* .. Intrinsic Functions ..
189 INTRINSIC cmplx, max, real
190* ..
191* .. Executable Statements ..
192*
193 cqrt17 = zero
194*
195 IF( lsame( trans, 'N' ) ) THEN
196 nrows = m
197 ncols = n
198 ELSE IF( lsame( trans, 'c' ) ) THEN
199 NROWS = N
200 NCOLS = M
201 ELSE
202 CALL XERBLA( 'cqrt17', 1 )
203 RETURN
204 END IF
205*
206.LT. IF( LWORKNCOLS*NRHS ) THEN
207 CALL XERBLA( 'cqrt17', 13 )
208 RETURN
209 END IF
210*
211.LE..OR..LE..OR..LE. IF( M0 N0 NRHS0 )
212 $ RETURN
213*
214 NORMA = CLANGE( 'one-norm', M, N, A, LDA, RWORK )
215 SMLNUM = SLAMCH( 'safe minimum' ) / SLAMCH( 'precision' )
216 ISCL = 0
217*
218* compute residual and scale it
219*
220 CALL CLACPY( 'all', NROWS, NRHS, B, LDB, C, LDB )
221 CALL CGEMM( TRANS, 'no transpose', NROWS, NRHS, NCOLS,
222 $ CMPLX( -ONE ), A, LDA, X, LDX, CMPLX( ONE ), C, LDB )
223 NORMRS = CLANGE( 'max', NROWS, NRHS, C, LDB, RWORK )
224.GT. IF( NORMRSSMLNUM ) THEN
225 ISCL = 1
226 CALL CLASCL( 'general', 0, 0, NORMRS, ONE, NROWS, NRHS, C, LDB,
227 $ INFO )
228 END IF
229*
230* compute R**H * op(A)
231*
232 CALL CGEMM( 'conjugate transpose', TRANS, NRHS, NCOLS, NROWS,
233 $ CMPLX( ONE ), C, LDB, A, LDA, CMPLX( ZERO ), WORK,
234 $ NRHS )
235*
236* compute and properly scale error
237*
238 ERR = CLANGE( 'one-norm', NRHS, NCOLS, WORK, NRHS, RWORK )
239.NE. IF( NORMAZERO )
240 $ ERR = ERR / NORMA
241*
242.EQ. IF( ISCL1 )
243 $ ERR = ERR*NORMRS
244*
245.EQ. IF( IRESID1 ) THEN
246 NORMB = CLANGE( 'one-norm', NROWS, NRHS, B, LDB, RWORK )
247.NE. IF( NORMBZERO )
248 $ ERR = ERR / NORMB
249 ELSE
250.NE. IF( NORMRSZERO )
251 $ ERR = ERR / NORMRS
252 END IF
253*
254 CQRT17 = ERR / ( SLAMCH( 'epsilon' )*REAL( MAX( M, N, NRHS ) ) )
255 RETURN
256*
257* End of CQRT17
258*
259 END
float cmplx[2]
Definition pblas.h:136
norm(diag(diag(diag(inv(mat))) -id.SOL), 2) % destroy mumps instance id.JOB
subroutine xerbla(srname, info)
XERBLA
Definition xerbla.f:60
logical function lsame(ca, cb)
LSAME
Definition lsame.f:53
real function clange(norm, m, n, a, lda, work)
CLANGE returns the value of the 1-norm, Frobenius norm, infinity-norm, or the largest absolute value ...
Definition clange.f:115
subroutine clascl(type, kl, ku, cfrom, cto, m, n, a, lda, info)
CLASCL multiplies a general rectangular matrix by a real scalar defined as cto/cfrom.
Definition clascl.f:143
subroutine clacpy(uplo, m, n, a, lda, b, ldb)
CLACPY copies all or part of one two-dimensional array to another.
Definition clacpy.f:103
subroutine cgemm(transa, transb, m, n, k, alpha, a, lda, b, ldb, beta, c, ldc)
CGEMM
Definition cgemm.f:187
real function cqrt17(trans, iresid, m, n, nrhs, a, lda, x, ldx, b, ldb, c, work, lwork)
CQRT17
Definition cqrt17.f:153
real function slamch(cmach)
SLAMCH
Definition slamch.f:68
#define max(a, b)
Definition macros.h:21