43 #ifndef IFPACK_DENSECONTAINER_H 44 #define IFPACK_DENSECONTAINER_H 48 #include "Epetra_SerialDenseMatrix.h" 49 #include "Epetra_SerialDenseSolver.h" 50 #include "Epetra_IntSerialDenseVector.h" 201 for (
int i = 0 ; i <
NumRows_ ; ++i)
214 virtual double&
LHS(
const int i,
const int Vector = 0);
217 virtual double&
RHS(
const int i,
const int Vector = 0);
229 virtual int&
ID(
const int i);
340 virtual std::ostream&
Print(std::ostream& os)
const;
Ifpack_DenseContainer(const int NumRows_in, const int NumVectors_in=1)
Default constructor.
Epetra_SerialDenseMatrix NonFactoredMatrix_
Dense matrix, that contains the non-factored matrix.
virtual int Compute(const Epetra_RowMatrix &Matrix_in)
Finalizes the linear system matrix and prepares for the application of the inverse.
virtual const Epetra_IntSerialDenseVector & ID() const
Returns the integer dense vector of IDs.
virtual bool IsInitialized() const
Returns true is the container has been successfully initialized.
virtual bool KeepNonFactoredMatrix() const
Returns KeepNonFactoredMatrix_.
virtual int SetNumVectors(const int NumVectors_in)
Sets the number of vectors for LHS/RHS.
virtual int SetMatrixElement(const int row, const int col, const double value)
Set the matrix element (row,col) to value.
virtual double InitializeFlops() const
Returns the flops in Initialize().
virtual int SetKeepNonFactoredMatrix(const bool flag)
If flag is true, keeps a copy of the non-factored matrix.
virtual double ApplyInverseFlops() const
Returns the flops in ApplyInverse().
virtual const Epetra_SerialDenseMatrix & LHS() const
Returns the dense vector containing the LHS.
int SetVectors(Epetra_SerialDenseMatrix &X, Epetra_SerialDenseMatrix &B)
Epetra_SerialDenseMatrix RHS_
Dense vector representing the RHS.
virtual double ApplyFlops() const
Returns the flops in Apply().
virtual double ComputeFlops() const
Returns the flops in Compute().
Epetra_SerialDenseSolver Solver_
Dense solver (solution will be get using LAPACK).
virtual ~Ifpack_DenseContainer()
Destructor.
virtual int Extract(const Epetra_RowMatrix &Matrix_in)
Extract the submatrices identified by the ID set int ID().
bool IsInitialized_
If true, the container has been successfully initialized.
Ifpack_DenseContainer(const Ifpack_DenseContainer &rhs)
Copy constructor.
double ApplyFlops_
Flops in Apply().
virtual bool IsComputed() const
Returns true is the container has been successfully computed.
virtual double & LHS(const int i, const int Vector=0)
Returns the i-th component of the vector Vector of LHS.
virtual int & ID(const int i)
Returns the ID associated to local row i.
virtual int Apply()
Apply the matrix to RHS, results are stored in LHS.
int NumRows_
Number of rows in the container.
virtual int NumVectors() const
Returns the number of vectors in LHS/RHS.
std::string Label_
Label for this object.
Ifpack_DenseContainer & operator=(const Ifpack_DenseContainer &rhs)
Operator=.
Epetra_IntSerialDenseVector ID_
Sets of local rows.
virtual int Initialize()
Initialize the container.
virtual int NumRows() const
Returns the number of rows of the matrix and LHS/RHS.
int Reshape(int NumRows, int NumCols)
virtual int ApplyInverse()
Apply the inverse of the matrix to RHS, results are stored in LHS.
virtual const Epetra_SerialDenseMatrix & Matrix() const
Returns the dense matrix or its factors.
Epetra_SerialDenseMatrix Matrix_
Dense matrix.
int NumVectors_
Number of vectors in the container.
bool IsComputed_
If true, the container has been successfully computed.
Ifpack_DenseContainer: a class to define containers for dense matrices.
virtual const Epetra_SerialDenseMatrix & NonFactoredMatrix() const
Returns the non-factored dense matrix (only if stored).
virtual const char * Label() const
Returns the label of this container.
virtual std::ostream & Print(std::ostream &os) const
Prints basic information on iostream. This function is used by operator<<.
double ComputeFlops_
Flops in Compute().
Ifpack_Container: a pure virtual class for creating and solving local linear problems.
virtual double & RHS(const int i, const int Vector=0)
Returns the i-th component of the vector Vector of RHS.
double ApplyInverseFlops_
Flops in ApplyInverse().
virtual int SetParameters(Teuchos::ParameterList &List)
Sets all necessary parameters.
virtual const Epetra_SerialDenseMatrix & RHS() const
Returns the dense vector containing the RHS.
#define IFPACK_CHK_ERR(ifpack_err)
bool KeepNonFactoredMatrix_
If true, keeps a copy of the non-factored matrix.
Epetra_SerialDenseMatrix LHS_
Dense vector representing the LHS.