LAPACK 3.12.0
LAPACK: Linear Algebra PACKage
Loading...
Searching...
No Matches
ctgevc.f
Go to the documentation of this file.
1*> \brief \b CTGEVC
2*
3* =========== DOCUMENTATION ===========
4*
5* Online html documentation available at
6* http://www.netlib.org/lapack/explore-html/
7*
8*> \htmlonly
9*> Download CTGEVC + dependencies
10*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/ctgevc.f">
11*> [TGZ]</a>
12*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/ctgevc.f">
13*> [ZIP]</a>
14*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/ctgevc.f">
15*> [TXT]</a>
16*> \endhtmlonly
17*
18* Definition:
19* ===========
20*
21* SUBROUTINE CTGEVC( SIDE, HOWMNY, SELECT, N, S, LDS, P, LDP, VL,
22* LDVL, VR, LDVR, MM, M, WORK, RWORK, INFO )
23*
24* .. Scalar Arguments ..
25* CHARACTER HOWMNY, SIDE
26* INTEGER INFO, LDP, LDS, LDVL, LDVR, M, MM, N
27* ..
28* .. Array Arguments ..
29* LOGICAL SELECT( * )
30* REAL RWORK( * )
31* COMPLEX P( LDP, * ), S( LDS, * ), VL( LDVL, * ),
32* $ VR( LDVR, * ), WORK( * )
33* ..
34*
35*
36*
37*> \par Purpose:
38* =============
39*>
40*> \verbatim
41*>
42*> CTGEVC computes some or all of the right and/or left eigenvectors of
43*> a pair of complex matrices (S,P), where S and P are upper triangular.
44*> Matrix pairs of this type are produced by the generalized Schur
45*> factorization of a complex matrix pair (A,B):
46*>
47*> A = Q*S*Z**H, B = Q*P*Z**H
48*>
49*> as computed by CGGHRD + CHGEQZ.
50*>
51*> The right eigenvector x and the left eigenvector y of (S,P)
52*> corresponding to an eigenvalue w are defined by:
53*>
54*> S*x = w*P*x, (y**H)*S = w*(y**H)*P,
55*>
56*> where y**H denotes the conjugate transpose of y.
57*> The eigenvalues are not input to this routine, but are computed
58*> directly from the diagonal elements of S and P.
59*>
60*> This routine returns the matrices X and/or Y of right and left
61*> eigenvectors of (S,P), or the products Z*X and/or Q*Y,
62*> where Z and Q are input matrices.
63*> If Q and Z are the unitary factors from the generalized Schur
64*> factorization of a matrix pair (A,B), then Z*X and Q*Y
65*> are the matrices of right and left eigenvectors of (A,B).
66*> \endverbatim
67*
68* Arguments:
69* ==========
70*
71*> \param[in] SIDE
72*> \verbatim
73*> SIDE is CHARACTER*1
74*> = 'R': compute right eigenvectors only;
75*> = 'L': compute left eigenvectors only;
76*> = 'B': compute both right and left eigenvectors.
77*> \endverbatim
78*>
79*> \param[in] HOWMNY
80*> \verbatim
81*> HOWMNY is CHARACTER*1
82*> = 'A': compute all right and/or left eigenvectors;
83*> = 'B': compute all right and/or left eigenvectors,
84*> backtransformed by the matrices in VR and/or VL;
85*> = 'S': compute selected right and/or left eigenvectors,
86*> specified by the logical array SELECT.
87*> \endverbatim
88*>
89*> \param[in] SELECT
90*> \verbatim
91*> SELECT is LOGICAL array, dimension (N)
92*> If HOWMNY='S', SELECT specifies the eigenvectors to be
93*> computed. The eigenvector corresponding to the j-th
94*> eigenvalue is computed if SELECT(j) = .TRUE..
95*> Not referenced if HOWMNY = 'A' or 'B'.
96*> \endverbatim
97*>
98*> \param[in] N
99*> \verbatim
100*> N is INTEGER
101*> The order of the matrices S and P. N >= 0.
102*> \endverbatim
103*>
104*> \param[in] S
105*> \verbatim
106*> S is COMPLEX array, dimension (LDS,N)
107*> The upper triangular matrix S from a generalized Schur
108*> factorization, as computed by CHGEQZ.
109*> \endverbatim
110*>
111*> \param[in] LDS
112*> \verbatim
113*> LDS is INTEGER
114*> The leading dimension of array S. LDS >= max(1,N).
115*> \endverbatim
116*>
117*> \param[in] P
118*> \verbatim
119*> P is COMPLEX array, dimension (LDP,N)
120*> The upper triangular matrix P from a generalized Schur
121*> factorization, as computed by CHGEQZ. P must have real
122*> diagonal elements.
123*> \endverbatim
124*>
125*> \param[in] LDP
126*> \verbatim
127*> LDP is INTEGER
128*> The leading dimension of array P. LDP >= max(1,N).
129*> \endverbatim
130*>
131*> \param[in,out] VL
132*> \verbatim
133*> VL is COMPLEX array, dimension (LDVL,MM)
134*> On entry, if SIDE = 'L' or 'B' and HOWMNY = 'B', VL must
135*> contain an N-by-N matrix Q (usually the unitary matrix Q
136*> of left Schur vectors returned by CHGEQZ).
137*> On exit, if SIDE = 'L' or 'B', VL contains:
138*> if HOWMNY = 'A', the matrix Y of left eigenvectors of (S,P);
139*> if HOWMNY = 'B', the matrix Q*Y;
140*> if HOWMNY = 'S', the left eigenvectors of (S,P) specified by
141*> SELECT, stored consecutively in the columns of
142*> VL, in the same order as their eigenvalues.
143*> Not referenced if SIDE = 'R'.
144*> \endverbatim
145*>
146*> \param[in] LDVL
147*> \verbatim
148*> LDVL is INTEGER
149*> The leading dimension of array VL. LDVL >= 1, and if
150*> SIDE = 'L' or 'l' or 'B' or 'b', LDVL >= N.
151*> \endverbatim
152*>
153*> \param[in,out] VR
154*> \verbatim
155*> VR is COMPLEX array, dimension (LDVR,MM)
156*> On entry, if SIDE = 'R' or 'B' and HOWMNY = 'B', VR must
157*> contain an N-by-N matrix Z (usually the unitary matrix Z
158*> of right Schur vectors returned by CHGEQZ).
159*> On exit, if SIDE = 'R' or 'B', VR contains:
160*> if HOWMNY = 'A', the matrix X of right eigenvectors of (S,P);
161*> if HOWMNY = 'B', the matrix Z*X;
162*> if HOWMNY = 'S', the right eigenvectors of (S,P) specified by
163*> SELECT, stored consecutively in the columns of
164*> VR, in the same order as their eigenvalues.
165*> Not referenced if SIDE = 'L'.
166*> \endverbatim
167*>
168*> \param[in] LDVR
169*> \verbatim
170*> LDVR is INTEGER
171*> The leading dimension of the array VR. LDVR >= 1, and if
172*> SIDE = 'R' or 'B', LDVR >= N.
173*> \endverbatim
174*>
175*> \param[in] MM
176*> \verbatim
177*> MM is INTEGER
178*> The number of columns in the arrays VL and/or VR. MM >= M.
179*> \endverbatim
180*>
181*> \param[out] M
182*> \verbatim
183*> M is INTEGER
184*> The number of columns in the arrays VL and/or VR actually
185*> used to store the eigenvectors. If HOWMNY = 'A' or 'B', M
186*> is set to N. Each selected eigenvector occupies one column.
187*> \endverbatim
188*>
189*> \param[out] WORK
190*> \verbatim
191*> WORK is COMPLEX array, dimension (2*N)
192*> \endverbatim
193*>
194*> \param[out] RWORK
195*> \verbatim
196*> RWORK is REAL array, dimension (2*N)
197*> \endverbatim
198*>
199*> \param[out] INFO
200*> \verbatim
201*> INFO is INTEGER
202*> = 0: successful exit.
203*> < 0: if INFO = -i, the i-th argument had an illegal value.
204*> \endverbatim
205*
206* Authors:
207* ========
208*
209*> \author Univ. of Tennessee
210*> \author Univ. of California Berkeley
211*> \author Univ. of Colorado Denver
212*> \author NAG Ltd.
213*
214*> \ingroup tgevc
215*
216* =====================================================================
217 SUBROUTINE ctgevc( SIDE, HOWMNY, SELECT, N, S, LDS, P, LDP, VL,
218 $ LDVL, VR, LDVR, MM, M, WORK, RWORK, INFO )
219*
220* -- LAPACK computational routine --
221* -- LAPACK is a software package provided by Univ. of Tennessee, --
222* -- Univ. of California Berkeley, Univ. of Colorado Denver and NAG Ltd..--
223*
224* .. Scalar Arguments ..
225 CHARACTER HOWMNY, SIDE
226 INTEGER INFO, LDP, LDS, LDVL, LDVR, M, MM, N
227* ..
228* .. Array Arguments ..
229 LOGICAL SELECT( * )
230 REAL RWORK( * )
231 COMPLEX P( LDP, * ), S( LDS, * ), VL( LDVL, * ),
232 $ vr( ldvr, * ), work( * )
233* ..
234*
235*
236* =====================================================================
237*
238* .. Parameters ..
239 REAL ZERO, ONE
240 parameter( zero = 0.0e+0, one = 1.0e+0 )
241 COMPLEX CZERO, CONE
242 parameter( czero = ( 0.0e+0, 0.0e+0 ),
243 $ cone = ( 1.0e+0, 0.0e+0 ) )
244* ..
245* .. Local Scalars ..
246 LOGICAL COMPL, COMPR, ILALL, ILBACK, ILBBAD, ILCOMP,
247 $ lsa, lsb
248 INTEGER I, IBEG, IEIG, IEND, IHWMNY, IM, ISIDE, ISRC,
249 $ j, je, jr
250 REAL ACOEFA, ACOEFF, ANORM, ASCALE, BCOEFA, BIG,
251 $ bignum, bnorm, bscale, dmin, safmin, sbeta,
252 $ scale, small, temp, ulp, xmax
253 COMPLEX BCOEFF, CA, CB, D, SALPHA, SUM, SUMA, SUMB, X
254* ..
255* .. External Functions ..
256 LOGICAL LSAME
257 REAL SLAMCH
258 COMPLEX CLADIV
259 EXTERNAL lsame, slamch, cladiv
260* ..
261* .. External Subroutines ..
262 EXTERNAL cgemv, xerbla
263* ..
264* .. Intrinsic Functions ..
265 INTRINSIC abs, aimag, cmplx, conjg, max, min, real
266* ..
267* .. Statement Functions ..
268 REAL ABS1
269* ..
270* .. Statement Function definitions ..
271 abs1( x ) = abs( real( x ) ) + abs( aimag( x ) )
272* ..
273* .. Executable Statements ..
274*
275* Decode and Test the input parameters
276*
277 IF( lsame( howmny, 'A' ) ) THEN
278 ihwmny = 1
279 ilall = .true.
280 ilback = .false.
281 ELSE IF( lsame( howmny, 'S' ) ) THEN
282 ihwmny = 2
283 ilall = .false.
284 ilback = .false.
285 ELSE IF( lsame( howmny, 'B' ) ) THEN
286 ihwmny = 3
287 ilall = .true.
288 ilback = .true.
289 ELSE
290 ihwmny = -1
291 END IF
292*
293 IF( lsame( side, 'R' ) ) THEN
294 iside = 1
295 compl = .false.
296 compr = .true.
297 ELSE IF( lsame( side, 'L' ) ) THEN
298 iside = 2
299 compl = .true.
300 compr = .false.
301 ELSE IF( lsame( side, 'B' ) ) THEN
302 iside = 3
303 compl = .true.
304 compr = .true.
305 ELSE
306 iside = -1
307 END IF
308*
309 info = 0
310 IF( iside.LT.0 ) THEN
311 info = -1
312 ELSE IF( ihwmny.LT.0 ) THEN
313 info = -2
314 ELSE IF( n.LT.0 ) THEN
315 info = -4
316 ELSE IF( lds.LT.max( 1, n ) ) THEN
317 info = -6
318 ELSE IF( ldp.LT.max( 1, n ) ) THEN
319 info = -8
320 END IF
321 IF( info.NE.0 ) THEN
322 CALL xerbla( 'CTGEVC', -info )
323 RETURN
324 END IF
325*
326* Count the number of eigenvectors
327*
328 IF( .NOT.ilall ) THEN
329 im = 0
330 DO 10 j = 1, n
331 IF( SELECT( j ) )
332 $ im = im + 1
333 10 CONTINUE
334 ELSE
335 im = n
336 END IF
337*
338* Check diagonal of B
339*
340 ilbbad = .false.
341 DO 20 j = 1, n
342 IF( aimag( p( j, j ) ).NE.zero )
343 $ ilbbad = .true.
344 20 CONTINUE
345*
346 IF( ilbbad ) THEN
347 info = -7
348 ELSE IF( compl .AND. ldvl.LT.n .OR. ldvl.LT.1 ) THEN
349 info = -10
350 ELSE IF( compr .AND. ldvr.LT.n .OR. ldvr.LT.1 ) THEN
351 info = -12
352 ELSE IF( mm.LT.im ) THEN
353 info = -13
354 END IF
355 IF( info.NE.0 ) THEN
356 CALL xerbla( 'CTGEVC', -info )
357 RETURN
358 END IF
359*
360* Quick return if possible
361*
362 m = im
363 IF( n.EQ.0 )
364 $ RETURN
365*
366* Machine Constants
367*
368 safmin = slamch( 'Safe minimum' )
369 big = one / safmin
370 ulp = slamch( 'Epsilon' )*slamch( 'Base' )
371 small = safmin*n / ulp
372 big = one / small
373 bignum = one / ( safmin*n )
374*
375* Compute the 1-norm of each column of the strictly upper triangular
376* part of A and B to check for possible overflow in the triangular
377* solver.
378*
379 anorm = abs1( s( 1, 1 ) )
380 bnorm = abs1( p( 1, 1 ) )
381 rwork( 1 ) = zero
382 rwork( n+1 ) = zero
383 DO 40 j = 2, n
384 rwork( j ) = zero
385 rwork( n+j ) = zero
386 DO 30 i = 1, j - 1
387 rwork( j ) = rwork( j ) + abs1( s( i, j ) )
388 rwork( n+j ) = rwork( n+j ) + abs1( p( i, j ) )
389 30 CONTINUE
390 anorm = max( anorm, rwork( j )+abs1( s( j, j ) ) )
391 bnorm = max( bnorm, rwork( n+j )+abs1( p( j, j ) ) )
392 40 CONTINUE
393*
394 ascale = one / max( anorm, safmin )
395 bscale = one / max( bnorm, safmin )
396*
397* Left eigenvectors
398*
399 IF( compl ) THEN
400 ieig = 0
401*
402* Main loop over eigenvalues
403*
404 DO 140 je = 1, n
405 IF( ilall ) THEN
406 ilcomp = .true.
407 ELSE
408 ilcomp = SELECT( je )
409 END IF
410 IF( ilcomp ) THEN
411 ieig = ieig + 1
412*
413 IF( abs1( s( je, je ) ).LE.safmin .AND.
414 $ abs( real( p( je, je ) ) ).LE.safmin ) THEN
415*
416* Singular matrix pencil -- return unit eigenvector
417*
418 DO 50 jr = 1, n
419 vl( jr, ieig ) = czero
420 50 CONTINUE
421 vl( ieig, ieig ) = cone
422 GO TO 140
423 END IF
424*
425* Non-singular eigenvalue:
426* Compute coefficients a and b in
427* H
428* y ( a A - b B ) = 0
429*
430 temp = one / max( abs1( s( je, je ) )*ascale,
431 $ abs( real( p( je, je ) ) )*bscale, safmin )
432 salpha = ( temp*s( je, je ) )*ascale
433 sbeta = ( temp*real( p( je, je ) ) )*bscale
434 acoeff = sbeta*ascale
435 bcoeff = salpha*bscale
436*
437* Scale to avoid underflow
438*
439 lsa = abs( sbeta ).GE.safmin .AND. abs( acoeff ).LT.small
440 lsb = abs1( salpha ).GE.safmin .AND. abs1( bcoeff ).LT.
441 $ small
442*
443 scale = one
444 IF( lsa )
445 $ scale = ( small / abs( sbeta ) )*min( anorm, big )
446 IF( lsb )
447 $ scale = max( scale, ( small / abs1( salpha ) )*
448 $ min( bnorm, big ) )
449 IF( lsa .OR. lsb ) THEN
450 scale = min( scale, one /
451 $ ( safmin*max( one, abs( acoeff ),
452 $ abs1( bcoeff ) ) ) )
453 IF( lsa ) THEN
454 acoeff = ascale*( scale*sbeta )
455 ELSE
456 acoeff = scale*acoeff
457 END IF
458 IF( lsb ) THEN
459 bcoeff = bscale*( scale*salpha )
460 ELSE
461 bcoeff = scale*bcoeff
462 END IF
463 END IF
464*
465 acoefa = abs( acoeff )
466 bcoefa = abs1( bcoeff )
467 xmax = one
468 DO 60 jr = 1, n
469 work( jr ) = czero
470 60 CONTINUE
471 work( je ) = cone
472 dmin = max( ulp*acoefa*anorm, ulp*bcoefa*bnorm, safmin )
473*
474* H
475* Triangular solve of (a A - b B) y = 0
476*
477* H
478* (rowwise in (a A - b B) , or columnwise in a A - b B)
479*
480 DO 100 j = je + 1, n
481*
482* Compute
483* j-1
484* SUM = sum conjg( a*S(k,j) - b*P(k,j) )*x(k)
485* k=je
486* (Scale if necessary)
487*
488 temp = one / xmax
489 IF( acoefa*rwork( j )+bcoefa*rwork( n+j ).GT.bignum*
490 $ temp ) THEN
491 DO 70 jr = je, j - 1
492 work( jr ) = temp*work( jr )
493 70 CONTINUE
494 xmax = one
495 END IF
496 suma = czero
497 sumb = czero
498*
499 DO 80 jr = je, j - 1
500 suma = suma + conjg( s( jr, j ) )*work( jr )
501 sumb = sumb + conjg( p( jr, j ) )*work( jr )
502 80 CONTINUE
503 sum = acoeff*suma - conjg( bcoeff )*sumb
504*
505* Form x(j) = - SUM / conjg( a*S(j,j) - b*P(j,j) )
506*
507* with scaling and perturbation of the denominator
508*
509 d = conjg( acoeff*s( j, j )-bcoeff*p( j, j ) )
510 IF( abs1( d ).LE.dmin )
511 $ d = cmplx( dmin )
512*
513 IF( abs1( d ).LT.one ) THEN
514 IF( abs1( sum ).GE.bignum*abs1( d ) ) THEN
515 temp = one / abs1( sum )
516 DO 90 jr = je, j - 1
517 work( jr ) = temp*work( jr )
518 90 CONTINUE
519 xmax = temp*xmax
520 sum = temp*sum
521 END IF
522 END IF
523 work( j ) = cladiv( -sum, d )
524 xmax = max( xmax, abs1( work( j ) ) )
525 100 CONTINUE
526*
527* Back transform eigenvector if HOWMNY='B'.
528*
529 IF( ilback ) THEN
530 CALL cgemv( 'N', n, n+1-je, cone, vl( 1, je ), ldvl,
531 $ work( je ), 1, czero, work( n+1 ), 1 )
532 isrc = 2
533 ibeg = 1
534 ELSE
535 isrc = 1
536 ibeg = je
537 END IF
538*
539* Copy and scale eigenvector into column of VL
540*
541 xmax = zero
542 DO 110 jr = ibeg, n
543 xmax = max( xmax, abs1( work( ( isrc-1 )*n+jr ) ) )
544 110 CONTINUE
545*
546 IF( xmax.GT.safmin ) THEN
547 temp = one / xmax
548 DO 120 jr = ibeg, n
549 vl( jr, ieig ) = temp*work( ( isrc-1 )*n+jr )
550 120 CONTINUE
551 ELSE
552 ibeg = n + 1
553 END IF
554*
555 DO 130 jr = 1, ibeg - 1
556 vl( jr, ieig ) = czero
557 130 CONTINUE
558*
559 END IF
560 140 CONTINUE
561 END IF
562*
563* Right eigenvectors
564*
565 IF( compr ) THEN
566 ieig = im + 1
567*
568* Main loop over eigenvalues
569*
570 DO 250 je = n, 1, -1
571 IF( ilall ) THEN
572 ilcomp = .true.
573 ELSE
574 ilcomp = SELECT( je )
575 END IF
576 IF( ilcomp ) THEN
577 ieig = ieig - 1
578*
579 IF( abs1( s( je, je ) ).LE.safmin .AND.
580 $ abs( real( p( je, je ) ) ).LE.safmin ) THEN
581*
582* Singular matrix pencil -- return unit eigenvector
583*
584 DO 150 jr = 1, n
585 vr( jr, ieig ) = czero
586 150 CONTINUE
587 vr( ieig, ieig ) = cone
588 GO TO 250
589 END IF
590*
591* Non-singular eigenvalue:
592* Compute coefficients a and b in
593*
594* ( a A - b B ) x = 0
595*
596 temp = one / max( abs1( s( je, je ) )*ascale,
597 $ abs( real( p( je, je ) ) )*bscale, safmin )
598 salpha = ( temp*s( je, je ) )*ascale
599 sbeta = ( temp*real( p( je, je ) ) )*bscale
600 acoeff = sbeta*ascale
601 bcoeff = salpha*bscale
602*
603* Scale to avoid underflow
604*
605 lsa = abs( sbeta ).GE.safmin .AND. abs( acoeff ).LT.small
606 lsb = abs1( salpha ).GE.safmin .AND. abs1( bcoeff ).LT.
607 $ small
608*
609 scale = one
610 IF( lsa )
611 $ scale = ( small / abs( sbeta ) )*min( anorm, big )
612 IF( lsb )
613 $ scale = max( scale, ( small / abs1( salpha ) )*
614 $ min( bnorm, big ) )
615 IF( lsa .OR. lsb ) THEN
616 scale = min( scale, one /
617 $ ( safmin*max( one, abs( acoeff ),
618 $ abs1( bcoeff ) ) ) )
619 IF( lsa ) THEN
620 acoeff = ascale*( scale*sbeta )
621 ELSE
622 acoeff = scale*acoeff
623 END IF
624 IF( lsb ) THEN
625 bcoeff = bscale*( scale*salpha )
626 ELSE
627 bcoeff = scale*bcoeff
628 END IF
629 END IF
630*
631 acoefa = abs( acoeff )
632 bcoefa = abs1( bcoeff )
633 xmax = one
634 DO 160 jr = 1, n
635 work( jr ) = czero
636 160 CONTINUE
637 work( je ) = cone
638 dmin = max( ulp*acoefa*anorm, ulp*bcoefa*bnorm, safmin )
639*
640* Triangular solve of (a A - b B) x = 0 (columnwise)
641*
642* WORK(1:j-1) contains sums w,
643* WORK(j+1:JE) contains x
644*
645 DO 170 jr = 1, je - 1
646 work( jr ) = acoeff*s( jr, je ) - bcoeff*p( jr, je )
647 170 CONTINUE
648 work( je ) = cone
649*
650 DO 210 j = je - 1, 1, -1
651*
652* Form x(j) := - w(j) / d
653* with scaling and perturbation of the denominator
654*
655 d = acoeff*s( j, j ) - bcoeff*p( j, j )
656 IF( abs1( d ).LE.dmin )
657 $ d = cmplx( dmin )
658*
659 IF( abs1( d ).LT.one ) THEN
660 IF( abs1( work( j ) ).GE.bignum*abs1( d ) ) THEN
661 temp = one / abs1( work( j ) )
662 DO 180 jr = 1, je
663 work( jr ) = temp*work( jr )
664 180 CONTINUE
665 END IF
666 END IF
667*
668 work( j ) = cladiv( -work( j ), d )
669*
670 IF( j.GT.1 ) THEN
671*
672* w = w + x(j)*(a S(*,j) - b P(*,j) ) with scaling
673*
674 IF( abs1( work( j ) ).GT.one ) THEN
675 temp = one / abs1( work( j ) )
676 IF( acoefa*rwork( j )+bcoefa*rwork( n+j ).GE.
677 $ bignum*temp ) THEN
678 DO 190 jr = 1, je
679 work( jr ) = temp*work( jr )
680 190 CONTINUE
681 END IF
682 END IF
683*
684 ca = acoeff*work( j )
685 cb = bcoeff*work( j )
686 DO 200 jr = 1, j - 1
687 work( jr ) = work( jr ) + ca*s( jr, j ) -
688 $ cb*p( jr, j )
689 200 CONTINUE
690 END IF
691 210 CONTINUE
692*
693* Back transform eigenvector if HOWMNY='B'.
694*
695 IF( ilback ) THEN
696 CALL cgemv( 'N', n, je, cone, vr, ldvr, work, 1,
697 $ czero, work( n+1 ), 1 )
698 isrc = 2
699 iend = n
700 ELSE
701 isrc = 1
702 iend = je
703 END IF
704*
705* Copy and scale eigenvector into column of VR
706*
707 xmax = zero
708 DO 220 jr = 1, iend
709 xmax = max( xmax, abs1( work( ( isrc-1 )*n+jr ) ) )
710 220 CONTINUE
711*
712 IF( xmax.GT.safmin ) THEN
713 temp = one / xmax
714 DO 230 jr = 1, iend
715 vr( jr, ieig ) = temp*work( ( isrc-1 )*n+jr )
716 230 CONTINUE
717 ELSE
718 iend = 0
719 END IF
720*
721 DO 240 jr = iend + 1, n
722 vr( jr, ieig ) = czero
723 240 CONTINUE
724*
725 END IF
726 250 CONTINUE
727 END IF
728*
729 RETURN
730*
731* End of CTGEVC
732*
733 END
subroutine xerbla(srname, info)
Definition cblat2.f:3285
subroutine cgemv(trans, m, n, alpha, a, lda, x, incx, beta, y, incy)
CGEMV
Definition cgemv.f:160
subroutine ctgevc(side, howmny, select, n, s, lds, p, ldp, vl, ldvl, vr, ldvr, mm, m, work, rwork, info)
CTGEVC
Definition ctgevc.f:219