lapack

package
v0.0.0-...-0a9b891 Latest Latest
Warning

This package is not in the latest version of its module.

Go to latest
Published: Sep 29, 2012 License: LGPL-3.0 Imports: 6 Imported by: 3

Documentation

Index

Constants

This section is empty.

Variables

This section is empty.

Functions

func Gbsv

func Gbsv(A, B matrix.Matrix, ipiv []int32, kl int, opts ...linalg.Option) error

Solves a real or complex set of linear equations with a banded coefficient matrix.

PURPOSE

Solves A*X = B

A an n by n real or complex band matrix with kl subdiagonals and ku superdiagonals.

If ipiv is provided, then on entry the kl+ku+1 diagonals of the matrix are stored in rows kl+1 to 2*kl+ku+1 of A, in the BLAS format for general band matrices. On exit, A and ipiv contain the details of the factorization. If ipiv is not provided, then on entry the diagonals of the matrix are stored in rows 1 to kl+ku+1 of A, and Gbsv() does not return the factorization and does not modify A. On exit B is replaced with solution X.

ARGUMENTS.

A         float or complex banded matrix
B         float or complex matrix.  Must have the same type as A.
kl        nonnegative integer
ipiv      int array of length at least n

OPTIONS

ku        nonnegative integer.  If negative, the default value is
          used.  The default value is A.Rows-kl-1 if ipiv is
          not provided, and A.Rows-2*kl-1 otherwise.
n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= kl+ku+1 if ipiv is not provided
          and ldA >= 2*kl+ku+1 if ipiv is provided.  If zero, the
          default value is used.
ldB       positive integer.  ldB >= max(1,n).  If zero, the default
          default value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer;

func GbsvComplex

func GbsvComplex(A, B *matrix.ComplexMatrix, ipiv []int32, kl int, opts ...linalg.Option) error

func GbsvFloat

func GbsvFloat(A, B *matrix.FloatMatrix, ipiv []int32, kl int, opts ...linalg.Option) error

func Gbtrf

func Gbtrf(A matrix.Matrix, ipiv []int32, M, KL int, opts ...linalg.Option) error

LU factorization of a real or complex m by n band matrix.

PURPOSE

Computes the LU factorization of an m by n band matrix with kl subdiagonals and ku superdiagonals. On entry, the diagonals are stored in rows kl+1 to 2*kl+ku+1 of the array A, in the BLAS format for general band matrices. On exit A and ipiv contains the factorization.

ARGUMENTS

A         float or complex matrix
ipiv      int array of length at least min(m,n)
m         nonnegative integer
kl        nonnegative integer.

OPTIONS

n         nonnegative integer, default =A.Cols()
ku        nonnegative integer. default = A.Rows()-2*kl+1
ldA       positive integer, ldA >= 2*kl+ku+1. default = min(1, A.Rows())
offsetA   nonnegative integer

func GbtrfFloat

func GbtrfFloat(A *matrix.FloatMatrix, ipiv []int32, M, KL int, opts ...linalg.Option) error

func Gbtrs

func Gbtrs(A, B matrix.Matrix, ipiv []int32, KL int, opts ...linalg.Option) error

Solves a real or complex set of linear equations with a banded coefficient matrix, given the LU factorization computed by gbtrf() or gbsv().

PURPOSE

Solves linear equations

A*X = B,   if trans is PNoTrans
A^T*X = B, if trans is PTrans
A^H*X = B, if trans is PConjTrans

On entry, A and ipiv contain the LU factorization of an n by n band matrix A as computed by Getrf() or Gbsv(). On exit B is replaced by the solution X.

ARGUMENTS

A         float or complex matrix
B         float or complex  matrix.  Must have the same type as A.
ipiv      int vector
kl        nonnegative integer

OPTIONS

trans     PNoTrans, PTrans or PConjTrans
n         nonnegative integer.  If negative, the default value is used.
ku        nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldA       positive integer, ldA >= 2*kl+ku+1. If zero, the  default value is used.
ldB       positive integer, ldB >= max(1,n). If zero, the default value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer;

func GbtrsFloat

func GbtrsFloat(A, B *matrix.FloatMatrix, ipiv []int32, KL int, opts ...linalg.Option) error

func Geqrf

func Geqrf(A, tau matrix.Matrix, opts ...linalg.Option) error

QR factorization.

PURPOSE

QR factorization of an m by n real or complex matrix A:

A = Q*R = [Q1 Q2] * [R1; 0] if m >= n
A = Q*R = Q * [R1 R2]       if m <= n,

where Q is m by m and orthogonal/unitary and R is m by n with R1 upper triangular. On exit, R is stored in the upper triangular part of A. Q is stored as a product of k=min(m,n) elementary reflectors. The parameters of the reflectors are stored in the first k entries of tau and in the lower triangular part of the first k columns of A.

ARGUMENTS

A         float or complex matrix
tau       float or complex  matrix of length at least min(m,n).  Must
          have the same type as A.
m         integer.  If negative, the default value is used.
n         integer.  If negative, the default value is used.
ldA       nonnegative integer.  ldA >= max(1,m).  If zero, the
          default value is used.
offsetA   nonnegative integer

func Gesv

func Gesv(A, B matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

Solves a general real or complex set of linear equations.

PURPOSE

Solves A*X=B with A n by n real or complex.

If ipiv is provided, then on exit A is overwritten with the details of the LU factorization, and ipiv contains the permutation matrix. If ipiv is not provided, then gesv() does not return the factorization and does not modify A. On exit B is replaced with the solution X.

ARGUMENTS.

A         float or complex matrix
B         float or complex matrix.  Must have the same type as A.
ipiv      int vector of length at least n

OPTIONS:

n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default value is used.
ldB       positive integer.  ldB >= max(1,n).  If zero, the default value is used.
offsetA   nonnegative integer
offsetA   nonnegative integer;

func Gesvd

func Gesvd(A, S, U, Vt matrix.Matrix, opts ...linalg.Option) error

Singular value decomposition of a real or complex matrix.

PURPOSE

Computes singular values and, optionally, singular vectors of a real or complex m by n matrix A.

The argument jobu controls how many left singular vectors are computed:

PJobNo : no left singular vectors are computed.
PJobAll: all left singular vectors are computed and returned as
         columns of U.
PJobS  : the first min(m,n) left singular vectors are computed and
         returned as columns of U.
PJobO  : the first min(m,n) left singular vectors are computed and
         returned as columns of A.

The argument jobvt controls how many right singular vectors are computed:

PJobNo : no right singular vectors are computed.
PJobAll: all right singular vectors are computed and returned as
         rows of Vt.
PJobS  : the first min(m,n) right singular vectors are computed and
         returned as rows of Vt.
PJobO  : the first min(m,n) right singular vectors are computed and
         returned as rows of A.

Note that the (conjugate) transposes of the right singular vectors are returned in Vt or A. On exit (in all cases), the contents of A are destroyed.

ARGUMENTS

A         float or complex matrix
S         float matrix of length at least min(m,n).  On exit,
          contains the computed singular values in descending order.
jobu      PJobNo, PJobAll, PJobS or PJobO
jobvt     PJobNo, PJobAll, PJobS or PJobO
U         float or complex matrix.  Must have the same type as A.
          Not referenced if jobu is PJobNo or PJobO.  If jobu is PJobAll,
          a matrix with at least m columns.   If jobu is PJobS, a
          matrix with at least min(m,n) columns.
          On exit (with jobu PJobAll or PJobS), the columns of U
          contain the computed left singular vectors.
Vt        float or complex matrix.  Must have the same type as A.
          Not referenced if jobvt is PJobNo or PJobO.  If jobvt is
          PJobAll or PJobS, a matrix with at least n columns.
          On exit (with jobvt PJobAll or PJobS), the rows of Vt
          contain the computed right singular vectors, or, in
          the complex case, their complex conjugates.
m         integer.  If negative, the default value is used.
n         integer.  If negative, the default value is used.
ldA       nonnegative integer.  ldA >= max(1,m).
          If zero, the default value is used.
ldU       nonnegative integer.
          ldU >= 1        if jobu is PJobNo or PJobO
          ldU >= max(1,m) if jobu is PJobAll or PJobS.
          The default value is max(1,U.Rows) if jobu is PJobAll
          or PJobS, and 1 otherwise.
          If zero, the default value is used.
ldVt      nonnegative integer.
          ldVt >= 1 if jobvt is PJobNo or PJobO.
          ldVt >= max(1,n) if jobvt is PJobAll.
          ldVt >= max(1,min(m,n)) if ldVt is PJobS.
          The default value is max(1,Vt.Rows) if jobvt is PJobAll
          or PJobS, and 1 otherwise.
          If zero, the default value is used.
offsetA   nonnegative integer
offsetS   nonnegative integer
offsetU   nonnegative integer
offsetVt  nonnegative integer

func GesvdComplex

func GesvdComplex(A, S, U, Vt *matrix.ComplexMatrix, opts ...linalg.Option) error

func GesvdFloat

func GesvdFloat(A, S, U, Vt *matrix.FloatMatrix, opts ...linalg.Option) error

func Getrf

func Getrf(A matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

LU factorization of a general real or complex m by n matrix.

PURPOSE

On exit, A is replaced with L, U in the factorization P*A = L*U and ipiv contains the permutation: P = P_min{m,n} * ... * P2 * P1 where Pi interchanges rows i and ipiv[i] of A (using the Fortran convention, i.e., the first row is numbered 1).

ARGUMENTS

A         float or complex matrix
ipiv      int vector of length at least min(m,n)

OPTIONS

m         nonnegative integer.  If negative, the default value is used.
n         nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,m).  If zero, the default
          value is used.
offsetA   nonnegative integer

func Getri

func Getri(A matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

Inverse of a real or complex matrix.

PURPOSE

Computes the inverse of real or complex matrix of order n. On entry, A and ipiv contain the LU factorization, as returned by gesv() or getrf(). On exit A is replaced by the inverse.

ARGUMENTS

A         float or complex matrix
ipiv      int vector

OPTIONS

n         nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default
          value is used.
offsetA   nonnegative integer;

func Getrs

func Getrs(A, B matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

Solves a general real or complex set of linear equations, given the LU factorization computed by getrf() or gesv().

PURPOSE

Solves equations

A*X = B,   if trans is PNoTrans
A^T*X = B, if trans is PTrans
A^H*X = B, if trans is PConjTrans

On entry, A and ipiv contain the LU factorization of an n by n matrix A as computed by getrf() or gesv(). On exit B is replaced by the solution X.

ARGUMENTS

A         float or complex matrix
B         float or complex matrix.  Must have the same type as A.
ipiv      int vector

OPTIONS

trans     PNoTrans, PTrans, PConjTrans
n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default value is used.
ldB       positive integer.  ldB >= max(1,n).  If zero, the default value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer;

func Gtrrf

func Gtrrf(DL, D, DU, DU2 matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

LU factorization of a real or complex tridiagonal matrix.

PURPOSE

Factors an n by n real or complex tridiagonal matrix A as A = P*L*U.

A is specified by its lower diagonal dl, diagonal d, and upper diagonal du. On exit dl, d, du, du2 and ipiv contain the details of the factorization.

ARGUMENTS.

DL        float or complex matrix
D         float or complex matrix.  Must have the same type as DL.
DU        float or complex matrix.  Must have the same type as DL.
DU2       float or complex matrix of length at least n-2.  Must have the
          same type as DL.
ipiv      int vector of length at least n

OPTIONS

n         nonnegative integer.  If negative, the default value is used.
offsetdl  nonnegative integer
offsetd   nonnegative integer
offsetdu  nonnegative integer

func Gtrrs

func Gtrrs(DL, D, DU, DU2, B matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

Solves a real or complex tridiagonal set of linear equations, given the LU factorization computed by gttrf().

PURPOSE

solves A*X=B,   if trans is PNoTrans
solves A^T*X=B, if trans is PTrans
solves A^H*X=B, if trans is PConjTrans

On entry, DL, D, DU, DU2 and ipiv contain the LU factorization of an n by n tridiagonal matrix A as computed by gttrf(). On exit B is replaced by the solution X.

ARGUMENTS.

DL        float or complex matrix
D         float or complex matrix.  Must have the same type as dl.
DU        float or complex matrix.  Must have the same type as dl.
DU2       float or complex matrix.  Must have the same type as dl.
B         float or complex matrix.  Must have the same type oas dl.
ipiv      int vector

OPTIONS

trans     PNoTrans, PTrans, PConjTrans
n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldB       positive integer, ldB >= max(1,n). If zero, the default value is used.
offsetdl  nonnegative integer
offsetd   nonnegative integer
offsetdu  nonnegative integer
offsetB   nonnegative integer

func Ormqf

func Ormqf(A, tau, C matrix.Matrix, opts ...linalg.Option) error

Product with a real orthogonal matrix.

PURPOSE

Computes

C := Q*C   if side = PLeft  and trans = PNoTrans
C := Q^T*C if side = PLeft  and trans = PTrans
C := C*Q   if side = PRight and trans = PNoTrans
C := C*Q^T if side = PRight and trans = PTrans

C is m by n and Q is a square orthogonal matrix computed by geqrf.

Q is defined as a product of k elementary reflectors, stored as the first k columns of A and the first k entries of tau.

ARGUMENTS

A         float matrix
tau       float matrix of length at least k
C         float matrix

OPTIONS

side      PLeft or PRight
trans     PNoTrans or PTrans
m         integer.  If negative, the default value is used.
n         integer.  If negative, the default value is used.
k         integer.  k <= m if side = PRight and k <= n if side = PLeft.
          If negative, the default value is used.
ldA       nonnegative integer.  ldA >= max(1,m) if side = PLeft
          and ldA >= max(1,n) if side = PRight.  If zero, the
          default value is used.
ldC       nonnegative integer.  ldC >= max(1,m).  If zero, the
          default value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer

func Posv

func Posv(A, B matrix.Matrix, opts ...linalg.Option) error

Solves a real symmetric or complex Hermitian positive definite set of linear equations.

PURPOSE

Solves A*X = B with A n by n, real symmetric or complex Hermitian, and positive definite, and B n by nrhs. On exit, if uplo is PLower, the lower triangular part of A is replaced by L. If uplo is PUpper, the upper triangular part is replaced by L^H. B is replaced by the solution.

ARGUMENTS.

A         float or complex matrix
B         float or complex matrix.  Must have the same type as A.

OPTIONS

uplo      PLower or PUpper
n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is  used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default value is used.
ldB       positive integer.  ldB >= max(1,n).  If zero, the default value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer

func PosvComplex

func PosvComplex(A, B *matrix.ComplexMatrix, opts ...linalg.Option) error

func PosvFloat

func PosvFloat(A, B *matrix.FloatMatrix, opts ...linalg.Option) error

func Potrf

func Potrf(A matrix.Matrix, opts ...linalg.Option) error

Cholesky factorization of a real symmetric or complex Hermitian positive definite matrix.

PURPOSE

Factors A as A=L*L^T or A = L*L^H, where A is n by n, real symmetric or complex Hermitian, and positive definite.

On exit, if uplo=PLower, the lower triangular part of A is replaced by L. If uplo=PUpper, the upper triangular part is replaced by L^T or L^H.

ARGUMENTS

A         float or complex matrix

OPTIONS

uplo      PLower or PUpper
n         nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default
          value is used.
offsetA   nonnegative integer

func PotrfFloat

func PotrfFloat(A *matrix.FloatMatrix, opts ...linalg.Option) error

func Potri

func Potri(A matrix.Matrix, opts ...linalg.Option) error

Inverse of a real symmetric or complex Hermitian positive definite matrix.

PURPOSE

Computes the inverse of a real symmetric or complex Hermitian positive definite matrix of order n. On entry, A contains the Cholesky factor, as returned by posv() or potrf(). On exit it is replaced by the inverse.

ARGUMENTS

A         float or complex matrix

OPTIONS

uplo      PLower orPUpper
n         nonnegative integer.  If negative, the default value is  used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default
          value is used.
offsetA   nonnegative integer;

func PotriFloat

func PotriFloat(A *matrix.FloatMatrix, opts ...linalg.Option) error

func Potrs

func Potrs(A, B matrix.Matrix, opts ...linalg.Option) error

Solves a real symmetric or complex Hermitian positive definite set of linear equations, given the Cholesky factorization computed by potrf() or posv().

PURPOSE

Solves

A*X = B

where A is n by n, real symmetric or complex Hermitian and positive definite, and B is n by nrhs. On entry, A contains the Cholesky factor, as returned by Posv() or Potrf(). On exit B is replaced by the solution X.

ARGUMENTS

A         float or complex matrix
B         float or complex matrix.  Must have the same type as A.

OPTIONS

uplo      PLower or PUpper
n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default
          value is used.
ldB       positive integer.  ldB >= max(1,n).  If zero, the default
          value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer;

func Syevd

func Syevd(A, W matrix.Matrix, opts ...linalg.Option) error

Eigenvalue decomposition of a real symmetric matrix (divide-and-conquer driver).

PURPOSE

Returns eigenvalues/vectors of a real symmetric nxn matrix A. On exit, W contains the eigenvalues in ascending order. If jobz is PJobV, the (normalized) eigenvectors are also computed and returned in A. If jobz is PJobNo, only the eigenvalues are computed, and the content of A is destroyed.

ARGUMENTS

A         float matrix
W         float matrix of length at least n.  On exit, contains
          the computed eigenvalues in ascending order.

OPTIONS

jobz      PJobNo or PJobV
uplo      PLower or PUpper
n         integer.  If negative, the default value is used.
ldA       nonnegative integer.  ldA >= max(1,n).  If zero, the
          default value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer;

func SyevdFloat

func SyevdFloat(A, W *matrix.FloatMatrix, opts ...linalg.Option) error

func Syevr

func Syevr(A, W, Z matrix.Matrix, abstol float64, vlimit []float64, ilimit []int, opts ...linalg.Option) error

Computes selected eigenvalues and eigenvectors of a real symmetric matrix (RRR driver).

PURPOSE

Computes selected eigenvalues/vectors of a real symmetric n by n matrix A.

If range is PRangeAll, all eigenvalues are computed. If range is PRangeV all eigenvalues in the interval (vlimit[0],vlimit[1]] are computed. If range is PRangeI, all eigenvalues ilimit[0] through ilimit[1] are computed (sorted in ascending order with 1 <= ilimit[0] <= ilimit[1] <= n).

If jobz is PJobNo, only the eigenvalues are returned in W. If jobz is PJobV, the eigenvectors are also returned in Z. On exit, the content of A is destroyed.

Syevr is usually the fastest of the four eigenvalue routines.

ARGUMENTS

A         float matrix
W         float matrix of length at least n.  On exit, contains
          the computed eigenvalues in ascending order.
Z         float matrix or nil.  Only required when jobz = PJobV.
          If range is PRangeAll or PRangeV, Z must have at least n columns.
          If range is PRangeI, Z must have at least iu-il+1 columns.
          On exit the first m columns of Z contain the computed
          (normalized) eigenvectors.
abstol    double.  Absolute error tolerance for eigenvalues.
          If nonpositive, the LAPACK default value is used.
vlmit     []float or nil.  Only required when range is PRangeV.
ilimit    []int or nil.  Only required when range is PRangeI.

OPTIONS

jobz      PJobNo or PJobV
range     PRangeAll, PRangeV or PRangeI
uplo      PLower or PUpper
n         integer.  If negative, the default value is used.
ldA       nonnegative integer.  ldA >= max(1,n).
          If zero, the default value is used.
ldZ       nonnegative integer.  ldZ >= 1 if jobz is 'N' and
          ldZ >= max(1,n) if jobz is PJobV.  The default value
          is 1 if jobz is PJobNo and max(1,Z.Rows) if jobz =PJboV.
          If zero, the default value is used.
offsetA   nonnegative integer
offsetW   nonnegative integer
offsetZ   nonnegative integer
m         the number of eigenvalues computed

func SyevrFloat

func SyevrFloat(A, W, Z matrix.Matrix, abstol float64, vlimit []float64, ilimit []int, opts ...linalg.Option) error

func Syevx

func Syevx(A, W, Z matrix.Matrix, abstol float64, vlimit []float64, ilimit []int, opts ...linalg.Option) error

Computes selected eigenvalues and eigenvectors of a real symmetric matrix (expert driver).

PURPOSE

Computes selected eigenvalues/vectors of a real symmetric n by n matrix A.

If range is OptRangeAll, all eigenvalues are computed. If range is OptRangeValue, all eigenvalues in the interval (vlimit[0],vlimit[1]] are computed. If range is OptRangeInt, all eigenvalues il through iu are computed (sorted in ascending order with 1 <= il <= iu <= n).

If jobz is OptJobNo, only the eigenvalues are returned in W. If jobz is OptJobValue, the eigenvectors are also returned in Z.

On exit, the content of A is destroyed.

ARGUMENTS

A         float matrix
W         float matrix of length at least n.  On exit, contains
          the computed eigenvalues in ascending order.
Z         float matrix.  Only required when jobz is PJobValue.  If range
          is PRangeAll or PRangeValue, Z must have at least n columns.  If
          range is PRangeInt, Z must have at least iu-il+1 columns.
          On exit the first m columns of Z contain the computed (normalized) eigenvectors.
vlimit    []float64 or nul.  Only required when range is PRangeValue
ilimit    []int or nil.  Only required when range is PRangeInt.
abstol    double.  Absolute error tolerance for eigenvalues.
          If nonpositive, the LAPACK default value is used.

OPTIONS

jobz      linalg.OptJobNo or linalg.OptJobValue
range     linalg.OptRangeAll, linalg.OptRangeValue or linalg.OptRangeInt
uplo      linalg.OptLower or linalg.OptUpper
n         integer.  If negative, the default value is used.
m         the number of eigenvalues computed;
ldA       nonnegative integer.  ldA >= max(1,n).  If zero, the
          default value is used.
ldZ       nonnegative integer.  ldZ >= 1 if jobz is PJobNo and
          ldZ >= max(1,n) if jobz is PJobValue.  The default value
          is 1 if jobz is PJobNo and max(1,Z.size[0]) if jobz =PJobValue.
          If zero, the default value is used.
offsetA   nonnegative integer
offsetW   nonnegative integer
offsetZ   nonnegative integer

func SyevxFloat

func SyevxFloat(A, W, Z matrix.Matrix, abstol float64, vlimit []float64, ilimit []int, opts ...linalg.Option) error

func Sytrf

func Sytrf(A matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

LDL^T factorization of a real or complex symmetric matrix.

PURPOSE Computes the LDL^T factorization of a real or complex symmetric n by n matrix A. On exit, A and ipiv contain the details of the factorization.

ARGUMENTS

A         float or complex matrix
ipiv      int vector of length at least n

OPTIONS

uplo      PLower or PUpper
n         nonnegative integer.  If negative, the default value is  used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default
          value is used.
offsetA   nonnegative integer;

func SytrfComplex

func SytrfComplex(A *matrix.ComplexMatrix, ipiv []int32, opts ...linalg.Option) error

func SytrfFloat

func SytrfFloat(A *matrix.FloatMatrix, ipiv []int32, opts ...linalg.Option) error

func Sytrs

func Sytrs(A, B matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

Solves a real or complex symmetric set of linear equations, given the LDL^T factorization computed by sytrf() or sysv().

PURPOSE Solves

A*X = B

where A is real or complex symmetric and n by n, and B is n by nrhs. On entry, A and ipiv contain the factorization of A as returned by Sytrf() or Sysv(). On exit, B is replaced by the solution.

ARGUMENTS

A         float or complex matrix
B         float or complex matrix.  Must have the same type as A.
ipiv      int vector

OPTIONS

uplo      PLower or PUpper
n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default
          value is used.
ldB       nonnegative integer.  ldB >= max(1,n).  If zero, the
          default value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer;

func Trtrs

func Trtrs(A, B matrix.Matrix, ipiv []int32, opts ...linalg.Option) error

Solution of a triangular set of equations with multiple righthand sides.

PURPOSE Solves set of equations

A*X = B,   if trans is PNoTrans
A^T*X = B, if trans is PTrans
A^H*X = B, if trans is PConjTrans

B is n by nrhs and A is triangular of order n.

ARGUMENTS

A         float or complex matrix
B         float or complex matrix.  Must have the same type as A.

OPTIONS

uplo      PLower or PUpper
trans     PNoTrans, PTrans, PConjTrans
diag      PNonUnit, PUnit
n         nonnegative integer.  If negative, the default value is used.
nrhs      nonnegative integer.  If negative, the default value is used.
ldA       positive integer.  ldA >= max(1,n).  If zero, the default
          value is used.
ldB       positive integer.  ldB >= max(1,n).  If zero, the default
          value is used.
offsetA   nonnegative integer
offsetB   nonnegative integer;

Types

This section is empty.

Jump to

Keyboard shortcuts

? : This menu
/ : Search site
f or F : Jump to
y or Y : Canonical URL