/* Subroutine */ int sgsvts_(integer *m, integer *p, integer *n, real *a, real *af, integer *lda, real *b, real *bf, integer *ldb, real *u, integer *ldu, real *v, integer *ldv, real *q, integer *ldq, real * alpha, real *beta, real *r__, integer *ldr, integer *iwork, real * work, integer *lwork, real *rwork, real *result) { /* System generated locals */ integer a_dim1, a_offset, af_dim1, af_offset, b_dim1, b_offset, bf_dim1, bf_offset, q_dim1, q_offset, r_dim1, r_offset, u_dim1, u_offset, v_dim1, v_offset, i__1, i__2; real r__1; /* Local variables */ integer i__, j, k, l; real ulp; integer info; real unfl, temp, resid; extern /* Subroutine */ int sgemm_(char *, char *, integer *, integer *, integer *, real *, real *, integer *, real *, integer *, real *, real *, integer *); real anorm, bnorm; extern /* Subroutine */ int scopy_(integer *, real *, integer *, real *, integer *), ssyrk_(char *, char *, integer *, integer *, real *, real *, integer *, real *, real *, integer *); extern doublereal slamch_(char *), slange_(char *, integer *, integer *, real *, integer *, real *); extern /* Subroutine */ int slacpy_(char *, integer *, integer *, real *, integer *, real *, integer *), slaset_(char *, integer *, integer *, real *, real *, real *, integer *), sggsvd_( char *, char *, char *, integer *, integer *, integer *, integer * , integer *, real *, integer *, real *, integer *, real *, real *, real *, integer *, real *, integer *, real *, integer *, real *, integer *, integer *); extern doublereal slansy_(char *, char *, integer *, real *, integer *, real *); real ulpinv; /* -- LAPACK test routine (version 3.1) -- */ /* Univ. of Tennessee, Univ. of California Berkeley and NAG Ltd.. */ /* November 2006 */ /* .. Scalar Arguments .. */ /* .. */ /* .. Array Arguments .. */ /* .. */ /* Purpose */ /* ======= */ /* SGSVTS tests SGGSVD, which computes the GSVD of an M-by-N matrix A */ /* and a P-by-N matrix B: */ /* U'*A*Q = D1*R and V'*B*Q = D2*R. */ /* Arguments */ /* ========= */ /* M (input) INTEGER */ /* The number of rows of the matrix A. M >= 0. */ /* P (input) INTEGER */ /* The number of rows of the matrix B. P >= 0. */ /* N (input) INTEGER */ /* The number of columns of the matrices A and B. N >= 0. */ /* A (input) REAL array, dimension (LDA,M) */ /* The M-by-N matrix A. */ /* AF (output) REAL array, dimension (LDA,N) */ /* Details of the GSVD of A and B, as returned by SGGSVD, */ /* see SGGSVD for further details. */ /* LDA (input) INTEGER */ /* The leading dimension of the arrays A and AF. */ /* LDA >= max( 1,M ). */ /* B (input) REAL array, dimension (LDB,P) */ /* On entry, the P-by-N matrix B. */ /* BF (output) REAL array, dimension (LDB,N) */ /* Details of the GSVD of A and B, as returned by SGGSVD, */ /* see SGGSVD for further details. */ /* LDB (input) INTEGER */ /* The leading dimension of the arrays B and BF. */ /* LDB >= max(1,P). */ /* U (output) REAL array, dimension(LDU,M) */ /* The M by M orthogonal matrix U. */ /* LDU (input) INTEGER */ /* The leading dimension of the array U. LDU >= max(1,M). */ /* V (output) REAL array, dimension(LDV,M) */ /* The P by P orthogonal matrix V. */ /* LDV (input) INTEGER */ /* The leading dimension of the array V. LDV >= max(1,P). */ /* Q (output) REAL array, dimension(LDQ,N) */ /* The N by N orthogonal matrix Q. */ /* LDQ (input) INTEGER */ /* The leading dimension of the array Q. LDQ >= max(1,N). */ /* ALPHA (output) REAL array, dimension (N) */ /* BETA (output) REAL array, dimension (N) */ /* The generalized singular value pairs of A and B, the */ /* ``diagonal'' matrices D1 and D2 are constructed from */ /* ALPHA and BETA, see subroutine SGGSVD for details. */ /* R (output) REAL array, dimension(LDQ,N) */ /* The upper triangular matrix R. */ /* LDR (input) INTEGER */ /* The leading dimension of the array R. LDR >= max(1,N). */ /* IWORK (workspace) INTEGER array, dimension (N) */ /* WORK (workspace) REAL array, dimension (LWORK) */ /* LWORK (input) INTEGER */ /* The dimension of the array WORK, */ /* LWORK >= max(M,P,N)*max(M,P,N). */ /* RWORK (workspace) REAL array, dimension (max(M,P,N)) */ /* RESULT (output) REAL array, dimension (6) */ /* The test ratios: */ /* RESULT(1) = norm( U'*A*Q - D1*R ) / ( MAX(M,N)*norm(A)*ULP) */ /* RESULT(2) = norm( V'*B*Q - D2*R ) / ( MAX(P,N)*norm(B)*ULP) */ /* RESULT(3) = norm( I - U'*U ) / ( M*ULP ) */ /* RESULT(4) = norm( I - V'*V ) / ( P*ULP ) */ /* RESULT(5) = norm( I - Q'*Q ) / ( N*ULP ) */ /* RESULT(6) = 0 if ALPHA is in decreasing order; */ /* = ULPINV otherwise. */ /* ===================================================================== */ /* .. Parameters .. */ /* .. */ /* .. Local Scalars .. */ /* .. */ /* .. External Functions .. */ /* .. */ /* .. External Subroutines .. */ /* .. */ /* .. Intrinsic Functions .. */ /* .. */ /* .. Executable Statements .. */ /* Parameter adjustments */ af_dim1 = *lda; af_offset = 1 + af_dim1; af -= af_offset; a_dim1 = *lda; a_offset = 1 + a_dim1; a -= a_offset; bf_dim1 = *ldb; bf_offset = 1 + bf_dim1; bf -= bf_offset; b_dim1 = *ldb; b_offset = 1 + b_dim1; b -= b_offset; u_dim1 = *ldu; u_offset = 1 + u_dim1; u -= u_offset; v_dim1 = *ldv; v_offset = 1 + v_dim1; v -= v_offset; q_dim1 = *ldq; q_offset = 1 + q_dim1; q -= q_offset; --alpha; --beta; r_dim1 = *ldr; r_offset = 1 + r_dim1; r__ -= r_offset; --iwork; --work; --rwork; --result; /* Function Body */ ulp = slamch_("Precision"); ulpinv = 1.f / ulp; unfl = slamch_("Safe minimum"); /* Copy the matrix A to the array AF. */ slacpy_("Full", m, n, &a[a_offset], lda, &af[af_offset], lda); slacpy_("Full", p, n, &b[b_offset], ldb, &bf[bf_offset], ldb); /* Computing MAX */ r__1 = slange_("1", m, n, &a[a_offset], lda, &rwork[1]); anorm = dmax(r__1,unfl); /* Computing MAX */ r__1 = slange_("1", p, n, &b[b_offset], ldb, &rwork[1]); bnorm = dmax(r__1,unfl); /* Factorize the matrices A and B in the arrays AF and BF. */ sggsvd_("U", "V", "Q", m, n, p, &k, &l, &af[af_offset], lda, &bf[ bf_offset], ldb, &alpha[1], &beta[1], &u[u_offset], ldu, &v[ v_offset], ldv, &q[q_offset], ldq, &work[1], &iwork[1], &info); /* Copy R */ /* Computing MIN */ i__2 = k + l; i__1 = min(i__2,*m); for (i__ = 1; i__ <= i__1; ++i__) { i__2 = k + l; for (j = i__; j <= i__2; ++j) { r__[i__ + j * r_dim1] = af[i__ + (*n - k - l + j) * af_dim1]; /* L10: */ } /* L20: */ } if (*m - k - l < 0) { i__1 = k + l; for (i__ = *m + 1; i__ <= i__1; ++i__) { i__2 = k + l; for (j = i__; j <= i__2; ++j) { r__[i__ + j * r_dim1] = bf[i__ - k + (*n - k - l + j) * bf_dim1]; /* L30: */ } /* L40: */ } } /* Compute A:= U'*A*Q - D1*R */ sgemm_("No transpose", "No transpose", m, n, n, &c_b17, &a[a_offset], lda, &q[q_offset], ldq, &c_b18, &work[1], lda) ; sgemm_("Transpose", "No transpose", m, n, m, &c_b17, &u[u_offset], ldu, & work[1], lda, &c_b18, &a[a_offset], lda); i__1 = k; for (i__ = 1; i__ <= i__1; ++i__) { i__2 = k + l; for (j = i__; j <= i__2; ++j) { a[i__ + (*n - k - l + j) * a_dim1] -= r__[i__ + j * r_dim1]; /* L50: */ } /* L60: */ } /* Computing MIN */ i__2 = k + l; i__1 = min(i__2,*m); for (i__ = k + 1; i__ <= i__1; ++i__) { i__2 = k + l; for (j = i__; j <= i__2; ++j) { a[i__ + (*n - k - l + j) * a_dim1] -= alpha[i__] * r__[i__ + j * r_dim1]; /* L70: */ } /* L80: */ } /* Compute norm( U'*A*Q - D1*R ) / ( MAX(1,M,N)*norm(A)*ULP ) . */ resid = slange_("1", m, n, &a[a_offset], lda, &rwork[1]); if (anorm > 0.f) { /* Computing MAX */ i__1 = max(1,*m); result[1] = resid / (real) max(i__1,*n) / anorm / ulp; } else { result[1] = 0.f; } /* Compute B := V'*B*Q - D2*R */ sgemm_("No transpose", "No transpose", p, n, n, &c_b17, &b[b_offset], ldb, &q[q_offset], ldq, &c_b18, &work[1], ldb) ; sgemm_("Transpose", "No transpose", p, n, p, &c_b17, &v[v_offset], ldv, & work[1], ldb, &c_b18, &b[b_offset], ldb); i__1 = l; for (i__ = 1; i__ <= i__1; ++i__) { i__2 = l; for (j = i__; j <= i__2; ++j) { b[i__ + (*n - l + j) * b_dim1] -= beta[k + i__] * r__[k + i__ + ( k + j) * r_dim1]; /* L90: */ } /* L100: */ } /* Compute norm( V'*B*Q - D2*R ) / ( MAX(P,N)*norm(B)*ULP ) . */ resid = slange_("1", p, n, &b[b_offset], ldb, &rwork[1]); if (bnorm > 0.f) { /* Computing MAX */ i__1 = max(1,*p); result[2] = resid / (real) max(i__1,*n) / bnorm / ulp; } else { result[2] = 0.f; } /* Compute I - U'*U */ slaset_("Full", m, m, &c_b18, &c_b17, &work[1], ldq); ssyrk_("Upper", "Transpose", m, m, &c_b44, &u[u_offset], ldu, &c_b17, & work[1], ldu); /* Compute norm( I - U'*U ) / ( M * ULP ) . */ resid = slansy_("1", "Upper", m, &work[1], ldu, &rwork[1]); result[3] = resid / (real) max(1,*m) / ulp; /* Compute I - V'*V */ slaset_("Full", p, p, &c_b18, &c_b17, &work[1], ldv); ssyrk_("Upper", "Transpose", p, p, &c_b44, &v[v_offset], ldv, &c_b17, & work[1], ldv); /* Compute norm( I - V'*V ) / ( P * ULP ) . */ resid = slansy_("1", "Upper", p, &work[1], ldv, &rwork[1]); result[4] = resid / (real) max(1,*p) / ulp; /* Compute I - Q'*Q */ slaset_("Full", n, n, &c_b18, &c_b17, &work[1], ldq); ssyrk_("Upper", "Transpose", n, n, &c_b44, &q[q_offset], ldq, &c_b17, & work[1], ldq); /* Compute norm( I - Q'*Q ) / ( N * ULP ) . */ resid = slansy_("1", "Upper", n, &work[1], ldq, &rwork[1]); result[5] = resid / (real) max(1,*n) / ulp; /* Check sorting */ scopy_(n, &alpha[1], &c__1, &work[1], &c__1); /* Computing MIN */ i__2 = k + l; i__1 = min(i__2,*m); for (i__ = k + 1; i__ <= i__1; ++i__) { j = iwork[i__]; if (i__ != j) { temp = work[i__]; work[i__] = work[j]; work[j] = temp; } /* L110: */ } result[6] = 0.f; /* Computing MIN */ i__2 = k + l; i__1 = min(i__2,*m) - 1; for (i__ = k + 1; i__ <= i__1; ++i__) { if (work[i__] < work[i__ + 1]) { result[6] = ulpinv; } /* L120: */ } return 0; /* End of SGSVTS */ } /* sgsvts_ */
/* Subroutine */ int serrgg_(char *path, integer *nunit) { /* Format strings */ static char fmt_9999[] = "(1x,a3,\002 routines passed the tests of the e" "rror exits (\002,i3,\002 tests done)\002)"; static char fmt_9998[] = "(\002 *** \002,a3,\002 routines failed the tes" "ts of the error \002,\002exits ***\002)"; /* Builtin functions */ integer s_wsle(cilist *), e_wsle(void); /* Subroutine */ int s_copy(char *, char *, ftnlen, ftnlen); integer s_wsfe(cilist *), do_fio(integer *, char *, ftnlen), e_wsfe(void); /* Local variables */ real a[9] /* was [3][3] */, b[9] /* was [3][3] */; integer i__, j, m; real q[9] /* was [3][3] */, u[9] /* was [3][3] */, v[9] /* was [3][3] */, w[18], z__[9] /* was [3][3] */; char c2[2]; real r1[3], r2[3], r3[3]; logical bw[3]; real ls[3]; integer iw[3], nt; real rs[3], dif, rce[2]; logical sel[3]; real tau[3], rcv[2]; integer info, sdim; real anrm, bnrm, tola, tolb; integer ifst, ilst; real scale; extern /* Subroutine */ int sgges_(char *, char *, char *, L_fp, integer * , real *, integer *, real *, integer *, integer *, real *, real *, real *, real *, integer *, real *, integer *, real *, integer *, logical *, integer *), sggev_(char *, char *, integer *, real *, integer *, real *, integer *, real *, real *, real *, real *, integer *, real *, integer *, real *, integer *, integer *); integer ncycle; extern /* Subroutine */ int sgghrd_(char *, char *, integer *, integer *, integer *, real *, integer *, real *, integer *, real *, integer * , real *, integer *, integer *); extern logical lsamen_(integer *, char *, char *); extern /* Subroutine */ int sggglm_(integer *, integer *, integer *, real *, integer *, real *, integer *, real *, real *, real *, real *, integer *, integer *), chkxer_(char *, integer *, integer *, logical *, logical *), sgglse_(integer *, integer *, integer *, real *, integer *, real *, integer *, real *, real *, real *, real *, integer *, integer *), sggqrf_(integer *, integer *, integer *, real *, integer *, real *, real *, integer *, real * , real *, integer *, integer *), sggrqf_(integer *, integer *, integer *, real *, integer *, real *, real *, integer *, real *, real *, integer *, integer *), stgevc_(char *, char *, logical *, integer *, real *, integer *, real *, integer *, real *, integer * , real *, integer *, integer *, integer *, real *, integer *); extern logical slctes_(); extern /* Subroutine */ int sggsvd_(char *, char *, char *, integer *, integer *, integer *, integer *, integer *, real *, integer *, real *, integer *, real *, real *, real *, integer *, real *, integer *, real *, integer *, real *, integer *, integer *), stgexc_(logical *, logical *, integer *, real *, integer *, real *, integer *, real *, integer *, real *, integer *, integer *, integer *, real *, integer *, integer *), sggesx_(char *, char *, char *, L_fp, char *, integer *, real *, integer *, real *, integer *, integer *, real *, real *, real *, real *, integer *, real *, integer *, real *, real *, real *, integer *, integer *, integer *, logical *, integer *), shgeqz_(char *, char *, char *, integer * , integer *, integer *, real *, integer *, real *, integer *, real *, real *, real *, real *, integer *, real *, integer *, real *, integer *, integer *), stgsja_( char *, char *, char *, integer *, integer *, integer *, integer * , integer *, real *, integer *, real *, integer *, real *, real *, real *, real *, real *, integer *, real *, integer *, real *, integer *, real *, integer *, integer *), sggevx_(char *, char *, char *, char *, integer *, real *, integer *, real *, integer *, real *, real *, real *, real *, integer *, real *, integer *, integer *, integer *, real *, real * , real *, real *, real *, real *, real *, integer *, integer *, logical *, integer *), stgsen_( integer *, logical *, logical *, logical *, integer *, real *, integer *, real *, integer *, real *, real *, real *, real *, integer *, real *, integer *, integer *, real *, real *, real *, real *, integer *, integer *, integer *, integer *), stgsna_(char *, char *, logical *, integer *, real *, integer *, real *, integer *, real *, integer *, real *, integer *, real *, real *, integer *, integer *, real *, integer *, integer *, integer *); integer dummyk, dummyl; extern /* Subroutine */ int sggsvp_(char *, char *, char *, integer *, integer *, integer *, real *, integer *, real *, integer *, real * , real *, integer *, integer *, real *, integer *, real *, integer *, real *, integer *, integer *, real *, real *, integer * ); extern logical slctsx_(); extern /* Subroutine */ int stgsyl_(char *, integer *, integer *, integer *, real *, integer *, real *, integer *, real *, integer *, real * , integer *, real *, integer *, real *, integer *, real *, real *, real *, integer *, integer *, integer *); /* Fortran I/O blocks */ static cilist io___1 = { 0, 0, 0, 0, 0 }; static cilist io___38 = { 0, 0, 0, fmt_9999, 0 }; static cilist io___39 = { 0, 0, 0, fmt_9998, 0 }; /* -- LAPACK test routine (version 3.1) -- */ /* Univ. of Tennessee, Univ. of California Berkeley and NAG Ltd.. */ /* November 2006 */ /* .. Scalar Arguments .. */ /* .. */ /* Purpose */ /* ======= */ /* SERRGG tests the error exits for SGGES, SGGESX, SGGEV, SGGEVX, */ /* SGGGLM, SGGHRD, SGGLSE, SGGQRF, SGGRQF, SGGSVD, SGGSVP, SHGEQZ, */ /* STGEVC, STGEXC, STGSEN, STGSJA, STGSNA, and STGSYL. */ /* Arguments */ /* ========= */ /* PATH (input) CHARACTER*3 */ /* The LAPACK path name for the routines to be tested. */ /* NUNIT (input) INTEGER */ /* The unit number for output. */ /* ===================================================================== */ /* .. Parameters .. */ /* .. */ /* .. Local Scalars .. */ /* .. */ /* .. Local Arrays .. */ /* .. */ /* .. External Functions .. */ /* .. */ /* .. External Subroutines .. */ /* .. */ /* .. Scalars in Common .. */ /* .. */ /* .. Common blocks .. */ /* .. */ /* .. Executable Statements .. */ infoc_1.nout = *nunit; io___1.ciunit = infoc_1.nout; s_wsle(&io___1); e_wsle(); s_copy(c2, path + 1, (ftnlen)2, (ftnlen)2); /* Set the variables to innocuous values. */ for (j = 1; j <= 3; ++j) { sel[j - 1] = TRUE_; for (i__ = 1; i__ <= 3; ++i__) { a[i__ + j * 3 - 4] = 0.f; b[i__ + j * 3 - 4] = 0.f; /* L10: */ } /* L20: */ } for (i__ = 1; i__ <= 3; ++i__) { a[i__ + i__ * 3 - 4] = 1.f; b[i__ + i__ * 3 - 4] = 1.f; /* L30: */ } infoc_1.ok = TRUE_; tola = 1.f; tolb = 1.f; ifst = 1; ilst = 1; nt = 0; /* Test error exits for the GG path. */ if (lsamen_(&c__2, c2, "GG")) { /* SGGHRD */ s_copy(srnamc_1.srnamt, "SGGHRD", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sgghrd_("/", "N", &c__0, &c__1, &c__0, a, &c__1, b, &c__1, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sgghrd_("N", "/", &c__0, &c__1, &c__0, a, &c__1, b, &c__1, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sgghrd_("N", "N", &c_n1, &c__0, &c__0, a, &c__1, b, &c__1, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; sgghrd_("N", "N", &c__0, &c__0, &c__0, a, &c__1, b, &c__1, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sgghrd_("N", "N", &c__0, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; sgghrd_("N", "N", &c__2, &c__1, &c__1, a, &c__1, b, &c__2, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 9; sgghrd_("N", "N", &c__2, &c__1, &c__1, a, &c__2, b, &c__1, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 11; sgghrd_("V", "N", &c__2, &c__1, &c__1, a, &c__2, b, &c__2, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 13; sgghrd_("N", "V", &c__2, &c__1, &c__1, a, &c__2, b, &c__2, q, &c__1, z__, &c__1, &info); chkxer_("SGGHRD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 9; /* SHGEQZ */ s_copy(srnamc_1.srnamt, "SHGEQZ", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; shgeqz_("/", "N", "N", &c__0, &c__1, &c__0, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; shgeqz_("E", "/", "N", &c__0, &c__1, &c__0, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; shgeqz_("E", "N", "/", &c__0, &c__1, &c__0, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; shgeqz_("E", "N", "N", &c_n1, &c__0, &c__0, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; shgeqz_("E", "N", "N", &c__0, &c__0, &c__0, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; shgeqz_("E", "N", "N", &c__0, &c__1, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; shgeqz_("E", "N", "N", &c__2, &c__1, &c__1, a, &c__1, b, &c__2, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; shgeqz_("E", "N", "N", &c__2, &c__1, &c__1, a, &c__2, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 15; shgeqz_("E", "V", "N", &c__2, &c__1, &c__1, a, &c__2, b, &c__2, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 17; shgeqz_("E", "N", "V", &c__2, &c__1, &c__1, a, &c__2, b, &c__2, r1, r2, r3, q, &c__1, z__, &c__1, w, &c__18, &info); chkxer_("SHGEQZ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 10; /* STGEVC */ s_copy(srnamc_1.srnamt, "STGEVC", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; stgevc_("/", "A", sel, &c__0, a, &c__1, b, &c__1, q, &c__1, z__, & c__1, &c__0, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; stgevc_("R", "/", sel, &c__0, a, &c__1, b, &c__1, q, &c__1, z__, & c__1, &c__0, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; stgevc_("R", "A", sel, &c_n1, a, &c__1, b, &c__1, q, &c__1, z__, & c__1, &c__0, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; stgevc_("R", "A", sel, &c__2, a, &c__1, b, &c__2, q, &c__1, z__, & c__2, &c__0, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; stgevc_("R", "A", sel, &c__2, a, &c__2, b, &c__1, q, &c__1, z__, & c__2, &c__0, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; stgevc_("L", "A", sel, &c__2, a, &c__2, b, &c__2, q, &c__1, z__, & c__1, &c__0, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; stgevc_("R", "A", sel, &c__2, a, &c__2, b, &c__2, q, &c__1, z__, & c__1, &c__0, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 13; stgevc_("R", "A", sel, &c__2, a, &c__2, b, &c__2, q, &c__1, z__, & c__2, &c__1, &m, w, &info); chkxer_("STGEVC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 8; /* Test error exits for the GSV path. */ } else if (lsamen_(&c__3, path, "GSV")) { /* SGGSVD */ s_copy(srnamc_1.srnamt, "SGGSVD", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggsvd_("/", "N", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggsvd_("N", "/", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggsvd_("N", "N", "/", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; sggsvd_("N", "N", "N", &c_n1, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggsvd_("N", "N", "N", &c__0, &c_n1, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; sggsvd_("N", "N", "N", &c__0, &c__0, &c_n1, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; sggsvd_("N", "N", "N", &c__2, &c__1, &c__1, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; sggsvd_("N", "N", "N", &c__1, &c__1, &c__2, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; sggsvd_("U", "N", "N", &c__2, &c__2, &c__2, &dummyk, &dummyl, a, & c__2, b, &c__2, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 18; sggsvd_("N", "V", "N", &c__1, &c__1, &c__2, &dummyk, &dummyl, a, & c__1, b, &c__2, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 20; sggsvd_("N", "N", "Q", &c__1, &c__2, &c__1, &dummyk, &dummyl, a, & c__1, b, &c__1, r1, r2, u, &c__1, v, &c__1, q, &c__1, w, iw, & info); chkxer_("SGGSVD", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 11; /* SGGSVP */ s_copy(srnamc_1.srnamt, "SGGSVP", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggsvp_("/", "N", "N", &c__0, &c__0, &c__0, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggsvp_("N", "/", "N", &c__0, &c__0, &c__0, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggsvp_("N", "N", "/", &c__0, &c__0, &c__0, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; sggsvp_("N", "N", "N", &c_n1, &c__0, &c__0, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggsvp_("N", "N", "N", &c__0, &c_n1, &c__0, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; sggsvp_("N", "N", "N", &c__0, &c__0, &c_n1, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; sggsvp_("N", "N", "N", &c__2, &c__1, &c__1, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; sggsvp_("N", "N", "N", &c__1, &c__2, &c__1, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; sggsvp_("U", "N", "N", &c__2, &c__2, &c__2, a, &c__2, b, &c__2, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 18; sggsvp_("N", "V", "N", &c__1, &c__2, &c__1, a, &c__1, b, &c__2, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 20; sggsvp_("N", "N", "Q", &c__1, &c__1, &c__2, a, &c__1, b, &c__1, &tola, &tolb, &dummyk, &dummyl, u, &c__1, v, &c__1, q, &c__1, iw, tau, w, &info); chkxer_("SGGSVP", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 11; /* STGSJA */ s_copy(srnamc_1.srnamt, "STGSJA", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; stgsja_("/", "N", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; stgsja_("N", "/", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; stgsja_("N", "N", "/", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; stgsja_("N", "N", "N", &c_n1, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; stgsja_("N", "N", "N", &c__0, &c_n1, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; stgsja_("N", "N", "N", &c__0, &c__0, &c_n1, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; stgsja_("N", "N", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__0, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; stgsja_("N", "N", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__0, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 18; stgsja_("U", "N", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__0, v, &c__1, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 20; stgsja_("N", "V", "N", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__0, q, & c__1, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 22; stgsja_("N", "N", "Q", &c__0, &c__0, &c__0, &dummyk, &dummyl, a, & c__1, b, &c__1, &tola, &tolb, r1, r2, u, &c__1, v, &c__1, q, & c__0, w, &ncycle, &info); chkxer_("STGSJA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 11; /* Test error exits for the GLM path. */ } else if (lsamen_(&c__3, path, "GLM")) { /* SGGGLM */ s_copy(srnamc_1.srnamt, "SGGGLM", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggglm_(&c_n1, &c__0, &c__0, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggglm_(&c__0, &c_n1, &c__0, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggglm_(&c__0, &c__1, &c__0, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggglm_(&c__0, &c__0, &c_n1, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggglm_(&c__1, &c__0, &c__0, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggglm_(&c__0, &c__0, &c__0, a, &c__0, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; sggglm_(&c__0, &c__0, &c__0, a, &c__1, b, &c__0, r1, r2, r3, w, & c__18, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; sggglm_(&c__1, &c__1, &c__1, a, &c__1, b, &c__1, r1, r2, r3, w, &c__1, &info); chkxer_("SGGGLM", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 8; /* Test error exits for the LSE path. */ } else if (lsamen_(&c__3, path, "LSE")) { /* SGGLSE */ s_copy(srnamc_1.srnamt, "SGGLSE", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sgglse_(&c_n1, &c__0, &c__0, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sgglse_(&c__0, &c_n1, &c__0, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sgglse_(&c__0, &c__0, &c_n1, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sgglse_(&c__0, &c__0, &c__1, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sgglse_(&c__0, &c__1, &c__0, a, &c__1, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sgglse_(&c__0, &c__0, &c__0, a, &c__0, b, &c__1, r1, r2, r3, w, & c__18, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; sgglse_(&c__0, &c__0, &c__0, a, &c__1, b, &c__0, r1, r2, r3, w, & c__18, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; sgglse_(&c__1, &c__1, &c__1, a, &c__1, b, &c__1, r1, r2, r3, w, &c__1, &info); chkxer_("SGGLSE", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 8; /* Test error exits for the GQR path. */ } else if (lsamen_(&c__3, path, "GQR")) { /* SGGQRF */ s_copy(srnamc_1.srnamt, "SGGQRF", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggqrf_(&c_n1, &c__0, &c__0, a, &c__1, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGQRF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggqrf_(&c__0, &c_n1, &c__0, a, &c__1, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGQRF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggqrf_(&c__0, &c__0, &c_n1, a, &c__1, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGQRF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggqrf_(&c__0, &c__0, &c__0, a, &c__0, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGQRF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; sggqrf_(&c__0, &c__0, &c__0, a, &c__1, r1, b, &c__0, r2, w, &c__18, & info); chkxer_("SGGQRF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 11; sggqrf_(&c__1, &c__1, &c__2, a, &c__1, r1, b, &c__1, r2, w, &c__1, & info); chkxer_("SGGQRF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 6; /* SGGRQF */ s_copy(srnamc_1.srnamt, "SGGRQF", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggrqf_(&c_n1, &c__0, &c__0, a, &c__1, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGRQF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggrqf_(&c__0, &c_n1, &c__0, a, &c__1, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGRQF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggrqf_(&c__0, &c__0, &c_n1, a, &c__1, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGRQF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggrqf_(&c__0, &c__0, &c__0, a, &c__0, r1, b, &c__1, r2, w, &c__18, & info); chkxer_("SGGRQF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; sggrqf_(&c__0, &c__0, &c__0, a, &c__1, r1, b, &c__0, r2, w, &c__18, & info); chkxer_("SGGRQF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 11; sggrqf_(&c__1, &c__1, &c__2, a, &c__1, r1, b, &c__1, r2, w, &c__1, & info); chkxer_("SGGRQF", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 6; /* Test error exits for the SGS, SGV, SGX, and SXV paths. */ } else if (lsamen_(&c__3, path, "SGS") || lsamen_(& c__3, path, "SGV") || lsamen_(&c__3, path, "SGX") || lsamen_(&c__3, path, "SXV")) { /* SGGES */ s_copy(srnamc_1.srnamt, "SGGES ", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sgges_("/", "N", "S", (L_fp)slctes_, &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sgges_("N", "/", "S", (L_fp)slctes_, &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sgges_("N", "V", "/", (L_fp)slctes_, &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sgges_("N", "V", "S", (L_fp)slctes_, &c_n1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; sgges_("N", "V", "S", (L_fp)slctes_, &c__1, a, &c__0, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 9; sgges_("N", "V", "S", (L_fp)slctes_, &c__1, a, &c__1, b, &c__0, &sdim, r1, r2, r3, q, &c__1, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 15; sgges_("N", "V", "S", (L_fp)slctes_, &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__0, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 15; sgges_("V", "V", "S", (L_fp)slctes_, &c__2, a, &c__2, b, &c__2, &sdim, r1, r2, r3, q, &c__1, u, &c__2, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 17; sgges_("N", "V", "S", (L_fp)slctes_, &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__0, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 17; sgges_("V", "V", "S", (L_fp)slctes_, &c__2, a, &c__2, b, &c__2, &sdim, r1, r2, r3, q, &c__2, u, &c__1, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 19; sgges_("V", "V", "S", (L_fp)slctes_, &c__2, a, &c__2, b, &c__2, &sdim, r1, r2, r3, q, &c__2, u, &c__2, w, &c__1, bw, &info); chkxer_("SGGES ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 11; /* SGGESX */ s_copy(srnamc_1.srnamt, "SGGESX", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggesx_("/", "N", "S", (L_fp)slctsx_, "N", &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggesx_("N", "/", "S", (L_fp)slctsx_, "N", &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggesx_("V", "V", "/", (L_fp)slctsx_, "N", &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggesx_("V", "V", "S", (L_fp)slctsx_, "/", &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c_n1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c__1, a, &c__0, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c__1, a, &c__1, b, &c__0, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__0, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c__2, a, &c__2, b, &c__2, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 18; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__0, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 18; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c__2, a, &c__2, b, &c__2, &sdim, r1, r2, r3, q, &c__2, u, &c__1, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 22; sggesx_("V", "V", "S", (L_fp)slctsx_, "B", &c__2, a, &c__2, b, &c__2, &sdim, r1, r2, r3, q, &c__2, u, &c__2, rce, rcv, w, &c__1, iw, &c__1, bw, &info) ; chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 24; sggesx_("V", "V", "S", (L_fp)slctsx_, "V", &c__1, a, &c__1, b, &c__1, &sdim, r1, r2, r3, q, &c__1, u, &c__1, rce, rcv, w, &c__32, iw, &c__0, bw, &info); chkxer_("SGGESX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 13; /* SGGEV */ s_copy(srnamc_1.srnamt, "SGGEV ", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggev_("/", "N", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggev_("N", "/", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggev_("V", "V", &c_n1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggev_("V", "V", &c__1, a, &c__0, b, &c__1, r1, r2, r3, q, &c__1, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; sggev_("V", "V", &c__1, a, &c__1, b, &c__0, r1, r2, r3, q, &c__1, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; sggev_("N", "V", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__0, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; sggev_("V", "V", &c__2, a, &c__2, b, &c__2, r1, r2, r3, q, &c__1, u, & c__2, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 14; sggev_("V", "N", &c__2, a, &c__2, b, &c__2, r1, r2, r3, q, &c__2, u, & c__0, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 14; sggev_("V", "V", &c__2, a, &c__2, b, &c__2, r1, r2, r3, q, &c__2, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; sggev_("V", "V", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, & c__1, w, &c__1, &info); chkxer_("SGGEV ", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 10; /* SGGEVX */ s_copy(srnamc_1.srnamt, "SGGEVX", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; sggevx_("/", "N", "N", "N", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; sggevx_("N", "/", "N", "N", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; sggevx_("N", "N", "/", "N", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; sggevx_("N", "N", "N", "/", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; sggevx_("N", "N", "N", "N", &c_n1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; sggevx_("N", "N", "N", "N", &c__1, a, &c__0, b, &c__1, r1, r2, r3, q, &c__1, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 9; sggevx_("N", "N", "N", "N", &c__1, a, &c__1, b, &c__0, r1, r2, r3, q, &c__1, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 14; sggevx_("N", "N", "N", "N", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__0, u, &c__1, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 14; sggevx_("N", "V", "N", "N", &c__2, a, &c__2, b, &c__2, r1, r2, r3, q, &c__1, u, &c__2, &c__1, &c__2, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; sggevx_("N", "N", "N", "N", &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, u, &c__0, &c__1, &c__1, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; sggevx_("N", "N", "V", "N", &c__2, a, &c__2, b, &c__2, r1, r2, r3, q, &c__2, u, &c__1, &c__1, &c__2, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 26; sggevx_("N", "N", "V", "N", &c__2, a, &c__2, b, &c__2, r1, r2, r3, q, &c__2, u, &c__2, &c__1, &c__2, ls, rs, &anrm, &bnrm, rce, rcv, w, &c__1, iw, bw, &info); chkxer_("SGGEVX", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 12; /* STGEXC */ s_copy(srnamc_1.srnamt, "STGEXC", (ftnlen)32, (ftnlen)6); infoc_1.infot = 3; stgexc_(&c_true, &c_true, &c_n1, a, &c__1, b, &c__1, q, &c__1, z__, & c__1, &ifst, &ilst, w, &c__1, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; stgexc_(&c_true, &c_true, &c__1, a, &c__0, b, &c__1, q, &c__1, z__, & c__1, &ifst, &ilst, w, &c__1, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; stgexc_(&c_true, &c_true, &c__1, a, &c__1, b, &c__0, q, &c__1, z__, & c__1, &ifst, &ilst, w, &c__1, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 9; stgexc_(&c_false, &c_true, &c__1, a, &c__1, b, &c__1, q, &c__0, z__, & c__1, &ifst, &ilst, w, &c__1, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 9; stgexc_(&c_true, &c_true, &c__1, a, &c__1, b, &c__1, q, &c__0, z__, & c__1, &ifst, &ilst, w, &c__1, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 11; stgexc_(&c_true, &c_false, &c__1, a, &c__1, b, &c__1, q, &c__1, z__, & c__0, &ifst, &ilst, w, &c__1, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 11; stgexc_(&c_true, &c_true, &c__1, a, &c__1, b, &c__1, q, &c__1, z__, & c__0, &ifst, &ilst, w, &c__1, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 15; stgexc_(&c_true, &c_true, &c__1, a, &c__1, b, &c__1, q, &c__1, z__, & c__1, &ifst, &ilst, w, &c__0, &info); chkxer_("STGEXC", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 8; /* STGSEN */ s_copy(srnamc_1.srnamt, "STGSEN", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; stgsen_(&c_n1, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 5; stgsen_(&c__1, &c_true, &c_true, sel, &c_n1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 7; stgsen_(&c__1, &c_true, &c_true, sel, &c__1, a, &c__0, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 9; stgsen_(&c__1, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__0, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 14; stgsen_(&c__1, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__0, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; stgsen_(&c__1, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__0, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 22; stgsen_(&c__0, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 22; stgsen_(&c__1, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 22; stgsen_(&c__2, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, &c__1, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 24; stgsen_(&c__0, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, & c__20, iw, &c__0, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 24; stgsen_(&c__1, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, & c__20, iw, &c__0, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 24; stgsen_(&c__2, &c_true, &c_true, sel, &c__1, a, &c__1, b, &c__1, r1, r2, r3, q, &c__1, z__, &c__1, &m, &tola, &tolb, rcv, w, & c__20, iw, &c__1, &info); chkxer_("STGSEN", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 12; /* STGSNA */ s_copy(srnamc_1.srnamt, "STGSNA", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; stgsna_("/", "A", sel, &c__1, a, &c__1, b, &c__1, q, &c__1, u, &c__1, r1, r2, &c__1, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; stgsna_("B", "/", sel, &c__1, a, &c__1, b, &c__1, q, &c__1, u, &c__1, r1, r2, &c__1, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; stgsna_("B", "A", sel, &c_n1, a, &c__1, b, &c__1, q, &c__1, u, &c__1, r1, r2, &c__1, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; stgsna_("B", "A", sel, &c__1, a, &c__0, b, &c__1, q, &c__1, u, &c__1, r1, r2, &c__1, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; stgsna_("B", "A", sel, &c__1, a, &c__1, b, &c__0, q, &c__1, u, &c__1, r1, r2, &c__1, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; stgsna_("E", "A", sel, &c__1, a, &c__1, b, &c__1, q, &c__0, u, &c__1, r1, r2, &c__1, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; stgsna_("E", "A", sel, &c__1, a, &c__1, b, &c__1, q, &c__1, u, &c__0, r1, r2, &c__1, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 15; stgsna_("E", "A", sel, &c__1, a, &c__1, b, &c__1, q, &c__1, u, &c__1, r1, r2, &c__0, &m, w, &c__1, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 18; stgsna_("E", "A", sel, &c__1, a, &c__1, b, &c__1, q, &c__1, u, &c__1, r1, r2, &c__1, &m, w, &c__0, iw, &info); chkxer_("STGSNA", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 9; /* STGSYL */ s_copy(srnamc_1.srnamt, "STGSYL", (ftnlen)32, (ftnlen)6); infoc_1.infot = 1; stgsyl_("/", &c__0, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 2; stgsyl_("N", &c_n1, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 3; stgsyl_("N", &c__0, &c__0, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 4; stgsyl_("N", &c__0, &c__1, &c__0, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 6; stgsyl_("N", &c__0, &c__1, &c__1, a, &c__0, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 8; stgsyl_("N", &c__0, &c__1, &c__1, a, &c__1, b, &c__0, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 10; stgsyl_("N", &c__0, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__0, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 12; stgsyl_("N", &c__0, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__0, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 14; stgsyl_("N", &c__0, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__0, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 16; stgsyl_("N", &c__0, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__0, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 20; stgsyl_("N", &c__1, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); infoc_1.infot = 20; stgsyl_("N", &c__2, &c__1, &c__1, a, &c__1, b, &c__1, q, &c__1, u, & c__1, v, &c__1, z__, &c__1, &scale, &dif, w, &c__1, iw, &info); chkxer_("STGSYL", &infoc_1.infot, &infoc_1.nout, &infoc_1.lerr, & infoc_1.ok); nt += 12; } /* Print a summary line. */ if (infoc_1.ok) { io___38.ciunit = infoc_1.nout; s_wsfe(&io___38); do_fio(&c__1, path, (ftnlen)3); do_fio(&c__1, (char *)&nt, (ftnlen)sizeof(integer)); e_wsfe(); } else { io___39.ciunit = infoc_1.nout; s_wsfe(&io___39); do_fio(&c__1, path, (ftnlen)3); e_wsfe(); } return 0; /* End of SERRGG */ } /* serrgg_ */