LAPACK 3.11.0
LAPACK: Linear Algebra PACKage
Loading...
Searching...
No Matches
Collaboration diagram for double:

Functions

subroutine ctplqt (m, n, l, mb, a, lda, b, ldb, t, ldt, work, info)
 CTPLQT
 
subroutine ctplqt2 (m, n, l, a, lda, b, ldb, t, ldt, info)
 CTPLQT2
 
subroutine ctpmlqt (side, trans, m, n, k, l, mb, v, ldv, t, ldt, a, lda, b, ldb, work, info)
 CTPMLQT
 
subroutine dbbcsd (jobu1, jobu2, jobv1t, jobv2t, trans, m, p, q, theta, phi, u1, ldu1, u2, ldu2, v1t, ldv1t, v2t, ldv2t, b11d, b11e, b12d, b12e, b21d, b21e, b22d, b22e, work, lwork, info)
 DBBCSD
 
subroutine dggsvp (jobu, jobv, jobq, m, p, n, a, lda, b, ldb, tola, tolb, k, l, u, ldu, v, ldv, q, ldq, iwork, tau, work, info)
 DGGSVP
 
subroutine dlatzm (side, m, n, v, incv, tau, c1, c2, ldc, work)
 DLATZM
 
subroutine dtzrqf (m, n, a, lda, tau, info)
 DTZRQF
 
subroutine dgetsqrhrt (m, n, mb1, nb1, nb2, a, lda, t, ldt, work, lwork, info)
 DGETSQRHRT
 
subroutine dgghd3 (compq, compz, n, ilo, ihi, a, lda, b, ldb, q, ldq, z, ldz, work, lwork, info)
 DGGHD3
 
subroutine dgghrd (compq, compz, n, ilo, ihi, a, lda, b, ldb, q, ldq, z, ldz, info)
 DGGHRD
 
subroutine dggqrf (n, m, p, a, lda, taua, b, ldb, taub, work, lwork, info)
 DGGQRF
 
subroutine dggrqf (m, p, n, a, lda, taua, b, ldb, taub, work, lwork, info)
 DGGRQF
 
subroutine dggsvp3 (jobu, jobv, jobq, m, p, n, a, lda, b, ldb, tola, tolb, k, l, u, ldu, v, ldv, q, ldq, iwork, tau, work, lwork, info)
 DGGSVP3
 
subroutine dgsvj0 (jobv, m, n, a, lda, d, sva, mv, v, ldv, eps, sfmin, tol, nsweep, work, lwork, info)
 DGSVJ0 pre-processor for the routine dgesvj.
 
subroutine dgsvj1 (jobv, m, n, n1, a, lda, d, sva, mv, v, ldv, eps, sfmin, tol, nsweep, work, lwork, info)
 DGSVJ1 pre-processor for the routine dgesvj, applies Jacobi rotations targeting only particular pivots.
 
subroutine dhsein (side, eigsrc, initv, select, n, h, ldh, wr, wi, vl, ldvl, vr, ldvr, mm, m, work, ifaill, ifailr, info)
 DHSEIN
 
subroutine dhseqr (job, compz, n, ilo, ihi, h, ldh, wr, wi, z, ldz, work, lwork, info)
 DHSEQR
 
subroutine dla_lin_berr (n, nz, nrhs, res, ayb, berr)
 DLA_LIN_BERR computes a component-wise relative backward error.
 
subroutine dla_wwaddw (n, x, y, w)
 DLA_WWADDW adds a vector into a doubled-single vector.
 
subroutine dlals0 (icompq, nl, nr, sqre, nrhs, b, ldb, bx, ldbx, perm, givptr, givcol, ldgcol, givnum, ldgnum, poles, difl, difr, z, k, c, s, work, info)
 DLALS0 applies back multiplying factors in solving the least squares problem using divide and conquer SVD approach. Used by sgelsd.
 
subroutine dlalsa (icompq, smlsiz, n, nrhs, b, ldb, bx, ldbx, u, ldu, vt, k, difl, difr, z, poles, givptr, givcol, ldgcol, perm, givnum, c, s, work, iwork, info)
 DLALSA computes the SVD of the coefficient matrix in compact form. Used by sgelsd.
 
subroutine dlalsd (uplo, smlsiz, n, nrhs, d, e, b, ldb, rcond, rank, work, iwork, info)
 DLALSD uses the singular value decomposition of A to solve the least squares problem.
 
double precision function dlansf (norm, transr, uplo, n, a, work)
 DLANSF returns the value of the 1-norm, or the Frobenius norm, or the infinity norm, or the element of largest absolute value of a symmetric matrix in RFP format.
 
subroutine dlarscl2 (m, n, d, x, ldx)
 DLARSCL2 performs reciprocal diagonal scaling on a matrix.
 
subroutine dlarz (side, m, n, l, v, incv, tau, c, ldc, work)
 DLARZ applies an elementary reflector (as returned by stzrzf) to a general matrix.
 
subroutine dlarzb (side, trans, direct, storev, m, n, k, l, v, ldv, t, ldt, c, ldc, work, ldwork)
 DLARZB applies a block reflector or its transpose to a general matrix.
 
subroutine dlarzt (direct, storev, n, k, v, ldv, tau, t, ldt)
 DLARZT forms the triangular factor T of a block reflector H = I - vtvH.
 
subroutine dlascl2 (m, n, d, x, ldx)
 DLASCL2 performs diagonal scaling on a matrix.
 
subroutine dlatrz (m, n, l, a, lda, tau, work)
 DLATRZ factors an upper trapezoidal matrix by means of orthogonal transformations.
 
subroutine dopgtr (uplo, n, ap, tau, q, ldq, work, info)
 DOPGTR
 
subroutine dopmtr (side, uplo, trans, m, n, ap, tau, c, ldc, work, info)
 DOPMTR
 
subroutine dorbdb (trans, signs, m, p, q, x11, ldx11, x12, ldx12, x21, ldx21, x22, ldx22, theta, phi, taup1, taup2, tauq1, tauq2, work, lwork, info)
 DORBDB
 
subroutine dorbdb1 (m, p, q, x11, ldx11, x21, ldx21, theta, phi, taup1, taup2, tauq1, work, lwork, info)
 DORBDB1
 
subroutine dorbdb2 (m, p, q, x11, ldx11, x21, ldx21, theta, phi, taup1, taup2, tauq1, work, lwork, info)
 DORBDB2
 
subroutine dorbdb3 (m, p, q, x11, ldx11, x21, ldx21, theta, phi, taup1, taup2, tauq1, work, lwork, info)
 DORBDB3
 
subroutine dorbdb4 (m, p, q, x11, ldx11, x21, ldx21, theta, phi, taup1, taup2, tauq1, phantom, work, lwork, info)
 DORBDB4
 
subroutine dorbdb5 (m1, m2, n, x1, incx1, x2, incx2, q1, ldq1, q2, ldq2, work, lwork, info)
 DORBDB5
 
subroutine dorbdb6 (m1, m2, n, x1, incx1, x2, incx2, q1, ldq1, q2, ldq2, work, lwork, info)
 DORBDB6
 
recursive subroutine dorcsd (jobu1, jobu2, jobv1t, jobv2t, trans, signs, m, p, q, x11, ldx11, x12, ldx12, x21, ldx21, x22, ldx22, theta, u1, ldu1, u2, ldu2, v1t, ldv1t, v2t, ldv2t, work, lwork, iwork, info)
 DORCSD
 
subroutine dorcsd2by1 (jobu1, jobu2, jobv1t, m, p, q, x11, ldx11, x21, ldx21, theta, u1, ldu1, u2, ldu2, v1t, ldv1t, work, lwork, iwork, info)
 DORCSD2BY1
 
subroutine dorg2l (m, n, k, a, lda, tau, work, info)
 DORG2L generates all or part of the orthogonal matrix Q from a QL factorization determined by sgeqlf (unblocked algorithm).
 
subroutine dorg2r (m, n, k, a, lda, tau, work, info)
 DORG2R generates all or part of the orthogonal matrix Q from a QR factorization determined by sgeqrf (unblocked algorithm).
 
subroutine dorghr (n, ilo, ihi, a, lda, tau, work, lwork, info)
 DORGHR
 
subroutine dorgl2 (m, n, k, a, lda, tau, work, info)
 DORGL2
 
subroutine dorglq (m, n, k, a, lda, tau, work, lwork, info)
 DORGLQ
 
subroutine dorgql (m, n, k, a, lda, tau, work, lwork, info)
 DORGQL
 
subroutine dorgqr (m, n, k, a, lda, tau, work, lwork, info)
 DORGQR
 
subroutine dorgr2 (m, n, k, a, lda, tau, work, info)
 DORGR2 generates all or part of the orthogonal matrix Q from an RQ factorization determined by sgerqf (unblocked algorithm).
 
subroutine dorgrq (m, n, k, a, lda, tau, work, lwork, info)
 DORGRQ
 
subroutine dorgtr (uplo, n, a, lda, tau, work, lwork, info)
 DORGTR
 
subroutine dorgtsqr (m, n, mb, nb, a, lda, t, ldt, work, lwork, info)
 DORGTSQR
 
subroutine dorgtsqr_row (m, n, mb, nb, a, lda, t, ldt, work, lwork, info)
 DORGTSQR_ROW
 
subroutine dorhr_col (m, n, nb, a, lda, t, ldt, d, info)
 DORHR_COL
 
subroutine dorm2l (side, trans, m, n, k, a, lda, tau, c, ldc, work, info)
 DORM2L multiplies a general matrix by the orthogonal matrix from a QL factorization determined by sgeqlf (unblocked algorithm).
 
subroutine dorm2r (side, trans, m, n, k, a, lda, tau, c, ldc, work, info)
 DORM2R multiplies a general matrix by the orthogonal matrix from a QR factorization determined by sgeqrf (unblocked algorithm).
 
subroutine dormbr (vect, side, trans, m, n, k, a, lda, tau, c, ldc, work, lwork, info)
 DORMBR
 
subroutine dormhr (side, trans, m, n, ilo, ihi, a, lda, tau, c, ldc, work, lwork, info)
 DORMHR
 
subroutine dorml2 (side, trans, m, n, k, a, lda, tau, c, ldc, work, info)
 DORML2 multiplies a general matrix by the orthogonal matrix from a LQ factorization determined by sgelqf (unblocked algorithm).
 
subroutine dormlq (side, trans, m, n, k, a, lda, tau, c, ldc, work, lwork, info)
 DORMLQ
 
subroutine dormql (side, trans, m, n, k, a, lda, tau, c, ldc, work, lwork, info)
 DORMQL
 
subroutine dormqr (side, trans, m, n, k, a, lda, tau, c, ldc, work, lwork, info)
 DORMQR
 
subroutine dormr2 (side, trans, m, n, k, a, lda, tau, c, ldc, work, info)
 DORMR2 multiplies a general matrix by the orthogonal matrix from a RQ factorization determined by sgerqf (unblocked algorithm).
 
subroutine dormr3 (side, trans, m, n, k, l, a, lda, tau, c, ldc, work, info)
 DORMR3 multiplies a general matrix by the orthogonal matrix from a RZ factorization determined by stzrzf (unblocked algorithm).
 
subroutine dormrq (side, trans, m, n, k, a, lda, tau, c, ldc, work, lwork, info)
 DORMRQ
 
subroutine dormrz (side, trans, m, n, k, l, a, lda, tau, c, ldc, work, lwork, info)
 DORMRZ
 
subroutine dormtr (side, uplo, trans, m, n, a, lda, tau, c, ldc, work, lwork, info)
 DORMTR
 
subroutine dpbcon (uplo, n, kd, ab, ldab, anorm, rcond, work, iwork, info)
 DPBCON
 
subroutine dpbequ (uplo, n, kd, ab, ldab, s, scond, amax, info)
 DPBEQU
 
subroutine dpbrfs (uplo, n, kd, nrhs, ab, ldab, afb, ldafb, b, ldb, x, ldx, ferr, berr, work, iwork, info)
 DPBRFS
 
subroutine dpbstf (uplo, n, kd, ab, ldab, info)
 DPBSTF
 
subroutine dpbtf2 (uplo, n, kd, ab, ldab, info)
 DPBTF2 computes the Cholesky factorization of a symmetric/Hermitian positive definite band matrix (unblocked algorithm).
 
subroutine dpbtrf (uplo, n, kd, ab, ldab, info)
 DPBTRF
 
subroutine dpbtrs (uplo, n, kd, nrhs, ab, ldab, b, ldb, info)
 DPBTRS
 
subroutine dpftrf (transr, uplo, n, a, info)
 DPFTRF
 
subroutine dpftri (transr, uplo, n, a, info)
 DPFTRI
 
subroutine dpftrs (transr, uplo, n, nrhs, a, b, ldb, info)
 DPFTRS
 
subroutine dppcon (uplo, n, ap, anorm, rcond, work, iwork, info)
 DPPCON
 
subroutine dppequ (uplo, n, ap, s, scond, amax, info)
 DPPEQU
 
subroutine dpprfs (uplo, n, nrhs, ap, afp, b, ldb, x, ldx, ferr, berr, work, iwork, info)
 DPPRFS
 
subroutine dpptrf (uplo, n, ap, info)
 DPPTRF
 
subroutine dpptri (uplo, n, ap, info)
 DPPTRI
 
subroutine dpptrs (uplo, n, nrhs, ap, b, ldb, info)
 DPPTRS
 
subroutine dpstf2 (uplo, n, a, lda, piv, rank, tol, work, info)
 DPSTF2 computes the Cholesky factorization with complete pivoting of a real symmetric positive semidefinite matrix.
 
subroutine dpstrf (uplo, n, a, lda, piv, rank, tol, work, info)
 DPSTRF computes the Cholesky factorization with complete pivoting of a real symmetric positive semidefinite matrix.
 
subroutine dsbgst (vect, uplo, n, ka, kb, ab, ldab, bb, ldbb, x, ldx, work, info)
 DSBGST
 
subroutine dsbtrd (vect, uplo, n, kd, ab, ldab, d, e, q, ldq, work, info)
 DSBTRD
 
subroutine dsfrk (transr, uplo, trans, n, k, alpha, a, lda, beta, c)
 DSFRK performs a symmetric rank-k operation for matrix in RFP format.
 
subroutine dspcon (uplo, n, ap, ipiv, anorm, rcond, work, iwork, info)
 DSPCON
 
subroutine dspgst (itype, uplo, n, ap, bp, info)
 DSPGST
 
subroutine dsprfs (uplo, n, nrhs, ap, afp, ipiv, b, ldb, x, ldx, ferr, berr, work, iwork, info)
 DSPRFS
 
subroutine dsptrd (uplo, n, ap, d, e, tau, info)
 DSPTRD
 
subroutine dsptrf (uplo, n, ap, ipiv, info)
 DSPTRF
 
subroutine dsptri (uplo, n, ap, ipiv, work, info)
 DSPTRI
 
subroutine dsptrs (uplo, n, nrhs, ap, ipiv, b, ldb, info)
 DSPTRS
 
subroutine dstegr (jobz, range, n, d, e, vl, vu, il, iu, abstol, m, w, z, ldz, isuppz, work, lwork, iwork, liwork, info)
 DSTEGR
 
subroutine dstein (n, d, e, m, w, iblock, isplit, z, ldz, work, iwork, ifail, info)
 DSTEIN
 
subroutine dstemr (jobz, range, n, d, e, vl, vu, il, iu, m, w, z, ldz, nzc, isuppz, tryrac, work, lwork, iwork, liwork, info)
 DSTEMR
 
subroutine dtbcon (norm, uplo, diag, n, kd, ab, ldab, rcond, work, iwork, info)
 DTBCON
 
subroutine dtbrfs (uplo, trans, diag, n, kd, nrhs, ab, ldab, b, ldb, x, ldx, ferr, berr, work, iwork, info)
 DTBRFS
 
subroutine dtbtrs (uplo, trans, diag, n, kd, nrhs, ab, ldab, b, ldb, info)
 DTBTRS
 
subroutine dtfsm (transr, side, uplo, trans, diag, m, n, alpha, a, b, ldb)
 DTFSM solves a matrix equation (one operand is a triangular matrix in RFP format).
 
subroutine dtftri (transr, uplo, diag, n, a, info)
 DTFTRI
 
subroutine dtfttp (transr, uplo, n, arf, ap, info)
 DTFTTP copies a triangular matrix from the rectangular full packed format (TF) to the standard packed format (TP).
 
subroutine dtfttr (transr, uplo, n, arf, a, lda, info)
 DTFTTR copies a triangular matrix from the rectangular full packed format (TF) to the standard full format (TR).
 
subroutine dtgsen (ijob, wantq, wantz, select, n, a, lda, b, ldb, alphar, alphai, beta, q, ldq, z, ldz, m, pl, pr, dif, work, lwork, iwork, liwork, info)
 DTGSEN
 
subroutine dtgsja (jobu, jobv, jobq, m, p, n, k, l, a, lda, b, ldb, tola, tolb, alpha, beta, u, ldu, v, ldv, q, ldq, work, ncycle, info)
 DTGSJA
 
subroutine dtgsna (job, howmny, select, n, a, lda, b, ldb, vl, ldvl, vr, ldvr, s, dif, mm, m, work, lwork, iwork, info)
 DTGSNA
 
subroutine dtpcon (norm, uplo, diag, n, ap, rcond, work, iwork, info)
 DTPCON
 
subroutine dtplqt (m, n, l, mb, a, lda, b, ldb, t, ldt, work, info)
 DTPLQT
 
subroutine dtplqt2 (m, n, l, a, lda, b, ldb, t, ldt, info)
 DTPLQT2 computes a LQ factorization of a real or complex "triangular-pentagonal" matrix, which is composed of a triangular block and a pentagonal block, using the compact WY representation for Q.
 
subroutine dtpmlqt (side, trans, m, n, k, l, mb, v, ldv, t, ldt, a, lda, b, ldb, work, info)
 DTPMLQT
 
subroutine dtpmqrt (side, trans, m, n, k, l, nb, v, ldv, t, ldt, a, lda, b, ldb, work, info)
 DTPMQRT
 
subroutine dtpqrt (m, n, l, nb, a, lda, b, ldb, t, ldt, work, info)
 DTPQRT
 
subroutine dtpqrt2 (m, n, l, a, lda, b, ldb, t, ldt, info)
 DTPQRT2 computes a QR factorization of a real or complex "triangular-pentagonal" matrix, which is composed of a triangular block and a pentagonal block, using the compact WY representation for Q.
 
subroutine dtprfs (uplo, trans, diag, n, nrhs, ap, b, ldb, x, ldx, ferr, berr, work, iwork, info)
 DTPRFS
 
subroutine dtptri (uplo, diag, n, ap, info)
 DTPTRI
 
subroutine dtptrs (uplo, trans, diag, n, nrhs, ap, b, ldb, info)
 DTPTRS
 
subroutine dtpttf (transr, uplo, n, ap, arf, info)
 DTPTTF copies a triangular matrix from the standard packed format (TP) to the rectangular full packed format (TF).
 
subroutine dtpttr (uplo, n, ap, a, lda, info)
 DTPTTR copies a triangular matrix from the standard packed format (TP) to the standard full format (TR).
 
subroutine dtrcon (norm, uplo, diag, n, a, lda, rcond, work, iwork, info)
 DTRCON
 
subroutine dtrevc (side, howmny, select, n, t, ldt, vl, ldvl, vr, ldvr, mm, m, work, info)
 DTREVC
 
subroutine dtrevc3 (side, howmny, select, n, t, ldt, vl, ldvl, vr, ldvr, mm, m, work, lwork, info)
 DTREVC3
 
subroutine dtrexc (compq, n, t, ldt, q, ldq, ifst, ilst, work, info)
 DTREXC
 
subroutine dtrrfs (uplo, trans, diag, n, nrhs, a, lda, b, ldb, x, ldx, ferr, berr, work, iwork, info)
 DTRRFS
 
subroutine dtrsen (job, compq, select, n, t, ldt, q, ldq, wr, wi, m, s, sep, work, lwork, iwork, liwork, info)
 DTRSEN
 
subroutine dtrsna (job, howmny, select, n, t, ldt, vl, ldvl, vr, ldvr, s, sep, mm, m, work, ldwork, iwork, info)
 DTRSNA
 
subroutine dtrti2 (uplo, diag, n, a, lda, info)
 DTRTI2 computes the inverse of a triangular matrix (unblocked algorithm).
 
subroutine dtrtri (uplo, diag, n, a, lda, info)
 DTRTRI
 
subroutine dtrtrs (uplo, trans, diag, n, nrhs, a, lda, b, ldb, info)
 DTRTRS
 
subroutine dtrttf (transr, uplo, n, a, lda, arf, info)
 DTRTTF copies a triangular matrix from the standard full format (TR) to the rectangular full packed format (TF).
 
subroutine dtrttp (uplo, n, a, lda, ap, info)
 DTRTTP copies a triangular matrix from the standard full format (TR) to the standard packed format (TP).
 
subroutine dtzrzf (m, n, a, lda, tau, work, lwork, info)
 DTZRZF
 
subroutine stplqt (m, n, l, mb, a, lda, b, ldb, t, ldt, work, info)
 STPLQT
 
subroutine stplqt2 (m, n, l, a, lda, b, ldb, t, ldt, info)
 STPLQT2 computes a LQ factorization of a real or complex "triangular-pentagonal" matrix, which is composed of a triangular block and a pentagonal block, using the compact WY representation for Q.
 
subroutine stpmlqt (side, trans, m, n, k, l, mb, v, ldv, t, ldt, a, lda, b, ldb, work, info)
 STPMLQT
 
subroutine ztplqt (m, n, l, mb, a, lda, b, ldb, t, ldt, work, info)
 ZTPLQT
 
subroutine ztplqt2 (m, n, l, a, lda, b, ldb, t, ldt, info)
 ZTPLQT2 computes a LQ factorization of a real or complex "triangular-pentagonal" matrix, which is composed of a triangular block and a pentagonal block, using the compact WY representation for Q.
 
subroutine ztpmlqt (side, trans, m, n, k, l, mb, v, ldv, t, ldt, a, lda, b, ldb, work, info)
 ZTPMLQT
 

Detailed Description

This is the group of double other Computational routines