|
|
| SerialQRDenseSolver () |
| Default constructor; matrix should be set using setMatrix(), LHS and RHS set with setVectors().
|
|
virtual | ~SerialQRDenseSolver () |
| SerialQRDenseSolver destructor.
|
|
|
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.
|
|
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).
|
|
|
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...
|
|
|
bool | transpose () |
| Returns true if adjoint of this matrix has and will be used.
|
|
bool | factored () |
| Returns true if matrix is factored (factor available via getFactoredMatrix()).
|
|
bool | equilibratedA () |
| Returns true if factor is equilibrated (factor available via getFactoredMatrix()).
|
|
bool | equilibratedB () |
| Returns true if RHS is equilibrated (RHS available via getRHS()).
|
|
bool | shouldEquilibrate () |
| Returns true if the LAPACK general rules for equilibration suggest you should equilibrate the system.
|
|
bool | solved () |
| Returns true if the current set of vectors has been solved.
|
|
bool | formedQ () |
| Returns true if Q has been formed explicitly.
|
|
bool | formedR () |
| Returns true if R has been formed explicitly.
|
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getMatrix () const |
| Returns pointer to current matrix.
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getFactoredMatrix () const |
| Returns pointer to factored matrix (assuming factorization has been performed).
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getQ () const |
| Returns pointer to Q (assuming factorization has been performed).
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getR () const |
| Returns pointer to R (assuming factorization has been performed).
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getLHS () const |
| Returns pointer to current LHS.
|
|
RCP< SerialDenseMatrix< OrdinalType, ScalarType > > | getRHS () const |
| Returns pointer to current RHS.
|
|
OrdinalType | numRows () const |
| Returns row dimension of system.
|
|
OrdinalType | numCols () const |
| Returns column dimension of system.
|
|
std::vector< ScalarType > | tau () const |
| Returns pointer to pivot vector (if factorization has been computed), zero otherwise.
|
|
MagnitudeType | ANORM () const |
| Returns the absolute value of the largest element of this matrix (returns -1 if not yet computed).
|
|
|
void | Print (std::ostream &os) const |
| Print service methods; defines behavior of ostream << operator.
|
|