Teuchos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType > Member List

This is the complete list of members for Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >, including all inherited members.

A_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
AF_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
allocateIWORK()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inlineprotected
allocateWORK()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inlineprotected
AMAX() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
AMAX_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
ANORM() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
ANORM_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
applyRefinement()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
ASUM(const OrdinalType &n, const ScalarType *x, const OrdinalType &incx) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
AXPY(const OrdinalType &n, const alpha_type alpha, const x_type *x, const OrdinalType &incx, ScalarType *y, const OrdinalType &incy) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
BERR() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
BERR_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
BLAS(void)Teuchos::BLAS< OrdinalType, ScalarType >inline
BLAS(const BLAS< OrdinalType, ScalarType > &)Teuchos::BLAS< OrdinalType, ScalarType >inline
CompObject()Teuchos::CompObject
CompObject(const CompObject &source)Teuchos::CompObject
computeEquilibrateScaling()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
COPY(const OrdinalType &n, const ScalarType *x, const OrdinalType &incx, ScalarType *y, const OrdinalType &incy) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
DefaultBLASImpl(void)Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >inline
DefaultBLASImpl(const DefaultBLASImpl< OrdinalType, ScalarType > &)Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >inline
DOT(const OrdinalType &n, const x_type *x, const OrdinalType &incx, const y_type *y, const OrdinalType &incy) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
equilibrate_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
equilibratedA()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
equilibratedA_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
equilibratedB()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
equilibratedB_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
equilibrateMatrix()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
equilibrateRHS()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
estimateSolutionErrors(bool flag)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
estimateSolutionErrors_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
factor()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
Factor_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
factored()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
factored_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
factorWithEquilibration(bool flag)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
FERR() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
FERR_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
flopCounter_Teuchos::CompObjectprotected
GBCON(const char &NORM, const OrdinalType &n, const OrdinalType &kl, const OrdinalType &ku, const ScalarType *A, const OrdinalType &lda, const OrdinalType *IPIV, const ScalarType &anorm, ScalarType *rcond, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GBEQU(const OrdinalType &m, const OrdinalType &n, const OrdinalType &kl, const OrdinalType &ku, const ScalarType *A, const OrdinalType &lda, MagnitudeType *R, MagnitudeType *C, MagnitudeType *rowcond, MagnitudeType *colcond, MagnitudeType *amax, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GBRFS(const char &TRANS, const OrdinalType &n, const OrdinalType &kl, const OrdinalType &ku, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, const ScalarType *AF, const OrdinalType &ldaf, const OrdinalType *IPIV, const ScalarType *B, const OrdinalType &ldb, ScalarType *X, const OrdinalType &ldx, ScalarType *FERR, ScalarType *BERR, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GBTRF(const OrdinalType &m, const OrdinalType &n, const OrdinalType &kl, const OrdinalType &ku, ScalarType *A, const OrdinalType &lda, OrdinalType *IPIV, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GBTRS(const char &TRANS, const OrdinalType &n, const OrdinalType &kl, const OrdinalType &ku, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, const OrdinalType *IPIV, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEBAK(const char &JOBZ, const char &SIDE, const OrdinalType &n, const OrdinalType &ilo, const OrdinalType &ihi, const MagnitudeType *scale, const OrdinalType &m, ScalarType *V, const OrdinalType &ldv, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEBAL(const char &JOBZ, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *ilo, OrdinalType *ihi, MagnitudeType *scale, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GECON(const char &NORM, const OrdinalType &n, const ScalarType *A, const OrdinalType &lda, const ScalarType &anorm, ScalarType *rcond, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEEQU(const OrdinalType &m, const OrdinalType &n, const ScalarType *A, const OrdinalType &lda, ScalarType *R, ScalarType *C, ScalarType *rowcond, ScalarType *colcond, ScalarType *amax, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEES(const char &JOBVS, const char &SORT, OrdinalType &(*ptr2func)(ScalarType *, ScalarType *), const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *sdim, ScalarType *WR, ScalarType *WI, ScalarType *VS, const OrdinalType &ldvs, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *BWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEES(const char &JOBVS, const char &SORT, OrdinalType &(*ptr2func)(ScalarType *), const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *sdim, ScalarType *W, ScalarType *VS, const OrdinalType &ldvs, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *BWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEES(const char &JOBVS, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *sdim, MagnitudeType *WR, MagnitudeType *WI, ScalarType *VS, const OrdinalType &ldvs, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *BWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEEV(const char &JOBVL, const char &JOBVR, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, MagnitudeType *WR, MagnitudeType *WI, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEEVX(const char &BALANC, const char &JOBVL, const char &JOBVR, const char &SENSE, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *WR, ScalarType *WI, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, OrdinalType *ilo, OrdinalType *ihi, MagnitudeType *SCALE, MagnitudeType *abnrm, MagnitudeType *RCONDE, MagnitudeType *RCONDV, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEHRD(const OrdinalType &n, const OrdinalType &ilo, const OrdinalType &ihi, ScalarType *A, const OrdinalType &lda, ScalarType *TAU, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GELS(const char &TRANS, const OrdinalType &m, const OrdinalType &n, const OrdinalType &nrhs, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GELSS(const OrdinalType &m, const OrdinalType &n, const OrdinalType &nrhs, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, MagnitudeType *S, const MagnitudeType rcond, OrdinalType *rank, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GELSS(const OrdinalType &m, const OrdinalType &n, const OrdinalType &nrhs, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, ScalarType *S, const ScalarType &rcond, OrdinalType *rank, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEMM(ETransp transa, ETransp transb, const OrdinalType &m, const OrdinalType &n, const OrdinalType &k, const alpha_type alpha, const A_type *A, const OrdinalType &lda, const B_type *B, const OrdinalType &ldb, const beta_type beta, ScalarType *C, const OrdinalType &ldc) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
GEMV(ETransp trans, const OrdinalType &m, const OrdinalType &n, const alpha_type alpha, const A_type *A, const OrdinalType &lda, const x_type *x, const OrdinalType &incx, const beta_type beta, ScalarType *y, const OrdinalType &incy) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
GEQP3(const OrdinalType &m, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *jpvt, ScalarType *TAU, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEQR2(const OrdinalType &m, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *TAU, ScalarType *WORK, OrdinalType *const info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GEQRF(const OrdinalType &m, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *TAU, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GER(const OrdinalType &m, const OrdinalType &n, const alpha_type alpha, const x_type *x, const OrdinalType &incx, const y_type *y, const OrdinalType &incy, ScalarType *A, const OrdinalType &lda) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
GERFS(const char &TRANS, const OrdinalType &n, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, const ScalarType *AF, const OrdinalType &ldaf, const OrdinalType *IPIV, const ScalarType *B, const OrdinalType &ldb, ScalarType *X, const OrdinalType &ldx, ScalarType *FERR, ScalarType *BERR, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GESV(const OrdinalType &n, const OrdinalType &nrhs, ScalarType *A, const OrdinalType &lda, OrdinalType *IPIV, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GESVD(const char &JOBU, const char &JOBVT, const OrdinalType &m, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, MagnitudeType *S, ScalarType *U, const OrdinalType &ldu, ScalarType *V, const OrdinalType &ldv, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GESVX(const char &FACT, const char &TRANS, const OrdinalType &n, const OrdinalType &nrhs, ScalarType *A, const OrdinalType &lda, ScalarType *AF, const OrdinalType &ldaf, OrdinalType *IPIV, char *EQUED, ScalarType *R, ScalarType *C, ScalarType *B, const OrdinalType &ldb, ScalarType *X, const OrdinalType &ldx, ScalarType *rcond, ScalarType *FERR, ScalarType *BERR, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
getFactoredMatrix() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
getFlopCounter() const Teuchos::CompObjectinline
getFlops() const Teuchos::CompObjectinline
getLHS() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
getMatrix() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
GETRF(const OrdinalType &m, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *IPIV, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
getRHS() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
GETRI(const OrdinalType &n, ScalarType *A, const OrdinalType &lda, const OrdinalType *IPIV, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GETRS(const char &TRANS, const OrdinalType &n, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, const OrdinalType *IPIV, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
getTracebackMode()Teuchos::Objectstatic
GGES(const char &JOBVL, const char &JOBVR, const char &SORT, OrdinalType &(*ptr2func)(ScalarType *, ScalarType *, ScalarType *), const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, OrdinalType *sdim, MagnitudeType *ALPHAR, MagnitudeType *ALPHAI, MagnitudeType *BETA, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *BWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GGEV(const char &JOBVL, const char &JOBVR, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, MagnitudeType *ALPHAR, MagnitudeType *ALPHAI, ScalarType *BETA, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GGEVX(const char &BALANC, const char &JOBVL, const char &JOBVR, const char &SENSE, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, MagnitudeType *ALPHAR, MagnitudeType *ALPHAI, ScalarType *BETA, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, OrdinalType *ilo, OrdinalType *ihi, MagnitudeType *lscale, MagnitudeType *rscale, MagnitudeType *abnrm, MagnitudeType *bbnrm, MagnitudeType *RCONDE, MagnitudeType *RCONDV, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *IWORK, OrdinalType *BWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GGLSE(const OrdinalType &m, const OrdinalType &n, const OrdinalType &p, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, ScalarType *C, ScalarType *D, ScalarType *X, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GTTRF(const OrdinalType &n, ScalarType *dl, ScalarType *d, ScalarType *du, ScalarType *du2, OrdinalType *IPIV, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
GTTRS(const char &TRANS, const OrdinalType &n, const OrdinalType &nrhs, const ScalarType *dl, const ScalarType *d, const ScalarType *du, const ScalarType *du2, const OrdinalType *IPIV, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
HEEV(const char &JOBZ, const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, MagnitudeType *W, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
HEGV(const OrdinalType &itype, const char &JOBZ, const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, MagnitudeType *W, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
HSEQR(const char &JOB, const char &COMPZ, const OrdinalType &n, const OrdinalType &ilo, const OrdinalType &ihi, ScalarType *H, const OrdinalType &ldh, ScalarType *WR, ScalarType *WI, ScalarType *Z, const OrdinalType &ldz, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
IAMAX(const OrdinalType &n, const ScalarType *x, const OrdinalType &incx) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
ILAENV(const OrdinalType &ispec, const std::string &NAME, const std::string &OPTS, const OrdinalType &N1=-1, const OrdinalType &N2=-1, const OrdinalType &N3=-1, const OrdinalType &N4=-1) const Teuchos::LAPACK< OrdinalType, ScalarType >
INFO_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
invert()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
inverted()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
inverted_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
IWORK_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
label() const Teuchos::Objectvirtual
LAMCH(const char &CMACH) const Teuchos::LAPACK< OrdinalType, ScalarType >
LANGB(const char &NORM, const OrdinalType &n, const OrdinalType &kl, const OrdinalType &ku, const ScalarType *A, const OrdinalType &lda, MagnitudeType *WORK) const Teuchos::LAPACK< OrdinalType, ScalarType >
LAPACK(void)Teuchos::LAPACK< OrdinalType, ScalarType >inline
LAPACK(const LAPACK< OrdinalType, ScalarType > &lapack)Teuchos::LAPACK< OrdinalType, ScalarType >inline
LAPY2(const ScalarType &x, const ScalarType &y) const Teuchos::LAPACK< OrdinalType, ScalarType >
LARFG(const OrdinalType &n, ScalarType *alpha, ScalarType *x, const OrdinalType &incx, ScalarType *tau) const Teuchos::LAPACK< OrdinalType, ScalarType >
LARND(const OrdinalType &idist, OrdinalType *seed) const Teuchos::LAPACK< OrdinalType, ScalarType >
LARNV(const OrdinalType &idist, OrdinalType *seed, const OrdinalType &n, ScalarType *v) const Teuchos::LAPACK< OrdinalType, ScalarType >
LARTG(const ScalarType &f, const ScalarType &g, MagnitudeType *c, ScalarType *s, ScalarType *r) const Teuchos::LAPACK< OrdinalType, ScalarType >
LASCL(const char &TYPE, const OrdinalType &kl, const OrdinalType &ku, const MagnitudeType cfrom, const MagnitudeType cto, const OrdinalType &m, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
LASWP(const OrdinalType &N, ScalarType *A, const OrdinalType &LDA, const OrdinalType &K1, const OrdinalType &K2, const OrdinalType *IPIV, const OrdinalType &INCX) const Teuchos::LAPACK< OrdinalType, ScalarType >
LATRS(const char &UPLO, const char &TRANS, const char &DIAG, const char &NORMIN, const OrdinalType &N, const ScalarType *A, const OrdinalType &LDA, ScalarType *X, MagnitudeType *SCALE, MagnitudeType *CNORM, OrdinalType *INFO) const Teuchos::LAPACK< OrdinalType, ScalarType >
LDA_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
LDAF_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
LHS_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
LWORK_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
MagnitudeType typedefTeuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
Matrix_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
NRM2(const OrdinalType &n, const ScalarType *x, const OrdinalType &incx) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
numCols() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
numRowCols_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
numRows() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
Object(int tracebackModeIn=-1)Teuchos::Object
Object(const char *label, int tracebackModeIn=-1)Teuchos::Object
Object(const std::string &label, int tracebackModeIn=-1)Teuchos::Object
operator<<(std::ostream &os, const Teuchos::Object &obj)Teuchos::Objectrelated
operator=(const SerialSpdDenseSolver< OrdinalType, ScalarType > &Source)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >private
ORGHR(const OrdinalType &n, const OrdinalType &ilo, const OrdinalType &ihi, ScalarType *A, const OrdinalType &lda, const ScalarType *TAU, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
ORGQR(const OrdinalType &m, const OrdinalType &n, const OrdinalType &k, ScalarType *A, const OrdinalType &lda, const ScalarType *TAU, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
ORM2R(const char &SIDE, const char &TRANS, const OrdinalType &m, const OrdinalType &n, const OrdinalType &k, const ScalarType *A, const OrdinalType &lda, const ScalarType *TAU, ScalarType *C, const OrdinalType &ldc, ScalarType *WORK, OrdinalType *const info) const Teuchos::LAPACK< OrdinalType, ScalarType >
ORMHR(const char &SIDE, const char &TRANS, const OrdinalType &m, const OrdinalType &n, const OrdinalType &ilo, const OrdinalType &ihi, const ScalarType *A, const OrdinalType &lda, const ScalarType *TAU, ScalarType *C, const OrdinalType &ldc, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
ORMQR(const char &SIDE, const char &TRANS, const OrdinalType &m, const OrdinalType &n, const OrdinalType &k, const ScalarType *A, const OrdinalType &lda, const ScalarType *TAU, ScalarType *C, const OrdinalType &ldc, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
POCON(const char &UPLO, const OrdinalType &n, const ScalarType *A, const OrdinalType &lda, const ScalarType &anorm, ScalarType *rcond, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
POEQU(const OrdinalType &n, const ScalarType *A, const OrdinalType &lda, MagnitudeType *S, MagnitudeType *scond, MagnitudeType *amax, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
PORFS(const char &UPLO, const OrdinalType &n, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, const ScalarType *AF, const OrdinalType &ldaf, const ScalarType *B, const OrdinalType &ldb, ScalarType *X, const OrdinalType &ldx, ScalarType *FERR, ScalarType *BERR, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
POSV(const char &UPLO, const OrdinalType &n, const OrdinalType &nrhs, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
POSVX(const char &FACT, const char &UPLO, const OrdinalType &n, const OrdinalType &nrhs, ScalarType *A, const OrdinalType &lda, ScalarType *AF, const OrdinalType &ldaf, char *EQUED, ScalarType *S, ScalarType *B, const OrdinalType &ldb, ScalarType *X, const OrdinalType &ldx, ScalarType *rcond, ScalarType *FERR, ScalarType *BERR, ScalarType *WORK, OrdinalType *IWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
POTRF(const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
POTRI(const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
POTRS(const char &UPLO, const OrdinalType &n, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
print(std::ostream &os) const Teuchos::Objectvirtual
Print(std::ostream &os) const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
PTEQR(const char &COMPZ, const OrdinalType &n, MagnitudeType *D, MagnitudeType *E, ScalarType *Z, const OrdinalType &ldz, MagnitudeType *WORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
PTTRF(const OrdinalType &n, MagnitudeType *d, ScalarType *e, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
PTTRS(const OrdinalType &n, const OrdinalType &nrhs, const MagnitudeType *d, const ScalarType *e, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
R() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
R_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
RCOND() const Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
RCOND_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
reciprocalConditionEstimate(MagnitudeType &Value)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
reciprocalConditionEstimated()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
reciprocalConditionEstimated_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
refineSolution_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
reportError(const std::string message, int errorCode) const Teuchos::Objectvirtual
resetFlops() const Teuchos::CompObjectinline
resetMatrix()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
resetVectors()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
RHS_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
ROT(const OrdinalType &n, ScalarType *dx, const OrdinalType &incx, ScalarType *dy, const OrdinalType &incy, MagnitudeType *c, ScalarType *s) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
ROTG(ScalarType *da, ScalarType *db, rotg_c_type *c, ScalarType *s) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
rotg_c_type typedefTeuchos::DefaultBLASImpl< OrdinalType, ScalarType >
SCAL(const OrdinalType &n, const ScalarType &alpha, ScalarType *x, const OrdinalType &incx) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
SCOND()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
SCOND_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
SerialSpdDenseSolver()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
SerialSpdDenseSolver(const SerialSpdDenseSolver< OrdinalType, ScalarType > &Source)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >private
setFlopCounter(const Flops &FlopCounter)Teuchos::CompObjectinline
setFlopCounter(const CompObject &compObject)Teuchos::CompObjectinline
setLabel(const char *theLabel)Teuchos::Objectvirtual
setMatrix(const RCP< SerialSymDenseMatrix< OrdinalType, ScalarType > > &A_in)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
setTracebackMode(int tracebackModeValue)Teuchos::Objectstatic
setVectors(const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &X, const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &B)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
shouldEquilibrate()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
shouldEquilibrate_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
solutionErrorsEstimated()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
solutionErrorsEstimated_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
solutionRefined()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
solutionRefined_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
solve()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
solved()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
solved_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
solveToRefinedSolution(bool flag)Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
SPEV(const char &JOBZ, const char &UPLO, const OrdinalType &n, ScalarType *AP, ScalarType *W, ScalarType *Z, const OrdinalType &ldz, ScalarType *WORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
STEQR(const char &COMPZ, const OrdinalType &n, MagnitudeType *D, MagnitudeType *E, ScalarType *Z, const OrdinalType &ldz, MagnitudeType *WORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
SWAP(const OrdinalType &n, ScalarType *const x, const OrdinalType &incx, ScalarType *const y, const OrdinalType &incy) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
SYEV(const char &JOBZ, const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *W, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
SYGV(const OrdinalType &itype, const char &JOBZ, const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, ScalarType *W, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
SYMM(ESide side, EUplo uplo, const OrdinalType &m, const OrdinalType &n, const alpha_type alpha, const A_type *A, const OrdinalType &lda, const B_type *B, const OrdinalType &ldb, const beta_type beta, ScalarType *C, const OrdinalType &ldc) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
SYRK(EUplo uplo, ETransp trans, const OrdinalType &n, const OrdinalType &k, const alpha_type alpha, const A_type *A, const OrdinalType &lda, const beta_type beta, ScalarType *C, const OrdinalType &ldc) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
SYTRD(const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *D, ScalarType *E, ScalarType *TAU, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
TGEVC(const char &SIDE, const char &HOWMNY, const OrdinalType *SELECT, const OrdinalType &n, const ScalarType *S, const OrdinalType &lds, const ScalarType *P, const OrdinalType &ldp, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, const OrdinalType &mm, OrdinalType *M, ScalarType *WORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
TGSEN(const OrdinalType &ijob, const OrdinalType &wantq, const OrdinalType &wantz, const OrdinalType *SELECT, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, MagnitudeType *ALPHAR, MagnitudeType *ALPHAI, MagnitudeType *BETA, ScalarType *Q, const OrdinalType &ldq, ScalarType *Z, const OrdinalType &ldz, OrdinalType *M, MagnitudeType *PL, MagnitudeType *PR, MagnitudeType *DIF, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *IWORK, const OrdinalType &liwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
tracebackModeTeuchos::Objectstatic
transpose()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >inline
transpose_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
TREVC(const char &SIDE, const char &HOWMNY, OrdinalType *select, const OrdinalType &n, const ScalarType *T, const OrdinalType &ldt, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, const OrdinalType &mm, OrdinalType *m, ScalarType *WORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
TREVC(const char &SIDE, const OrdinalType &n, const ScalarType *T, const OrdinalType &ldt, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, const OrdinalType &mm, OrdinalType *m, ScalarType *WORK, MagnitudeType *RWORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
TREXC(const char &COMPQ, const OrdinalType &n, ScalarType *T, const OrdinalType &ldt, ScalarType *Q, const OrdinalType &ldq, OrdinalType *ifst, OrdinalType *ilst, ScalarType *WORK, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
TRMM(ESide side, EUplo uplo, ETransp transa, EDiag diag, const OrdinalType &m, const OrdinalType &n, const alpha_type alpha, const A_type *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
TRMV(EUplo uplo, ETransp trans, EDiag diag, const OrdinalType &n, const A_type *A, const OrdinalType &lda, ScalarType *x, const OrdinalType &incx) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
TRSEN(const char &JOB, const char &COMPQ, const OrdinalType *SELECT, const OrdinalType &n, ScalarType *T, const OrdinalType &ldt, ScalarType *Q, const OrdinalType &ldq, MagnitudeType *WR, MagnitudeType *WI, OrdinalType *M, ScalarType *S, MagnitudeType *SEP, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *IWORK, const OrdinalType &liwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
TRSM(ESide side, EUplo uplo, ETransp transa, EDiag diag, const OrdinalType &m, const OrdinalType &n, const alpha_type alpha, const A_type *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb) const Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >
TRTRI(const char &UPLO, const char &DIAG, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
TRTRS(const char &UPLO, const char &TRANS, const char &DIAG, const OrdinalType &n, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
unequilibrateLHS()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >
UNGQR(const OrdinalType &m, const OrdinalType &n, const OrdinalType &k, ScalarType *A, const OrdinalType &lda, const ScalarType *TAU, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
UNM2R(const char &SIDE, const char &TRANS, const OrdinalType &M, const OrdinalType &N, const OrdinalType &K, const ScalarType *A, const OrdinalType &LDA, const ScalarType *TAU, ScalarType *C, const OrdinalType &LDC, ScalarType *WORK, OrdinalType *const INFO) const Teuchos::LAPACK< OrdinalType, ScalarType >
UNMQR(const char &SIDE, const char &TRANS, const OrdinalType &m, const OrdinalType &n, const OrdinalType &k, const ScalarType *A, const OrdinalType &lda, const ScalarType *TAU, ScalarType *C, const OrdinalType &ldc, ScalarType *WORK, const OrdinalType &lwork, OrdinalType *info) const Teuchos::LAPACK< OrdinalType, ScalarType >
unsetFlopCounter()Teuchos::CompObjectinline
updateFlops(int addflops) const Teuchos::CompObjectinline
updateFlops(long int addflops) const Teuchos::CompObjectinline
updateFlops(double addflops) const Teuchos::CompObjectinline
updateFlops(float addflops) const Teuchos::CompObjectinline
WORK_Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >protected
~BLAS(void)Teuchos::BLAS< OrdinalType, ScalarType >inlinevirtual
~CompObject()Teuchos::CompObjectvirtual
~DefaultBLASImpl(void)Teuchos::DefaultBLASImpl< OrdinalType, ScalarType >inlinevirtual
~LAPACK(void)Teuchos::LAPACK< OrdinalType, ScalarType >inlinevirtual
~Object()Teuchos::Objectinlinevirtual
~SerialSpdDenseSolver()Teuchos::SerialSpdDenseSolver< OrdinalType, ScalarType >virtual