Skip to content

Commit

Permalink
comments fixed: subroutine name
Browse files Browse the repository at this point in the history
  • Loading branch information
jip authored and weslleyspereira committed Apr 6, 2021
1 parent 33d68e7 commit 56d3c3f
Show file tree
Hide file tree
Showing 90 changed files with 184 additions and 184 deletions.
6 changes: 3 additions & 3 deletions SRC/cgbrfsx.f
Original file line number Diff line number Diff line change
Expand Up @@ -138,7 +138,7 @@
*> \verbatim
*> AFB is COMPLEX array, dimension (LDAFB,N)
*> Details of the LU factorization of the band matrix A, as
*> computed by DGBTRF. U is stored as an upper triangular band
*> computed by CGBTRF. U is stored as an upper triangular band
*> matrix with KL+KU superdiagonals in rows 1 to KL+KU+1, and
*> the multipliers used during the factorization are stored in
*> rows KL+KU+2 to 2*KL+KU+1.
Expand All @@ -153,7 +153,7 @@
*> \param[in] IPIV
*> \verbatim
*> IPIV is INTEGER array, dimension (N)
*> The pivot indices from SGETRF; for 1<=i<=N, row i of the
*> The pivot indices from CGETRF; for 1<=i<=N, row i of the
*> matrix was interchanged with row IPIV(i).
*> \endverbatim
*>
Expand Down Expand Up @@ -208,7 +208,7 @@
*> \param[in,out] X
*> \verbatim
*> X is COMPLEX array, dimension (LDX,NRHS)
*> On entry, the solution matrix X, as computed by SGETRS.
*> On entry, the solution matrix X, as computed by CGETRS.
*> On exit, the improved solution matrix X.
*> \endverbatim
*>
Expand Down
8 changes: 4 additions & 4 deletions SRC/cgbsvxx.f
Original file line number Diff line number Diff line change
Expand Up @@ -230,7 +230,7 @@
*> IPIV is INTEGER array, dimension (N)
*> If FACT = 'F', then IPIV is an input argument and on entry
*> contains the pivot indices from the factorization A = P*L*U
*> as computed by SGETRF; row i of the matrix was interchanged
*> as computed by CGETRF; row i of the matrix was interchanged
*> with row IPIV(i).
*>
*> If FACT = 'N', then IPIV is an output argument and on exit
Expand Down Expand Up @@ -349,8 +349,8 @@
*> This also means that the solution X, estimated condition numbers,
*> and error bounds could be unreliable. If factorization fails with
*> 0<INFO<=N, then this contains the reciprocal pivot growth factor
*> for the leading INFO columns of A. In SGESVX, this quantity is
*> returned in WORK(1).
*> for the leading INFO columns of A. In CGESVX, this quantity is
*> returned in RWORK(1).
*> \endverbatim
*>
*> \param[out] BERR
Expand Down Expand Up @@ -635,7 +635,7 @@ SUBROUTINE CGBSVXX( FACT, TRANS, N, KL, KU, NRHS, AB, LDAB, AFB,
*
RPVGRW = ZERO
*
* Test the input parameters. PARAMS is not tested until SGERFSX.
* Test the input parameters. PARAMS is not tested until CGERFSX.
*
IF( .NOT.NOFACT .AND. .NOT.EQUIL .AND. .NOT.
$ LSAME( FACT, 'F' ) ) THEN
Expand Down
4 changes: 2 additions & 2 deletions SRC/cgehrd.f
Original file line number Diff line number Diff line change
Expand Up @@ -157,9 +157,9 @@
*> modified element of the upper Hessenberg matrix H, and vi denotes an
*> element of the vector defining H(i).
*>
*> This file is a slight modification of LAPACK-3.0's DGEHRD
*> This file is a slight modification of LAPACK-3.0's CGEHRD
*> subroutine incorporating improvements proposed by Quintana-Orti and
*> Van de Geijn (2006). (See DLAHR2.)
*> Van de Geijn (2006). (See CLAHR2.)
*> \endverbatim
*>
* =====================================================================
Expand Down
2 changes: 1 addition & 1 deletion SRC/cgejsv.f
Original file line number Diff line number Diff line change
Expand Up @@ -359,7 +359,7 @@
*> RWORK(3) = SCONDA is an estimate for the condition number of
*> column equilibrated A. (If JOBA = 'E' or 'G')
*> SCONDA is an estimate of SQRT(||(R^* * R)^(-1)||_1).
*> It is computed using SPOCON. It holds
*> It is computed using CPOCON. It holds
*> N^(-1/4) * SCONDA <= ||R^(-1)||_2 <= N^(1/4) * SCONDA
*> where R is the triangular factor from the QRF of A.
*> However, if R is truncated and the numerical rank is
Expand Down
6 changes: 3 additions & 3 deletions SRC/cgemlqt.f
Original file line number Diff line number Diff line change
Expand Up @@ -79,7 +79,7 @@
*> MB is INTEGER
*> The block size used for the storage of T. K >= MB >= 1.
*> This must be the same value of MB used to generate T
*> in DGELQT.
*> in CGELQT.
*> \endverbatim
*>
*> \param[in] V
Expand All @@ -89,7 +89,7 @@
*> (LDV,N) if SIDE = 'R'
*> The i-th row must contain the vector which defines the
*> elementary reflector H(i), for i = 1,2,...,k, as returned by
*> DGELQT in the first K rows of its array argument A.
*> CGELQT in the first K rows of its array argument A.
*> \endverbatim
*>
*> \param[in] LDV
Expand All @@ -102,7 +102,7 @@
*> \verbatim
*> T is COMPLEX array, dimension (LDT,K)
*> The upper triangular factors of the block reflectors
*> as returned by DGELQT, stored as a MB-by-K matrix.
*> as returned by CGELQT, stored as a MB-by-K matrix.
*> \endverbatim
*>
*> \param[in] LDT
Expand Down
4 changes: 2 additions & 2 deletions SRC/cggev.f
Original file line number Diff line number Diff line change
Expand Up @@ -197,8 +197,8 @@
*> The QZ iteration failed. No eigenvectors have been
*> calculated, but ALPHA(j) and BETA(j) should be
*> correct for j=INFO+1,...,N.
*> > N: =N+1: other then QZ iteration failed in SHGEQZ,
*> =N+2: error return from STGEVC.
*> > N: =N+1: other then QZ iteration failed in CHGEQZ,
*> =N+2: error return from CTGEVC.
*> \endverbatim
*
* Authors:
Expand Down
4 changes: 2 additions & 2 deletions SRC/cggev3.f
Original file line number Diff line number Diff line change
Expand Up @@ -196,8 +196,8 @@
*> The QZ iteration failed. No eigenvectors have been
*> calculated, but ALPHA(j) and BETA(j) should be
*> correct for j=INFO+1,...,N.
*> > N: =N+1: other then QZ iteration failed in SHGEQZ,
*> =N+2: error return from STGEVC.
*> > N: =N+1: other then QZ iteration failed in CHGEQZ,
*> =N+2: error return from CTGEVC.
*> \endverbatim
*
* Authors:
Expand Down
4 changes: 2 additions & 2 deletions SRC/cggevx.f
Original file line number Diff line number Diff line change
Expand Up @@ -707,8 +707,8 @@ SUBROUTINE CGGEVX( BALANC, JOBVL, JOBVR, SENSE, N, A, LDA, B, LDB,
*
IF( .NOT.WANTSN ) THEN
*
* compute eigenvectors (STGEVC) and estimate condition
* numbers (STGSNA). Note that the definition of the condition
* compute eigenvectors (CTGEVC) and estimate condition
* numbers (CTGSNA). Note that the definition of the condition
* number is not invariant under transformation (u,v) to
* (Q*u, Z*v), where (u,v) are eigenvectors of the generalized
* Schur form (S,T), Q and Z are orthogonal matrices. In order
Expand Down
2 changes: 1 addition & 1 deletion SRC/cheevr.f
Original file line number Diff line number Diff line change
Expand Up @@ -75,7 +75,7 @@
*> The desired accuracy of the output can be specified by the input
*> parameter ABSTOL.
*>
*> For more details, see DSTEMR's documentation and:
*> For more details, see CSTEMR's documentation and:
*> - Inderjit S. Dhillon and Beresford N. Parlett: "Multiple representations
*> to compute orthogonal eigenvectors of symmetric tridiagonal matrices,"
*> Linear Algebra and its Applications, 387(1), pp. 1-28, August 2004.
Expand Down
2 changes: 1 addition & 1 deletion SRC/cheevr_2stage.f
Original file line number Diff line number Diff line change
Expand Up @@ -81,7 +81,7 @@
*> The desired accuracy of the output can be specified by the input
*> parameter ABSTOL.
*>
*> For more details, see DSTEMR's documentation and:
*> For more details, see CSTEMR's documentation and:
*> - Inderjit S. Dhillon and Beresford N. Parlett: "Multiple representations
*> to compute orthogonal eigenvectors of symmetric tridiagonal matrices,"
*> Linear Algebra and its Applications, 387(1), pp. 1-28, August 2004.
Expand Down
6 changes: 3 additions & 3 deletions SRC/cherfsx.f
Original file line number Diff line number Diff line change
Expand Up @@ -123,7 +123,7 @@
*> The factored form of the matrix A. AF contains the block
*> diagonal matrix D and the multipliers used to obtain the
*> factor U or L from the factorization A = U*D*U**T or A =
*> L*D*L**T as computed by SSYTRF.
*> L*D*L**T as computed by CHETRF.
*> \endverbatim
*>
*> \param[in] LDAF
Expand All @@ -136,7 +136,7 @@
*> \verbatim
*> IPIV is INTEGER array, dimension (N)
*> Details of the interchanges and the block structure of D
*> as determined by SSYTRF.
*> as determined by CHETRF.
*> \endverbatim
*>
*> \param[in,out] S
Expand Down Expand Up @@ -170,7 +170,7 @@
*> \param[in,out] X
*> \verbatim
*> X is COMPLEX array, dimension (LDX,NRHS)
*> On entry, the solution matrix X, as computed by SGETRS.
*> On entry, the solution matrix X, as computed by CHETRS.
*> On exit, the improved solution matrix X.
*> \endverbatim
*>
Expand Down
2 changes: 1 addition & 1 deletion SRC/chesvxx.f
Original file line number Diff line number Diff line change
Expand Up @@ -185,7 +185,7 @@
*> If FACT = 'F', then AF is an input argument and on entry
*> contains the block diagonal matrix D and the multipliers
*> used to obtain the factor U or L from the factorization A =
*> U*D*U**T or A = L*D*L**T as computed by SSYTRF.
*> U*D*U**T or A = L*D*L**T as computed by CHETRF.
*>
*> If FACT = 'N', then AF is an output argument and on exit
*> returns the block diagonal matrix D and the multipliers
Expand Down
10 changes: 5 additions & 5 deletions SRC/chetrd_hb2st.f
Original file line number Diff line number Diff line change
@@ -1,17 +1,17 @@
*> \brief \b CHBTRD_HB2ST reduces a complex Hermitian band matrix A to real symmetric tridiagonal form T
*> \brief \b CHETRD_HB2ST reduces a complex Hermitian band matrix A to real symmetric tridiagonal form T
*
* =========== DOCUMENTATION ===========
*
* Online html documentation available at
* http://www.netlib.org/lapack/explore-html/
*
*> \htmlonly
*> Download CHBTRD_HB2ST + dependencies
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/chbtrd_hb2st.f">
*> Download CHETRD_HB2ST + dependencies
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/chetrd_hb2st.f">
*> [TGZ]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/chbtrd_hb2st.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/chetrd_hb2st.f">
*> [ZIP]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/chbtrd_hb2st.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/chetrd_hb2st.f">
*> [TXT]</a>
*> \endhtmlonly
*
Expand Down
6 changes: 3 additions & 3 deletions SRC/chetrd_he2hb.f
Original file line number Diff line number Diff line change
Expand Up @@ -9,11 +9,11 @@
*
*> \htmlonly
*> Download CHETRD_HE2HB + dependencies
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/chetrd.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/chetrd_he2hb.f">
*> [TGZ]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/chetrd.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/chetrd_he2hb.f">
*> [ZIP]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/chetrd.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/chetrd_he2hb.f">
*> [TXT]</a>
*> \endhtmlonly
*
Expand Down
2 changes: 1 addition & 1 deletion SRC/claed0.f
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
*> \brief \b CLAED0 used by sstedc. Computes all eigenvalues and corresponding eigenvectors of an unreduced symmetric tridiagonal matrix using the divide and conquer method.
*> \brief \b CLAED0 used by CSTEDC. Computes all eigenvalues and corresponding eigenvectors of an unreduced symmetric tridiagonal matrix using the divide and conquer method.
*
* =========== DOCUMENTATION ===========
*
Expand Down
2 changes: 1 addition & 1 deletion SRC/claed7.f
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
*> \brief \b CLAED7 used by sstedc. Computes the updated eigensystem of a diagonal matrix after modification by a rank-one symmetric matrix. Used when the original matrix is dense.
*> \brief \b CLAED7 used by CSTEDC. Computes the updated eigensystem of a diagonal matrix after modification by a rank-one symmetric matrix. Used when the original matrix is dense.
*
* =========== DOCUMENTATION ===========
*
Expand Down
2 changes: 1 addition & 1 deletion SRC/claed8.f
Original file line number Diff line number Diff line change
@@ -1,4 +1,4 @@
*> \brief \b CLAED8 used by sstedc. Merges eigenvalues and deflates secular equation. Used when the original matrix is dense.
*> \brief \b CLAED8 used by CSTEDC. Merges eigenvalues and deflates secular equation. Used when the original matrix is dense.
*
* =========== DOCUMENTATION ===========
*
Expand Down
6 changes: 3 additions & 3 deletions SRC/clahr2.f
Original file line number Diff line number Diff line change
Expand Up @@ -162,11 +162,11 @@
*> modified element of the upper Hessenberg matrix H, and vi denotes an
*> element of the vector defining H(i).
*>
*> This subroutine is a slight modification of LAPACK-3.0's DLAHRD
*> This subroutine is a slight modification of LAPACK-3.0's CLAHRD
*> incorporating improvements proposed by Quintana-Orti and Van de
*> Gejin. Note that the entries of A(1:K,2:NB) differ from those
*> returned by the original LAPACK-3.0's DLAHRD routine. (This
*> subroutine is not backward compatible with LAPACK-3.0's DLAHRD.)
*> returned by the original LAPACK-3.0's CLAHRD routine. (This
*> subroutine is not backward compatible with LAPACK-3.0's CLAHRD.)
*> \endverbatim
*
*> \par References:
Expand Down
2 changes: 1 addition & 1 deletion SRC/cporfsx.f
Original file line number Diff line number Diff line change
Expand Up @@ -122,7 +122,7 @@
*> \verbatim
*> AF is COMPLEX array, dimension (LDAF,N)
*> The triangular factor U or L from the Cholesky factorization
*> A = U**T*U or A = L*L**T, as computed by SPOTRF.
*> A = U**T*U or A = L*L**T, as computed by CPOTRF.
*> \endverbatim
*>
*> \param[in] LDAF
Expand Down
6 changes: 3 additions & 3 deletions SRC/csyrfsx.f
Original file line number Diff line number Diff line change
Expand Up @@ -124,7 +124,7 @@
*> The factored form of the matrix A. AF contains the block
*> diagonal matrix D and the multipliers used to obtain the
*> factor U or L from the factorization A = U*D*U**T or A =
*> L*D*L**T as computed by SSYTRF.
*> L*D*L**T as computed by CSYTRF.
*> \endverbatim
*>
*> \param[in] LDAF
Expand All @@ -137,7 +137,7 @@
*> \verbatim
*> IPIV is INTEGER array, dimension (N)
*> Details of the interchanges and the block structure of D
*> as determined by SSYTRF.
*> as determined by CSYTRF.
*> \endverbatim
*>
*> \param[in,out] S
Expand Down Expand Up @@ -171,7 +171,7 @@
*> \param[in,out] X
*> \verbatim
*> X is COMPLEX array, dimension (LDX,NRHS)
*> On entry, the solution matrix X, as computed by SGETRS.
*> On entry, the solution matrix X, as computed by CGETRS.
*> On exit, the improved solution matrix X.
*> \endverbatim
*>
Expand Down
6 changes: 3 additions & 3 deletions SRC/csysv_aa_2stage.f
Original file line number Diff line number Diff line change
Expand Up @@ -7,11 +7,11 @@
*
*> \htmlonly
*> Download CSYSV_AA_2STAGE + dependencies
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/csysv_aasen_2stage.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/csysv_aa_2stage.f">
*> [TGZ]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/csysv_aasen_2stage.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/csysv_aa_2stage.f">
*> [ZIP]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/csysv_aasen_2stage.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/csysv_aa_2stage.f">
*> [TXT]</a>
*> \endhtmlonly
*
Expand Down
6 changes: 3 additions & 3 deletions SRC/csysvxx.f
Original file line number Diff line number Diff line change
Expand Up @@ -185,7 +185,7 @@
*> If FACT = 'F', then AF is an input argument and on entry
*> contains the block diagonal matrix D and the multipliers
*> used to obtain the factor U or L from the factorization A =
*> U*D*U**T or A = L*D*L**T as computed by SSYTRF.
*> U*D*U**T or A = L*D*L**T as computed by CSYTRF.
*>
*> If FACT = 'N', then AF is an output argument and on exit
*> returns the block diagonal matrix D and the multipliers
Expand All @@ -204,7 +204,7 @@
*> IPIV is INTEGER array, dimension (N)
*> If FACT = 'F', then IPIV is an input argument and on entry
*> contains details of the interchanges and the block
*> structure of D, as determined by SSYTRF. If IPIV(k) > 0,
*> structure of D, as determined by CSYTRF. If IPIV(k) > 0,
*> then rows and columns k and IPIV(k) were interchanged and
*> D(k,k) is a 1-by-1 diagonal block. If UPLO = 'U' and
*> IPIV(k) = IPIV(k-1) < 0, then rows and columns k-1 and
Expand All @@ -215,7 +215,7 @@
*>
*> If FACT = 'N', then IPIV is an output argument and on exit
*> contains details of the interchanges and the block
*> structure of D, as determined by SSYTRF.
*> structure of D, as determined by CSYTRF.
*> \endverbatim
*>
*> \param[in,out] EQUED
Expand Down
6 changes: 3 additions & 3 deletions SRC/ctpmlqt.f
Original file line number Diff line number Diff line change
Expand Up @@ -74,15 +74,15 @@
*> MB is INTEGER
*> The block size used for the storage of T. K >= MB >= 1.
*> This must be the same value of MB used to generate T
*> in DTPLQT.
*> in CTPLQT.
*> \endverbatim
*>
*> \param[in] V
*> \verbatim
*> V is COMPLEX array, dimension (LDV,K)
*> The i-th row must contain the vector which defines the
*> elementary reflector H(i), for i = 1,2,...,k, as returned by
*> DTPLQT in B. See Further Details.
*> CTPLQT in B. See Further Details.
*> \endverbatim
*>
*> \param[in] LDV
Expand All @@ -97,7 +97,7 @@
*> \verbatim
*> T is COMPLEX array, dimension (LDT,K)
*> The upper triangular factors of the block reflectors
*> as returned by DTPLQT, stored as a MB-by-K matrix.
*> as returned by CTPLQT, stored as a MB-by-K matrix.
*> \endverbatim
*>
*> \param[in] LDT
Expand Down
2 changes: 1 addition & 1 deletion SRC/ctzrzf.f
Original file line number Diff line number Diff line change
Expand Up @@ -141,7 +141,7 @@
*> V = ( I A(:,M+1:N) )
*>
*> I is the M-by-M identity matrix, A(:,M+1:N)
*> is the output stored in A on exit from DTZRZF,
*> is the output stored in A on exit from CTZRZF,
*> and tau(k) is the kth element of the array TAU.
*>
*> \endverbatim
Expand Down
6 changes: 3 additions & 3 deletions SRC/cungtsqr.f
Original file line number Diff line number Diff line change
Expand Up @@ -9,9 +9,9 @@
*> Download CUNGTSQR + dependencies
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.tgz?format=tgz&filename=/lapack/lapack_routine/cuntsqr.f">
*> [TGZ]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/zungtsqr.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.zip?format=zip&filename=/lapack/lapack_routine/cungtsqr.f">
*> [ZIP]</a>
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/zungtsqr.f">
*> <a href="http://www.netlib.org/cgi-bin/netlibfiles.txt?format=txt&filename=/lapack/lapack_routine/cungtsqr.f">
*> [TXT]</a>
*> \endhtmlonly
*>
Expand Down Expand Up @@ -60,7 +60,7 @@
*> \param[in] MB
*> \verbatim
*> MB is INTEGER
*> The row block size used by DLATSQR to return
*> The row block size used by CLATSQR to return
*> arrays A and T. MB > N.
*> (Note that if MB > M, then M is used instead of MB
*> as the row block size).
Expand Down
Loading

0 comments on commit 56d3c3f

Please sign in to comment.