44#ifndef EPETRA_SERIALSPDDENSESOLVER_H
45#define EPETRA_SERIALSPDDENSESOLVER_H
262 double AMAX() {
return(AMAX_);};
Epetra_SerialDenseSolver: A class for solving dense linear problems.
virtual int Solve(void)
Computes the solution X to AX = B for the this matrix and the B provided to SetVectors()....
double AMAX() const
Returns the absolute value of the largest entry of the this matrix (returns -1 if not yet computed).
int SetMatrix(Epetra_SerialDenseMatrix &A)
Sets the pointers for coefficient matrix.
virtual int ReciprocalConditionEstimate(double &Value)
Returns the reciprocal of the 1-norm condition number of the this matrix.
virtual int ApplyRefinement(void)
Apply Iterative Refinement.
virtual int ComputeEquilibrateScaling(void)
Computes the scaling vector S(i) = 1/sqrt(A(i,i)) of the this matrix.
virtual int Factor(void)
Computes the in-place LU factorization of the matrix using the LAPACK routine DGETRF.
virtual int EquilibrateMatrix(void)
Equilibrates the this matrix.
virtual int Invert(void)
Inverts the this matrix.
Epetra_SerialSpdDenseSolver: A class for constructing and using symmetric positive definite dense mat...
Epetra_SerialSpdDenseSolver(const Epetra_SerialSpdDenseSolver &Source)
bool ShouldEquilibrate()
Returns true if the LAPACK general rules for equilibration suggest you should equilibrate the system.
Epetra_SerialSymDenseMatrix * SymFactor_
int EquilibrateRHS(void)
Equilibrates the current RHS.
double SCOND()
Ratio of smallest to largest equilibration scale factors for the this matrix (returns -1 if not yet c...
Epetra_SerialSpdDenseSolver & operator=(const Epetra_SerialSpdDenseSolver &Source)
Epetra_SerialSymDenseMatrix * SymMatrix() const
Returns pointer to current matrix.
double AMAX()
Returns the absolute value of the largest entry of the this matrix (returns -1 if not yet computed).
Epetra_SerialSymDenseMatrix * SymFactoredMatrix() const
Returns pointer to factored matrix (assuming factorization has been performed).
Epetra_SerialSymDenseMatrix * SymMatrix_
int UnequilibrateLHS(void)
Unscales the solution vectors if equilibration was used to solve the system.
Epetra_SerialSymDenseMatrix: A class for constructing and using symmetric positive definite dense mat...