Apply(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const | EpetraExt_HypreIJMatrix | inline |
ApplyInverse(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const | EpetraExt_HypreIJMatrix | inline |
CreatePrecond() | EpetraExt_HypreIJMatrix | protected |
CreateSolver() | EpetraExt_HypreIJMatrix | protected |
EpetraExt_HypreIJMatrix(HYPRE_IJMatrix matrix) | EpetraExt_HypreIJMatrix | |
ExtractMyEntryView(int CurEntry, double *&Value, int &RowIndex, int &ColIndex) | EpetraExt_HypreIJMatrix | |
ExtractMyEntryView(int CurEntry, const double *&Value, int &RowIndex, int &ColIndex) const | EpetraExt_HypreIJMatrix | |
ExtractMyRowCopy(int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const | EpetraExt_HypreIJMatrix | |
GetMatrix() | EpetraExt_HypreIJMatrix | inline |
Hypre_AMSCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_BoomerAMGCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_EuclidCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_ParaSailsCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_ParCSRBiCGSTABCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_ParCSRFlexGMRESCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_ParCSRGMRESCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_ParCSRHybridCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_ParCSRLGMRESCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
Hypre_ParCSRPCGCreate(MPI_Comm comm, HYPRE_Solver *solver) | EpetraExt_HypreIJMatrix | inlineprotected |
InitializeDefaults() | EpetraExt_HypreIJMatrix | protected |
IsPrecondSetup_ | EpetraExt_HypreIJMatrix | protected |
IsSolverSetup_ | EpetraExt_HypreIJMatrix | protected |
LeftScale(const Epetra_Vector &X) | EpetraExt_HypreIJMatrix | |
Matrix_ | EpetraExt_HypreIJMatrix | mutableprotected |
MatType_ | EpetraExt_HypreIJMatrix | mutableprotected |
Multiply(bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const | EpetraExt_HypreIJMatrix | |
MyRowEnd_ | EpetraExt_HypreIJMatrix | protected |
MyRowStart_ | EpetraExt_HypreIJMatrix | protected |
NumGlobalCols_ | EpetraExt_HypreIJMatrix | protected |
NumGlobalRows_ | EpetraExt_HypreIJMatrix | protected |
NumMyRowEntries(int MyRow, int &NumEntries) const | EpetraExt_HypreIJMatrix | |
NumMyRows_ | EpetraExt_HypreIJMatrix | protected |
par_x | EpetraExt_HypreIJMatrix | mutableprotected |
par_y | EpetraExt_HypreIJMatrix | mutableprotected |
ParMatrix_ | EpetraExt_HypreIJMatrix | mutableprotected |
PrecondCreatePtr_ | EpetraExt_HypreIJMatrix | protected |
PrecondDestroyPtr_ | EpetraExt_HypreIJMatrix | protected |
Preconditioner_ | EpetraExt_HypreIJMatrix | mutableprotected |
PrecondSetupPtr_ | EpetraExt_HypreIJMatrix | protected |
PrecondSolvePtr_ | EpetraExt_HypreIJMatrix | protected |
RightScale(const Epetra_Vector &X) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser, int(*pt2Func)(HYPRE_Solver, int), int parameter) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser, int(*pt2Func)(HYPRE_Solver, double), double parameter) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser, int(*pt2Func)(HYPRE_Solver, double, int), double parameter1, int parameter2) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser, int(*pt2Func)(HYPRE_Solver, int, int), int parameter1, int parameter2) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser, int(*pt2Func)(HYPRE_Solver, double *), double *parameter) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser, int(*pt2Func)(HYPRE_Solver, int *), int *parameter) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser, Hypre_Solver Solver, bool transpose=false) | EpetraExt_HypreIJMatrix | |
SetParameter(bool UsePreconditioner) | EpetraExt_HypreIJMatrix | |
SetParameter(Hypre_Chooser chooser) | EpetraExt_HypreIJMatrix | |
SetupPrecond() const | EpetraExt_HypreIJMatrix | protected |
SetupSolver() const | EpetraExt_HypreIJMatrix | protected |
Solve(bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const | EpetraExt_HypreIJMatrix | |
SolveOrPrec_ | EpetraExt_HypreIJMatrix | protected |
Solver_ | EpetraExt_HypreIJMatrix | mutableprotected |
SolverCreatePtr_ | EpetraExt_HypreIJMatrix | protected |
SolverDestroyPtr_ | EpetraExt_HypreIJMatrix | protected |
SolverPrecondPtr_ | EpetraExt_HypreIJMatrix | protected |
SolverSetupPtr_ | EpetraExt_HypreIJMatrix | protected |
SolverSolvePtr_ | EpetraExt_HypreIJMatrix | protected |
TransposeSolve_ | EpetraExt_HypreIJMatrix | protected |
UseTranspose() const | EpetraExt_HypreIJMatrix | inlinevirtual |
X_hypre | EpetraExt_HypreIJMatrix | mutableprotected |
x_local | EpetraExt_HypreIJMatrix | mutableprotected |
x_vec | EpetraExt_HypreIJMatrix | mutableprotected |
Y_hypre | EpetraExt_HypreIJMatrix | mutableprotected |
y_local | EpetraExt_HypreIJMatrix | mutableprotected |
y_vec | EpetraExt_HypreIJMatrix | mutableprotected |
~EpetraExt_HypreIJMatrix() | EpetraExt_HypreIJMatrix | virtual |