#include <Teuchos_SerialQRDenseSolver_MP_Vector.hpp>
Inherits CompObject, and Object.
|
int | setMatrix (const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &A) |
| Sets the pointers for coefficient matrix. More...
|
|
int | setVectors (const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &X, const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &B) |
| Sets the pointers for left and right hand side vector(s). More...
|
|
|
void | factorWithEquilibration (bool flag) |
| Causes equilibration to be called just before the matrix factorization as part of the call to factor . More...
|
|
void | solveWithTranspose (bool flag) |
| If flag is true, causes all subsequent function calls to work with the adjoint of this matrix, otherwise not. More...
|
|
void | solveWithTransposeFlag (Teuchos::ETransp trans) |
| All subsequent function calls will work with the transpose-type set by this method (Teuchos::NO_TRANS or Teuchos::CONJ_TRANS). More...
|
|
|
int | factor () |
| Computes the in-place QR factorization of the matrix using the LAPACK routine _GETRF or the Eigen class HouseholderQR. More...
|
|
int | solve () |
| Computes the solution X to AX = B for the this matrix and the B provided to SetVectors().. More...
|
|
int | computeEquilibrateScaling () |
| Determines if this matrix should be scaled. More...
|
|
int | equilibrateMatrix () |
| Equilibrates the this matrix. More...
|
|
int | equilibrateRHS () |
| Equilibrates the current RHS. More...
|
|
int | unequilibrateLHS () |
| Unscales the solution vectors if equilibration was used to solve the system. More...
|
|
int | formQ () |
| Explicitly forms the unitary matrix Q. More...
|
|
int | formR () |
| Explicitly forms the upper triangular matrix R. More...
|
|
int | multiplyQ (ETransp transq, SerialDenseMatrix< OrdinalType, ScalarType > &C) |
| Left multiply the input matrix by the unitary matrix Q or its adjoint. More...
|
|
int | solveR (ETransp transr, SerialDenseMatrix< OrdinalType, ScalarType > &C) |
| Solve input matrix on the left with the upper triangular matrix R or its adjoint. More...
|
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getMatrix () const |
| Returns pointer to current matrix. More...
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getFactoredMatrix () const |
| Returns pointer to factored matrix (assuming factorization has been performed). More...
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getQ () const |
| Returns pointer to Q (assuming factorization has been performed). More...
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getR () const |
| Returns pointer to R (assuming factorization has been performed). More...
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getLHS () const |
| Returns pointer to current LHS. More...
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getRHS () const |
| Returns pointer to current RHS. More...
|
|
OrdinalType | numRows () const |
| Returns row dimension of system. More...
|
|
OrdinalType | numCols () const |
| Returns column dimension of system. More...
|
|
std::vector< ScalarType > | tau () const |
| Returns pointer to pivot vector (if factorization has been computed), zero otherwise. More...
|
|
MagnitudeType | ANORM () const |
| Returns the absolute value of the largest element of this matrix (returns -1 if not yet computed). More...
|
|
|
void | Print (std::ostream &os) const |
| Print service methods; defines behavior of ostream << operator. More...
|
|
template<typename OrdinalType, typename Storage>
class Teuchos::SerialQRDenseSolver< OrdinalType, Sacado::MP::Vector< Storage > >
Definition at line 60 of file Teuchos_SerialQRDenseSolver_MP_Vector.hpp.
◆ ScalarType
template<typename OrdinalType , typename Storage >
◆ MagnitudeType
template<typename OrdinalType , typename Storage >
◆ BaseScalarType
template<typename OrdinalType , typename Storage >
◆ BaseQRType
template<typename OrdinalType , typename Storage >
◆ BaseMatrixType
template<typename OrdinalType , typename Storage >
◆ MatrixType
template<typename OrdinalType , typename Storage >
◆ SerialQRDenseSolver() [1/2]
template<typename OrdinalType , typename Storage >
◆ ~SerialQRDenseSolver()
template<typename OrdinalType , typename Storage >
◆ SerialQRDenseSolver() [2/2]
template<typename OrdinalType , typename Storage >
◆ setMatrix()
template<typename OrdinalType , typename Storage >
◆ setVectors()
template<typename OrdinalType , typename Storage >
Sets the pointers for left and right hand side vector(s).
Row dimension of X must match column dimension of matrix A, row dimension of B must match row dimension of A.
Definition at line 444 of file Teuchos_SerialQRDenseSolver_MP_Vector.hpp.
◆ factorWithEquilibration()
template<typename OrdinalType , typename Storage >
Causes equilibration to be called just before the matrix factorization as part of the call to factor
.
- Note
- This method must be called before the factorization is performed, otherwise it will have no effect.
Definition at line 101 of file Teuchos_SerialQRDenseSolver_MP_Vector.hpp.
◆ solveWithTranspose()
template<typename OrdinalType , typename Storage >
◆ solveWithTransposeFlag()
template<typename OrdinalType , typename Storage >
◆ factor()
template<typename OrdinalType , typename Storage >
◆ solve()
template<typename OrdinalType , typename Storage >
◆ computeEquilibrateScaling()
template<typename OrdinalType , typename Storage >
◆ equilibrateMatrix()
template<typename OrdinalType , typename Storage >
Equilibrates the this matrix.
- Note
- This method will be called automatically in solve() method if factorWithEquilibration( true ) is called.
- Returns
- Integer error code, set to 0 if successful.
Definition at line 145 of file Teuchos_SerialQRDenseSolver_MP_Vector.hpp.
◆ equilibrateRHS()
template<typename OrdinalType , typename Storage >
Equilibrates the current RHS.
- Note
- This method will be called automatically in solve() method if factorWithEquilibration( true ) is called.
- Returns
- Integer error code, set to 0 if successful.
Definition at line 152 of file Teuchos_SerialQRDenseSolver_MP_Vector.hpp.
◆ unequilibrateLHS()
template<typename OrdinalType , typename Storage >
Unscales the solution vectors if equilibration was used to solve the system.
- Note
- This method will be called automatically in solve() method if factorWithEquilibration( true ) is called.
- Returns
- Integer error code, set to 0 if successful.
Definition at line 159 of file Teuchos_SerialQRDenseSolver_MP_Vector.hpp.
◆ formQ()
template<typename OrdinalType , typename Storage >
◆ formR()
template<typename OrdinalType , typename Storage >
◆ multiplyQ()
template<typename OrdinalType , typename Storage >
◆ solveR()
template<typename OrdinalType , typename Storage >
◆ transpose()
template<typename OrdinalType , typename Storage >
◆ factored()
template<typename OrdinalType , typename Storage >
◆ equilibratedA()
template<typename OrdinalType , typename Storage >
◆ equilibratedB()
template<typename OrdinalType , typename Storage >
◆ shouldEquilibrate()
template<typename OrdinalType , typename Storage >
◆ solved()
template<typename OrdinalType , typename Storage >
◆ formedQ()
template<typename OrdinalType , typename Storage >
◆ formedR()
template<typename OrdinalType , typename Storage >
◆ getMatrix()
template<typename OrdinalType , typename Storage >
◆ getFactoredMatrix()
template<typename OrdinalType , typename Storage >
◆ getQ()
template<typename OrdinalType , typename Storage >
◆ getR()
template<typename OrdinalType , typename Storage >
◆ getLHS()
template<typename OrdinalType , typename Storage >
◆ getRHS()
template<typename OrdinalType , typename Storage >
◆ numRows()
template<typename OrdinalType , typename Storage >
◆ numCols()
template<typename OrdinalType , typename Storage >
◆ tau()
template<typename OrdinalType , typename Storage >
◆ ANORM()
template<typename OrdinalType , typename Storage >
◆ Print()
template<typename OrdinalType , typename Storage >
◆ resetMatrix()
template<typename OrdinalType , typename Storage >
◆ resetVectors()
template<typename OrdinalType , typename Storage >
◆ createBaseMatrix()
template<typename OrdinalType , typename Storage >
◆ createMatrix()
template<typename OrdinalType , typename Storage >
◆ operator=()
template<typename OrdinalType , typename Storage >
◆ base_QR_
template<typename OrdinalType , typename Storage >
◆ M_
template<typename OrdinalType , typename Storage >
◆ N_
template<typename OrdinalType , typename Storage >
◆ SacadoSize_
template<typename OrdinalType , typename Storage >
◆ Matrix_
template<typename OrdinalType , typename Storage >
◆ LHS_
template<typename OrdinalType , typename Storage >
◆ RHS_
template<typename OrdinalType , typename Storage >
◆ Factor_
template<typename OrdinalType , typename Storage >
◆ FactorQ_
template<typename OrdinalType , typename Storage >
◆ FactorR_
template<typename OrdinalType , typename Storage >
◆ Base_Matrix_
template<typename OrdinalType , typename Storage >
◆ Base_LHS_
template<typename OrdinalType , typename Storage >
◆ Base_RHS_
template<typename OrdinalType , typename Storage >
◆ Base_Factor_
template<typename OrdinalType , typename Storage >
◆ Base_FactorQ_
template<typename OrdinalType , typename Storage >
◆ Base_FactorR_
template<typename OrdinalType , typename Storage >
The documentation for this class was generated from the following file: