OpenRadioss 2025.1.11
OpenRadioss project
Loading...
Searching...
No Matches
cchksy_aa.f
Go to the documentation of this file.
1*> \brief \b CCHKSY_AA
2*
3* =========== DOCUMENTATION ===========
4*
5* Online html documentation available at
6* http://www.netlib.org/lapack/explore-html/
7*
8* Definition:
9* ===========
10*
11* SUBROUTINE CCHKSY_AA( DOTYPE, NN, NVAL, NNB, NBVAL, NNS, NSVAL,
12* THRESH, TSTERR, NMAX, A, AFAC, AINV, B, X,
13* XACT, WORK, RWORK, IWORK, NOUT )
14*
15* .. Scalar Arguments ..
16* LOGICAL TSTERR
17* INTEGER NMAX, NN, NNB, NNS, NOUT
18* REAL THRESH
19* ..
20* .. Array Arguments ..
21* LOGICAL DOTYPE( * )
22* INTEGER IWORK( * ), NBVAL( * ), NSVAL( * ), NVAL( * )
23* COMPLEX A( * ), AFAC( * ), AINV( * ), B( * ),
24* $ RWORK( * ), WORK( * ), X( * ), XACT( * )
25* ..
26*
27*
28*> \par Purpose:
29* =============
30*>
31*> \verbatim
32*>
33*> CCHKSY_AA tests CSYTRF_AA, -TRS_AA.
34*> \endverbatim
35*
36* Arguments:
37* ==========
38*
39*> \param[in] DOTYPE
40*> \verbatim
41*> DOTYPE is LOGICAL array, dimension (NTYPES)
42*> The matrix types to be used for testing. Matrices of type j
43*> (for 1 <= j <= NTYPES) are used for testing if DOTYPE(j) =
44*> .TRUE.; if DOTYPE(j) = .FALSE., then type j is not used.
45*> \endverbatim
46*>
47*> \param[in] NN
48*> \verbatim
49*> NN is INTEGER
50*> The number of values of N contained in the vector NVAL.
51*> \endverbatim
52*>
53*> \param[in] NVAL
54*> \verbatim
55*> NVAL is INTEGER array, dimension (NN)
56*> The values of the matrix dimension N.
57*> \endverbatim
58*>
59*> \param[in] NNB
60*> \verbatim
61*> NNB is INTEGER
62*> The number of values of NB contained in the vector NBVAL.
63*> \endverbatim
64*>
65*> \param[in] NBVAL
66*> \verbatim
67*> NBVAL is INTEGER array, dimension (NNB)
68*> The values of the blocksize NB.
69*> \endverbatim
70*>
71*> \param[in] NNS
72*> \verbatim
73*> NNS is INTEGER
74*> The number of values of NRHS contained in the vector NSVAL.
75*> \endverbatim
76*>
77*> \param[in] NSVAL
78*> \verbatim
79*> NSVAL is INTEGER array, dimension (NNS)
80*> The values of the number of right hand sides NRHS.
81*> \endverbatim
82*>
83*> \param[in] THRESH
84*> \verbatim
85*> THRESH is REAL
86*> The threshold value for the test ratios. A result is
87*> included in the output file if RESULT >= THRESH. To have
88*> every test ratio printed, use THRESH = 0.
89*> \endverbatim
90*>
91*> \param[in] TSTERR
92*> \verbatim
93*> TSTERR is LOGICAL
94*> Flag that indicates whether error exits are to be tested.
95*> \endverbatim
96*>
97*> \param[in] NMAX
98*> \verbatim
99*> NMAX is INTEGER
100*> The maximum value permitted for N, used in dimensioning the
101*> work arrays.
102*> \endverbatim
103*>
104*> \param[out] A
105*> \verbatim
106*> A is REAL array, dimension (NMAX*NMAX)
107*> \endverbatim
108*>
109*> \param[out] AFAC
110*> \verbatim
111*> AFAC is REAL array, dimension (NMAX*NMAX)
112*> \endverbatim
113*>
114*> \param[out] AINV
115*> \verbatim
116*> AINV is REAL array, dimension (NMAX*NMAX)
117*> \endverbatim
118*>
119*> \param[out] B
120*> \verbatim
121*> B is REAL array, dimension (NMAX*NSMAX)
122*> where NSMAX is the largest entry in NSVAL.
123*> \endverbatim
124*>
125*> \param[out] X
126*> \verbatim
127*> X is REAL array, dimension (NMAX*NSMAX)
128*> \endverbatim
129*>
130*> \param[out] XACT
131*> \verbatim
132*> XACT is REAL array, dimension (NMAX*NSMAX)
133*> \endverbatim
134*>
135*> \param[out] WORK
136*> \verbatim
137*> WORK is REAL array, dimension (NMAX*max(3,NSMAX))
138*> \endverbatim
139*>
140*> \param[out] RWORK
141*> \verbatim
142*> RWORK is REAL array, dimension (max(NMAX,2*NSMAX))
143*> \endverbatim
144*>
145*> \param[out] IWORK
146*> \verbatim
147*> IWORK is INTEGER array, dimension (2*NMAX)
148*> \endverbatim
149*>
150*> \param[in] NOUT
151*> \verbatim
152*> NOUT is INTEGER
153*> The unit number for output.
154*> \endverbatim
155*
156* Authors:
157* ========
158*
159*> \author Univ. of Tennessee
160*> \author Univ. of California Berkeley
161*> \author Univ. of Colorado Denver
162*> \author NAG Ltd.
163*
164*> \ingroup complex_lin
165*
166* =====================================================================
167 SUBROUTINE cchksy_aa( DOTYPE, NN, NVAL, NNB, NBVAL, NNS, NSVAL,
168 $ THRESH, TSTERR, NMAX, A, AFAC, AINV, B,
169 $ X, XACT, WORK, RWORK, IWORK, NOUT )
170*
171* -- LAPACK test routine --
172* -- LAPACK is a software package provided by Univ. of Tennessee, --
173* -- Univ. of California Berkeley, Univ. of Colorado Denver and NAG Ltd..--
174*
175 IMPLICIT NONE
176*
177* .. Scalar Arguments ..
178 LOGICAL TSTERR
179 INTEGER NN, NNB, NNS, NMAX, NOUT
180 REAL THRESH
181* ..
182* .. Array Arguments ..
183 LOGICAL DOTYPE( * )
184 INTEGER IWORK( * ), NBVAL( * ), NSVAL( * ), NVAL( * )
185 REAL RWORK( * )
186 COMPLEX A( * ), AFAC( * ), AINV( * ), B( * ),
187 $ work( * ), x( * ), xact( * )
188* ..
189*
190* =====================================================================
191*
192* .. Parameters ..
193 REAL ZERO
194 PARAMETER ( ZERO = 0.0d+0 )
195 COMPLEX CZERO
196 parameter( czero = 0.0e+0 )
197 INTEGER NTYPES
198 parameter( ntypes = 10 )
199 INTEGER NTESTS
200 parameter( ntests = 9 )
201* ..
202* .. Local Scalars ..
203 LOGICAL ZEROT
204 CHARACTER DIST, TYPE, UPLO, XTYPE
205 CHARACTER*3 PATH, MATPATH
206 INTEGER I, I1, I2, IMAT, IN, INB, INFO, IOFF, IRHS,
207 $ iuplo, izero, j, k, kl, ku, lda, lwork, mode,
208 $ n, nb, nerrs, nfail, nimat, nrhs, nrun, nt
209 REAL ANORM, CNDNUM
210* ..
211* .. Local Arrays ..
212 CHARACTER UPLOS( 2 )
213 INTEGER ISEED( 4 ), ISEEDY( 4 )
214 REAL RESULT( NTESTS )
215* ..
216* .. External Subroutines ..
217 EXTERNAL alaerh, alahd, alasum, cerrsy, clacpy, clarhs,
220* ..
221* .. Intrinsic Functions ..
222 INTRINSIC max, min
223* ..
224* .. Scalars in Common ..
225 LOGICAL LERR, OK
226 CHARACTER*32 SRNAMT
227 INTEGER INFOT, NUNIT
228* ..
229* .. Common blocks ..
230 COMMON / infoc / infot, nunit, ok, lerr
231 COMMON / srnamc / srnamt
232* ..
233* .. Data statements ..
234 DATA iseedy / 1988, 1989, 1990, 1991 /
235 DATA uplos / 'u', 'l' /
236* ..
237* .. Executable Statements ..
238*
239* Initialize constants and the random number seed.
240*
241* Test path
242*
243 PATH( 1: 1 ) = 'Complex precision'
244 PATH( 2: 3 ) = 'SA'
245*
246* Path to generate matrices
247*
248 MATPATH( 1: 1 ) = 'Complex precision'
249 MATPATH( 2: 3 ) = 'SY'
250 NRUN = 0
251 NFAIL = 0
252 NERRS = 0
253 DO 10 I = 1, 4
254 ISEED( I ) = ISEEDY( I )
255 10 CONTINUE
256*
257* Test the error exits
258*
259 IF( TSTERR )
260 $ CALL CERRSY( PATH, NOUT )
261 INFOT = 0
262*
263* Set the minimum block size for which the block routine should
264* be used, which will be later returned by ILAENV
265*
266 CALL XLAENV( 2, 2 )
267*
268* Do for each value of N in NVAL
269*
270 DO 180 IN = 1, NN
271 N = NVAL( IN )
272.GT. IF( N NMAX ) THEN
273 NFAIL = NFAIL + 1
274 WRITE(NOUT, 9995) 'M ', N, NMAX
275 GO TO 180
276 END IF
277 LDA = MAX( N, 1 )
278 XTYPE = 'N'
279 NIMAT = NTYPES
280.LE. IF( N0 )
281 $ NIMAT = 1
282*
283 IZERO = 0
284*
285* Do for each value of matrix type IMAT
286*
287 DO 170 IMAT = 1, NIMAT
288*
289* Do the tests only if DOTYPE( IMAT ) is true.
290*
291.NOT. IF( DOTYPE( IMAT ) )
292 $ GO TO 170
293*
294* Skip types 3, 4, 5, or 6 if the matrix size is too small.
295*
296.GE..AND..LE. ZEROT = IMAT3 IMAT6
297.AND..LT. IF( ZEROT NIMAT-2 )
298 $ GO TO 170
299*
300* Do first for UPLO = 'U', then for UPLO = 'L'
301*
302 DO 160 IUPLO = 1, 2
303 UPLO = UPLOS( IUPLO )
304*
305* Begin generate the test matrix A.
306*
307*
308* Set up parameters with CLATB4 for the matrix generator
309* based on the type of matrix to be generated.
310*
311 CALL CLATB4( MATPATH, IMAT, N, N, TYPE, KL, KU,
312 $ ANORM, MODE, CNDNUM, DIST )
313*
314* Generate a matrix with CLATMS.
315*
316 SRNAMT = 'CLATMS'
317 CALL CLATMS( N, N, DIST, ISEED, TYPE, RWORK, MODE,
318 $ CNDNUM, ANORM, KL, KU, UPLO, A, LDA, WORK,
319 $ INFO )
320*
321* Check error code from CLATMS and handle error.
322*
323.NE. IF( INFO0 ) THEN
324 CALL ALAERH( PATH, 'CLATMS', INFO, 0, UPLO, N, N, -1,
325 $ -1, -1, IMAT, NFAIL, NERRS, NOUT )
326*
327* Skip all tests for this generated matrix
328*
329 GO TO 160
330 END IF
331*
332* For matrix types 3-6, zero one or more rows and
333* columns of the matrix to test that INFO is returned
334* correctly.
335*
336 IF( ZEROT ) THEN
337.EQ. IF( IMAT3 ) THEN
338 IZERO = 1
339.EQ. ELSE IF( IMAT4 ) THEN
340 IZERO = N
341 ELSE
342 IZERO = N / 2 + 1
343 END IF
344*
345.LT. IF( IMAT6 ) THEN
346*
347* Set row and column IZERO to zero.
348*
349.EQ. IF( IUPLO1 ) THEN
350 IOFF = ( IZERO-1 )*LDA
351 DO 20 I = 1, IZERO - 1
352 A( IOFF+I ) = CZERO
353 20 CONTINUE
354 IOFF = IOFF + IZERO
355 DO 30 I = IZERO, N
356 A( IOFF ) = CZERO
357 IOFF = IOFF + LDA
358 30 CONTINUE
359 ELSE
360 IOFF = IZERO
361 DO 40 I = 1, IZERO - 1
362 A( IOFF ) = CZERO
363 IOFF = IOFF + LDA
364 40 CONTINUE
365 IOFF = IOFF - IZERO
366 DO 50 I = IZERO, N
367 A( IOFF+I ) = CZERO
368 50 CONTINUE
369 END IF
370 ELSE
371.EQ. IF( IUPLO1 ) THEN
372*
373* Set the first IZERO rows and columns to zero.
374*
375 IOFF = 0
376 DO 70 J = 1, N
377 I2 = MIN( J, IZERO )
378 DO 60 I = 1, I2
379 A( IOFF+I ) = CZERO
380 60 CONTINUE
381 IOFF = IOFF + LDA
382 70 CONTINUE
383 IZERO = 1
384 ELSE
385*
386* Set the last IZERO rows and columns to zero.
387*
388 IOFF = 0
389 DO 90 J = 1, N
390 I1 = MAX( J, IZERO )
391 DO 80 I = I1, N
392 A( IOFF+I ) = CZERO
393 80 CONTINUE
394 IOFF = IOFF + LDA
395 90 CONTINUE
396 END IF
397 END IF
398 ELSE
399 IZERO = 0
400 END IF
401*
402* End generate the test matrix A.
403*
404* Do for each value of NB in NBVAL
405*
406 DO 150 INB = 1, NNB
407*
408* Set the optimal blocksize, which will be later
409* returned by ILAENV.
410*
411 NB = NBVAL( INB )
412 CALL XLAENV( 1, NB )
413*
414* Copy the test matrix A into matrix AFAC which
415* will be factorized in place. This is needed to
416* preserve the test matrix A for subsequent tests.
417*
418 CALL CLACPY( UPLO, N, N, A, LDA, AFAC, LDA )
419*
420* Compute the L*D*L**T or U*D*U**T factorization of the
421* matrix. IWORK stores details of the interchanges and
422* the block structure of D. AINV is a work array for
423* block factorization, LWORK is the length of AINV.
424*
425 SRNAMT = 'CSYTRF_AA'
426 LWORK = MAX( 1, N*NB + N )
427 CALL CSYTRF_AA( UPLO, N, AFAC, LDA, IWORK, AINV,
428 $ LWORK, INFO )
429*
430* Adjust the expected value of INFO to account for
431* pivoting.
432*
433c IF( IZERO.GT.0 ) THEN
434c J = 1
435c K = IZERO
436c 100 CONTINUE
437c IF( J.EQ.K ) THEN
438c K = IWORK( J )
439c ELSE IF( IWORK( J ).EQ.K ) THEN
440c K = J
441c END IF
442c IF( J.LT.K ) THEN
443c J = J + 1
444c GO TO 100
445c END IF
446c ELSE
447 K = 0
448c END IF
449*
450* Check error code from CSYTRF and handle error.
451*
452.NE. IF( INFOK ) THEN
453 CALL ALAERH( PATH, 'CSYTRF_AA', INFO, K, UPLO,
454 $ N, N, -1, -1, NB, IMAT, NFAIL, NERRS,
455 $ NOUT )
456 END IF
457*
458*+ TEST 1
459* Reconstruct matrix from factors and compute residual.
460*
461 CALL CSYT01_AA( UPLO, N, A, LDA, AFAC, LDA, IWORK,
462 $ AINV, LDA, RWORK, RESULT( 1 ) )
463 NT = 1
464*
465*
466* Print information about the tests that did not pass
467* the threshold.
468*
469 DO 110 K = 1, NT
470.GE. IF( RESULT( K )THRESH ) THEN
471.EQ..AND..EQ. IF( NFAIL0 NERRS0 )
472 $ CALL ALAHD( NOUT, PATH )
473 WRITE( NOUT, FMT = 9999 )UPLO, N, NB, IMAT, K,
474 $ RESULT( K )
475 NFAIL = NFAIL + 1
476 END IF
477 110 CONTINUE
478 NRUN = NRUN + NT
479*
480* Skip solver test if INFO is not 0.
481*
482.NE. IF( INFO0 ) THEN
483 GO TO 140
484 END IF
485*
486* Do for each value of NRHS in NSVAL.
487*
488 DO 130 IRHS = 1, NNS
489 NRHS = NSVAL( IRHS )
490*
491*+ TEST 2 (Using TRS)
492* Solve and compute residual for A * X = B.
493*
494* Choose a set of NRHS random solution vectors
495* stored in XACT and set up the right hand side B
496*
497 SRNAMT = 'CLARHS'
498 CALL CLARHS( MATPATH, XTYPE, UPLO, ' ', N, N,
499 $ KL, KU, NRHS, A, LDA, XACT, LDA,
500 $ B, LDA, ISEED, INFO )
501 CALL CLACPY( 'Full', N, NRHS, B, LDA, X, LDA )
502*
503 SRNAMT = 'CSYTRS_AA'
504 LWORK = MAX( 1, 3*N-2 )
505 CALL CSYTRS_AA( UPLO, N, NRHS, AFAC, LDA,
506 $ IWORK, X, LDA, WORK, LWORK,
507 $ INFO )
508*
509* Check error code from CSYTRS and handle error.
510*
511.NE. IF( INFO0 ) THEN
512.EQ. IF( IZERO0 ) THEN
513 CALL ALAERH( PATH, 'CSYTRS_AA', INFO, 0,
514 $ UPLO, N, N, -1, -1, NRHS, IMAT,
515 $ NFAIL, NERRS, NOUT )
516 END IF
517 ELSE
518 CALL CLACPY( 'Full', N, NRHS, B, LDA, WORK, LDA
519 $ )
520*
521* Compute the residual for the solution
522*
523 CALL CSYT02( UPLO, N, NRHS, A, LDA, X, LDA,
524 $ WORK, LDA, RWORK, RESULT( 2 ) )
525*
526*
527* Print information about the tests that did not pass
528* the threshold.
529*
530 DO 120 K = 2, 2
531.GE. IF( RESULT( K )THRESH ) THEN
532.EQ..AND..EQ. IF( NFAIL0 NERRS0 )
533 $ CALL ALAHD( NOUT, PATH )
534 WRITE( NOUT, FMT = 9998 )UPLO, N, NRHS,
535 $ IMAT, K, RESULT( K )
536 NFAIL = NFAIL + 1
537 END IF
538 120 CONTINUE
539 END IF
540 NRUN = NRUN + 1
541*
542* End do for each value of NRHS in NSVAL.
543*
544 130 CONTINUE
545 140 CONTINUE
546 150 CONTINUE
547 160 CONTINUE
548 170 CONTINUE
549 180 CONTINUE
550*
551* Print a summary of the results.
552*
553 CALL ALASUM( PATH, NOUT, NFAIL, NRUN, NERRS )
554*
555 9999 FORMAT( ' UPLO = ''', A1, ''', n =', I5, ', nb =', I4, ', type ',
556 $ I2, ', test ', I2, ', ratio =', G12.5 )
557 9998 FORMAT( ' uplo = ''', A1, ''', n =', I5, ', nrhs=', I3, ', type ',
558 $ I2, ', test(', I2, ') =', G12.5 )
559 9995 FORMAT( ' invalid input value: ', A4, '=', I6, '; must be <=',
560 $ I6 )
561 RETURN
562*
563* End of CCHKSY_AA
564*
565 END
subroutine xlaenv(ispec, nvalue)
XLAENV
Definition xlaenv.f:81
subroutine alasum(type, nout, nfail, nrun, nerrs)
ALASUM
Definition alasum.f:73
subroutine alahd(iounit, path)
ALAHD
Definition alahd.f:107
subroutine alaerh(path, subnam, info, infoe, opts, m, n, kl, ku, n5, imat, nfail, nerrs, nout)
ALAERH
Definition alaerh.f:147
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 csytrf_aa(uplo, n, a, lda, ipiv, work, lwork, info)
CSYTRF_AA
Definition csytrf_aa.f:132
subroutine csytrs_aa(uplo, n, nrhs, a, lda, ipiv, b, ldb, work, lwork, info)
CSYTRS_AA
Definition csytrs_aa.f:131
subroutine clarhs(path, xtype, uplo, trans, m, n, kl, ku, nrhs, a, lda, x, ldx, b, ldb, iseed, info)
CLARHS
Definition clarhs.f:208
subroutine cerrsy(path, nunit)
CERRSY
Definition cerrsy.f:55
subroutine csyt01_aa(uplo, n, a, lda, afac, ldafac, ipiv, c, ldc, rwork, resid)
CSYT01
Definition csyt01_aa.f:124
subroutine cchksy_aa(dotype, nn, nval, nnb, nbval, nns, nsval, thresh, tsterr, nmax, a, afac, ainv, b, x, xact, work, rwork, iwork, nout)
CCHKSY_AA
Definition cchksy_aa.f:170
subroutine csyt02(uplo, n, nrhs, a, lda, x, ldx, b, ldb, rwork, resid)
CSYT02
Definition csyt02.f:127
subroutine clatb4(path, imat, m, n, type, kl, ku, anorm, mode, cndnum, dist)
CLATB4
Definition clatb4.f:121
subroutine clatms(m, n, dist, iseed, sym, d, mode, cond, dmax, kl, ku, pack, a, lda, work, info)
CLATMS
Definition clatms.f:332
#define min(a, b)
Definition macros.h:20
#define max(a, b)
Definition macros.h:21