45 #include "Epetra_RowMatrix.h" 71 memset(
Matrix_.
A(),0,
sizeof(double)*size);
113 if ((row < 0) || (row >=
NumRows())) {
117 if ((col < 0) || (col >=
NumRows())) {
138 #ifdef IFPACK_FLOPCOUNTERS 155 for (
int j = 0 ; j <
NumRows_ ; ++j) {
160 if (
ID(j) > Matrix_in.NumMyRows())
165 int Length = Matrix_in.MaxNumEntries();
166 std::vector<double> Values;
167 Values.resize(Length);
168 std::vector<int> Indices;
169 Indices.resize(Length);
171 for (
int j = 0 ; j <
NumRows_ ; ++j) {
178 Matrix_in.ExtractMyRowCopy(LRID, Length, NumEntries,
179 &Values[0], &Indices[0]);
182 for (
int k = 0 ; k < NumEntries ; ++k) {
184 int LCID = Indices[k];
187 if (LCID >= Matrix_in.NumMyRows())
194 for (
int kk = 0 ; kk <
NumRows_ ; ++kk)
228 Label_ =
"Ifpack_TriDiContainer";
231 #ifdef IFPACK_FLOPCOUNTERS 263 os <<
"================================================================================" << endl;
264 os <<
"Ifpack_TriDiContainer" << endl;
265 os <<
"Number of rows = " <<
NumRows() << endl;
266 os <<
"Number of vectors = " <<
NumVectors() << endl;
268 os <<
"IsComputed() = " <<
IsComputed() << endl;
269 #ifdef IFPACK_FLOPCOUNTERS 270 os <<
"Flops in Compute() = " <<
ComputeFlops() << endl;
273 os <<
"================================================================================" << endl;
std::string Label_
Label for this object.
virtual double ComputeFlops() const
Returns the flops in Compute().
int Shape(int NumRowCol)
Set dimensions of a Ifpack_SerialTriDiMatrix object; init values to zero.
double ApplyInverseFlops_
Flops in ApplyInverse().
virtual int Solve(void)
Computes the solution X to AX = B for the this matrix and the B provided to SetVectors()..
virtual int Factor(void)
Computes the in-place LU factorization of the matrix using the LAPACK routine DGETRF.
virtual int SetMatrixElement(const int row, const int col, const double value)
Set the matrix element (row,col) to value.
bool IsInitialized_
If true, the container has been successfully initialized.
bool KeepNonFactoredMatrix_
If true, keeps a copy of the non-factored matrix.
virtual int Extract(const Epetra_RowMatrix &Matrix_in)
Extract the submatrices identified by the ID set int ID().
int SetMatrix(Ifpack_SerialTriDiMatrix &A)
Sets the pointers for coefficient matrix.
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.
Epetra_SerialDenseMatrix RHS_
SerialDense vector representing the RHS.
virtual bool IsComputed() const
Returns true is the container has been successfully computed.
int NumVectors_
Number of vectors in the container.
double * A() const
Returns pointer to the this matrix.
Ifpack_SerialTriDiSolver Solver_
TriDi solver (solution will be get using LAPACK).
int NumRows_
Number of rows in the container.
virtual int NumVectors() const
Returns the number of vectors in LHS/RHS.
Epetra_IntSerialDenseVector ID_
Sets of local rows.
virtual const Epetra_SerialDenseMatrix & RHS() const
Returns the dense vector containing the RHS.
virtual std::ostream & Print(std::ostream &os) const
Prints basic information on iostream. This function is used by operator<<.
virtual int Apply()
Apply the matrix to RHS, results are stored in LHS.
virtual int Compute(const Epetra_RowMatrix &Matrix_in)
Finalizes the linear system matrix and prepares for the application of the inverse.
virtual const Epetra_SerialDenseMatrix & LHS() const
Returns the dense vector containing the LHS.
virtual int ApplyInverse()
Apply the inverse of the matrix to RHS, results are stored in LHS.
Ifpack_SerialTriDiMatrix Matrix_
TriDi matrix.
virtual int Initialize()
Initialize the container.
Ifpack_SerialTriDiMatrix NonFactoredMatrix_
TriDi matrix, that contains the non-factored matrix.
int SetVectors(Epetra_SerialDenseMatrix &X, Epetra_SerialDenseMatrix &B)
Sets the pointers for left and right hand side vector(s).
bool IsComputed_
If true, the container has been successfully computed.
#define IFPACK_CHK_ERR(ifpack_err)
double ComputeFlops_
Flops in Compute().
virtual double ApplyInverseFlops() const
Returns the flops in ApplyInverse().
Epetra_SerialDenseMatrix LHS_
SerialDense vector representing the LHS.
virtual int NumRows() const
Returns the number of rows of the matrix and LHS/RHS.