#include <Trilinos_Util_CrsMatrixGallery.h>
Public Member Functions | |
CrsMatrixGallery (const string name, const Epetra_Comm &comm) | |
Triutils_Gallery Constructor. | |
CrsMatrixGallery (const string name, const Epetra_Map &map) | |
Creates an Triutils_Gallery object using a given map. | |
~CrsMatrixGallery () | |
Triutils_Gallery destructor. | |
int | Set (const string parameter, const int value) |
Sets a gallery options using an interger value. | |
int | Set (const string parameter, const string value) |
Sets a gallery options using a C++ string . | |
int | Set (const string parameter, const double value) |
Sets a gallery options using an double value. | |
int | Set (const string parameter, const Epetra_Vector &value) |
Sets a gallery options using an Epetra_Vector. | |
int | Set (Trilinos_Util::CommandLineParser &CLP) |
Sets gallery options using values passed from the shell. | |
Protected Member Functions | |
void | CreateMap () |
Creates a map. | |
void | CreateMatrix () |
Creates the CrdMatrix. | |
void | CreateExactSolution () |
Creates the exact solution. | |
void | CreateStartingSolution () |
Creates the starting solution. | |
void | CreateRHS () |
Create the RHS corresponding to the desired exact solution. | |
void | CreateEye () |
void | CreateMatrixDiag () |
void | CreateMatrixTriDiag () |
void | CreateMatrixLaplace1d () |
void | CreateMatrixLaplace1dNeumann () |
void | CreateMatrixCrossStencil2d () |
void | CreateMatrixCrossStencil2dVector () |
void | CreateMatrixLaplace2d () |
void | CreateMatrixLaplace2d_BC () |
void | CreateMatrixLaplace2d_9pt () |
void | CreateMatrixStretched2d () |
void | CreateMatrixRecirc2d () |
void | CreateMatrixRecirc2dDivFree () |
void | CreateMatrixLaplace2dNeumann () |
void | CreateMatrixUniFlow2d () |
void | CreateMatrixLaplace3d () |
void | CreateMatrixCrossStencil3d () |
void | CreateMatrixCrossStencil3dVector () |
void | CreateMatrixLehmer () |
void | CreateMatrixMinij () |
void | CreateMatrixRis () |
void | CreateMatrixHilbert () |
void | CreateMatrixJordblock () |
void | CreateMatrixCauchy () |
void | CreateMatrixFiedler () |
void | CreateMatrixHanowa () |
void | CreateMatrixKMS () |
void | CreateMatrixParter () |
void | CreateMatrixPei () |
void | CreateMatrixOnes () |
void | CreateMatrixVander () |
void | ReadMatrix () |
void | GetNeighboursCartesian2d (const int i, const int nx, const int ny, int &left, int &right, int &lower, int &upper) |
void | GetNeighboursCartesian3d (const int i, const int nx, const int ny, const int nz, int &left, int &right, int &lower, int &upper, int &below, int &above) |
void | ZeroOutData () |
void | SetupCartesianGrid2D () |
void | SetupCartesianGrid3D () |
void | ExactSolQuadXY (double x, double y, double &u) |
void | ExactSolQuadXY (double x, double y, double &u, double &ux, double &uy, double &uxx, double &uyy) |
Protected Attributes | |
const Epetra_Comm * | comm_ |
Epetra_CrsMatrix * | matrix_ |
Epetra_MultiVector * | ExactSolution_ |
Epetra_MultiVector * | StartingSolution_ |
Epetra_MultiVector * | rhs_ |
Epetra_Map * | map_ |
Epetra_LinearProblem * | LinearProblem_ |
string | name_ |
int | NumGlobalElements_ |
int | NumMyElements_ |
int * | MyGlobalElements_ |
string | MapType_ |
bool | ContiguousMap_ |
std::vector< int > | MapMap_ |
string | ExactSolutionType_ |
string | StartingSolutionType_ |
string | ExpandType_ |
string | RhsType_ |
int | nx_ |
int | ny_ |
int | nz_ |
int | mx_ |
int | my_ |
int | mz_ |
double | lx_ |
double | ly_ |
double | lz_ |
int | NumPDEEqns_ |
int | NumVectors_ |
Epetra_Vector * | VectorA_ |
Epetra_Vector * | VectorB_ |
Epetra_Vector * | VectorC_ |
Epetra_Vector * | VectorD_ |
Epetra_Vector * | VectorE_ |
Epetra_Vector * | VectorF_ |
Epetra_Vector * | VectorG_ |
double | a_ |
double | b_ |
double | c_ |
double | d_ |
double | e_ |
double | f_ |
double | g_ |
double | alpha_ |
double | beta_ |
double | gamma_ |
double | delta_ |
double | conv_ |
double | diff_ |
double | source_ |
double | epsilon_ |
string | FileName_ |
string | ErrorMsg |
string | OutputMsg |
bool | verbose_ |
Epetra_CrsMatrix * | GetMatrix () |
Returns a pointer to the CrsMatrix. | |
Epetra_CrsMatrix & | GetMatrixRef () |
Epetra_MultiVector * | GetExactSolution () |
Returns a pointer to the exact solution. | |
Epetra_MultiVector * | GetStartingSolution () |
Returns a pointer to the starting solution (typically, for HB problems). | |
Epetra_MultiVector * | GetRHS () |
Returns a pointer to the rhs corresponding to the selected exact solution. | |
const Epetra_Map * | GetMap () |
Returns a pointer the internally stored Map. | |
const Epetra_Map & | GetMapRef () |
Epetra_LinearProblem * | GetLinearProblem () |
Returns a pointer to Epetra_LinearProblem. | |
void | ComputeResidual (double *residual) |
Computes the 2-norm of the residual. | |
void | ComputeDiffBetweenStartingAndExactSolutions (double *residual) |
Computes the 2-norm of the difference between the starting solution and the exact solution. | |
void | PrintMatrixAndVectors (ostream &os) |
Print out matrix and vectors. | |
void | PrintMatrixAndVectors () |
void | GetCartesianCoordinates (double *&x, double *&y, double *&z) |
Get pointers to double vectors containing coordinates of points. | |
int | WriteMatrix (const string &FileName, const bool UseSparse=true) |
Print matrix on file in MATLAB format. | |
ostream & | operator<< (ostream &os, const Trilinos_Util::CrsMatrixGallery &G) |
Print out detailed information about the problem at hand. |
Trilinos_Util::CrsMatrixGallery::CrsMatrixGallery | ( | const string | name, | |
const Epetra_Comm & | comm | |||
) |
Triutils_Gallery Constructor.
Creates a Triutils_Gallery instance.
The first parameter is the name of the matrix. We refer to the Trilinos Tutorial for a detailed description of available matrices.
int main(int argc, char *argv[]) { #ifdef HAVE_MPI MPI_Init(&argc,&argv); Epetra_MpiComm Comm (MPI_COMM_WORLD); #else Epetra_SerialComm Comm; #endif // create an Epetra matrix reading an H/B matrix Trilinos_Util_CrsMatrixGallery Gallery("hb", Comm); // set the name of the matrix Gallery.Set("matrix name", "bcsstk14.rsa"); Epetra_CrsMatrix * A; Epetra_Vector * ExactSolution; Epetra_Vector * RHS; Epetra_Vector * StartingSolution; // at this point the matrix is read from file A = Gallery.GetMatrix(); ExactSolution = Gallery.GetExactSolution(); // at this point the RHS is allocated and filled RHS = Gallery.GetRHS(); StartingSolution = Gallery.GetStartingSolution(); // create linear problem Epetra_LinearProblem Problem(A,StartingSolution,RHS); // create AztecOO instance AztecOO Solver(Problem); Solver.SetAztecOption( AZ_precond, AZ_dom_decomp ); Solver.Iterate(1000,1E-9); // compute residual double residual; Gallery.ComputeResidual(&residual); if( Comm.MyPID()==0 ) cout << "||b-Ax||_2 = " << residual << endl; Gallery.ComputeDiffBetweenStartingAndExactSolutions(&residual); if( Comm.MyPID()==0 ) cout << "||x_exact - x||_2 = " << residual << endl; #ifdef HAVE_MPI MPI_Finalize() ; #endif return 0 ; }
Class CommandLineParser can be used as well. In this case, one may decide to use the following:
Trilinos_Util::CommandLineParser CLP(argc,argv); // set a problem with no matrix name Trilinos_Util::CrsMatrixGallery Gallery("", Comm); // read parameters and settings from the shell line G.Set(CLP); // continue with your code...
In | comm - Epetra communicator |
References ErrorMsg, OutputMsg, verbose_, and ZeroOutData().
Trilinos_Util::CrsMatrixGallery::CrsMatrixGallery | ( | const string | name, | |
const Epetra_Map & | map | |||
) |
Creates an Triutils_Gallery object using a given map.
Create a Triutils_Gallery object using an Epetra_Map. Problem size must match the elements in map.
In | name - definition of the problem to be created. | |
In | map - Epetra_Map |
References comm_, ErrorMsg, map_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, verbose_, and ZeroOutData().
Trilinos_Util::CrsMatrixGallery::~CrsMatrixGallery | ( | void | ) |
Triutils_Gallery destructor.
References ExactSolution_, LinearProblem_, map_, matrix_, rhs_, StartingSolution_, VectorA_, VectorB_, VectorC_, VectorD_, VectorE_, VectorF_, VectorG_, and ZeroOutData().
void Trilinos_Util::CrsMatrixGallery::ComputeDiffBetweenStartingAndExactSolutions | ( | double * | residual | ) |
Computes the 2-norm of the difference between the starting solution and the exact solution.
References CreateRHS(), ExactSolution_, map_, NumVectors_, rhs_, and StartingSolution_.
void Trilinos_Util::CrsMatrixGallery::ComputeResidual | ( | double * | residual | ) |
Computes the 2-norm of the residual.
References CreateRHS(), map_, matrix_, NumVectors_, rhs_, and StartingSolution_.
void Trilinos_Util::CrsMatrixGallery::CreateExactSolution | ( | void | ) | [protected] |
Creates the exact solution.
References CreateMap(), ErrorMsg, ExactSolQuadXY(), ExactSolution_, ExactSolutionType_, lx_, ly_, map_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, NumVectors_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
Referenced by CreateRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), and GetExactSolution().
void Trilinos_Util::CrsMatrixGallery::CreateEye | ( | void | ) | [protected] |
void Trilinos_Util::CrsMatrixGallery::CreateMap | ( | void | ) | [protected] |
Creates a map.
Creates an Epetra_Map. Before calling this function, the problem size must have been specified.
CreateMap() allows some different maps. The type of map is set using Set("map",value). Value is a string, defined as:
References comm_, ContiguousMap_, ErrorMsg, map_, MapMap_, MapType_, mx_, my_, MyGlobalElements_, mz_, name_, NumGlobalElements_, NumMyElements_, nx_, ny_, nz_, OutputMsg, SetupCartesianGrid2D(), SetupCartesianGrid3D(), and verbose_.
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateMatrix(), CreateRHS(), CreateStartingSolution(), GetCartesianCoordinates(), GetMap(), GetMapRef(), and ReadMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrix | ( | void | ) | [protected] |
Creates the CrdMatrix.
References comm_, CreateEye(), CreateMap(), CreateMatrixCauchy(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil3d(), CreateMatrixDiag(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1d(), CreateMatrixLaplace1dNeumann(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixLaplace3d(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixRis(), CreateMatrixStretched2d(), CreateMatrixTriDiag(), CreateMatrixUniFlow2d(), CreateMatrixVander(), ErrorMsg, map_, matrix_, name_, OutputMsg, ReadMatrix(), and verbose_.
Referenced by CreateRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), GetMatrix(), GetMatrixRef(), and WriteMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixCauchy | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixCrossStencil2d | ( | void | ) | [protected] |
References a_, b_, c_, Copy, d_, e_, GetNeighboursCartesian2d(), map_, matrix_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), UNDEF, and verbose_.
Referenced by CreateMatrix(), CreateMatrixLaplace2d(), and CreateMatrixRecirc2dDivFree().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixCrossStencil2dVector | ( | void | ) | [protected] |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
Referenced by CreateMatrixRecirc2d(), and CreateMatrixUniFlow2d().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixCrossStencil3d | ( | void | ) | [protected] |
References a_, b_, c_, Copy, d_, e_, f_, g_, GetNeighboursCartesian3d(), map_, matrix_, MyGlobalElements_, NumMyElements_, nx_, ny_, nz_, OutputMsg, SetupCartesianGrid3D(), UNDEF, and verbose_.
Referenced by CreateMatrix(), and CreateMatrixLaplace3d().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixCrossStencil3dVector | ( | void | ) | [protected] |
References Copy, ErrorMsg, GetNeighboursCartesian3d(), map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, nx_, ny_, nz_, OutputMsg, and verbose_.
void Trilinos_Util::CrsMatrixGallery::CreateMatrixDiag | ( | void | ) | [protected] |
References a_, Copy, map_, matrix_, MyGlobalElements_, NumMyElements_, OutputMsg, UNDEF, and verbose_.
Referenced by CreateEye(), and CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixFiedler | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixHanowa | ( | void | ) | [protected] |
References a_, Copy, ErrorMsg, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixHilbert | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixJordblock | ( | void | ) | [protected] |
References a_, Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, VectorA_, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixKMS | ( | void | ) | [protected] |
References a_, Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLaplace1d | ( | void | ) | [protected] |
References a_, b_, c_, CreateMatrixTriDiag(), OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLaplace1dNeumann | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLaplace2d | ( | void | ) | [protected] |
References a_, b_, c_, CreateMatrixCrossStencil2d(), d_, e_, lx_, ly_, nx_, ny_, OutputMsg, Scaling, SetupCartesianGrid2D(), and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLaplace2d_9pt | ( | void | ) | [protected] |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLaplace2d_BC | ( | void | ) | [protected] |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLaplace2dNeumann | ( | void | ) | [protected] |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLaplace3d | ( | void | ) | [protected] |
void Trilinos_Util::CrsMatrixGallery::CreateMatrixLehmer | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixMinij | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixOnes | ( | void | ) | [protected] |
References a_, Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixParter | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixPei | ( | void | ) | [protected] |
References a_, Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixRecirc2d | ( | void | ) | [protected] |
References conv_, CreateMatrixCrossStencil2dVector(), diff_, lx_, ly_, map_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), UNDEF, VectorA_, VectorB_, VectorC_, VectorD_, VectorE_, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixRecirc2dDivFree | ( | void | ) | [protected] |
References conv_, CreateMatrixCrossStencil2d(), diff_, lx_, ly_, map_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), UNDEF, VectorA_, VectorB_, VectorC_, VectorD_, VectorE_, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixRis | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixStretched2d | ( | void | ) | [protected] |
References Copy, epsilon_, GetNeighboursCartesian2d(), map_, matrix_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), UNDEF, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixTriDiag | ( | void | ) | [protected] |
References a_, b_, c_, Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, and verbose_.
Referenced by CreateMatrix(), and CreateMatrixLaplace1d().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixUniFlow2d | ( | void | ) | [protected] |
References alpha_, conv_, CreateMatrixCrossStencil2dVector(), diff_, lx_, ly_, map_, MyGlobalElements_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), UNDEF, VectorA_, VectorB_, VectorC_, VectorD_, VectorE_, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateMatrixVander | ( | void | ) | [protected] |
References Copy, map_, matrix_, MyGlobalElements_, NumGlobalElements_, NumMyElements_, OutputMsg, VectorA_, and verbose_.
Referenced by CreateMatrix().
void Trilinos_Util::CrsMatrixGallery::CreateRHS | ( | void | ) | [protected] |
Create the RHS corresponding to the desired exact solution.
References alpha_, comm_, conv_, CreateExactSolution(), CreateMap(), CreateMatrix(), diff_, ErrorMsg, ExactSolQuadXY(), ExactSolution_, lx_, ly_, map_, matrix_, MyGlobalElements_, NumMyElements_, NumVectors_, nx_, ny_, OutputMsg, rhs_, RhsType_, SetupCartesianGrid2D(), UNDEF, and verbose_.
Referenced by ComputeDiffBetweenStartingAndExactSolutions(), ComputeResidual(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), and GetRHS().
void Trilinos_Util::CrsMatrixGallery::CreateStartingSolution | ( | void | ) | [protected] |
Creates the starting solution.
References CreateMap(), ErrorMsg, map_, NumVectors_, OutputMsg, StartingSolution_, StartingSolutionType_, and verbose_.
Referenced by Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), and GetStartingSolution().
void Trilinos_Util::CrsMatrixGallery::ExactSolQuadXY | ( | double | x, | |
double | y, | |||
double & | u, | |||
double & | ux, | |||
double & | uy, | |||
double & | uxx, | |||
double & | uyy | |||
) | [protected] |
void Trilinos_Util::CrsMatrixGallery::ExactSolQuadXY | ( | double | x, | |
double | y, | |||
double & | u | |||
) | [protected] |
Referenced by CreateExactSolution(), and CreateRHS().
void Trilinos_Util::CrsMatrixGallery::GetCartesianCoordinates | ( | double *& | x, | |
double *& | y, | |||
double *& | z | |||
) |
Epetra_MultiVector * Trilinos_Util::CrsMatrixGallery::GetExactSolution | ( | void | ) |
Returns a pointer to the exact solution.
Returns a pointer to the exact solution.
Some choices are available to define the exact solution, using Set("exact solution", value). value can be:
References CreateExactSolution(), and ExactSolution_.
Epetra_LinearProblem * Trilinos_Util::CrsMatrixGallery::GetLinearProblem | ( | void | ) |
Returns a pointer to Epetra_LinearProblem.
References GetMatrix(), GetRHS(), GetStartingSolution(), and LinearProblem_.
const Epetra_Map * Trilinos_Util::CrsMatrixGallery::GetMap | ( | void | ) |
const Epetra_Map & Trilinos_Util::CrsMatrixGallery::GetMapRef | ( | void | ) |
References CreateMap(), and map_.
Epetra_CrsMatrix * Trilinos_Util::CrsMatrixGallery::GetMatrix | ( | void | ) |
Returns a pointer to the CrsMatrix.
References CreateMatrix(), and matrix_.
Referenced by GetLinearProblem().
Epetra_CrsMatrix & Trilinos_Util::CrsMatrixGallery::GetMatrixRef | ( | void | ) |
References CreateMatrix(), and matrix_.
void Trilinos_Util::CrsMatrixGallery::GetNeighboursCartesian2d | ( | const int | i, | |
const int | nx, | |||
const int | ny, | |||
int & | left, | |||
int & | right, | |||
int & | lower, | |||
int & | upper | |||
) | [protected] |
void Trilinos_Util::CrsMatrixGallery::GetNeighboursCartesian3d | ( | const int | i, | |
const int | nx, | |||
const int | ny, | |||
const int | nz, | |||
int & | left, | |||
int & | right, | |||
int & | lower, | |||
int & | upper, | |||
int & | below, | |||
int & | above | |||
) | [protected] |
References GetNeighboursCartesian2d().
Referenced by CreateMatrixCrossStencil3d(), and CreateMatrixCrossStencil3dVector().
Epetra_MultiVector * Trilinos_Util::CrsMatrixGallery::GetRHS | ( | void | ) |
Returns a pointer to the rhs corresponding to the selected exact solution.
References CreateRHS(), and rhs_.
Referenced by GetLinearProblem().
Epetra_MultiVector * Trilinos_Util::CrsMatrixGallery::GetStartingSolution | ( | void | ) |
Returns a pointer to the starting solution (typically, for HB problems).
Returns a pointer to the starting solution. This is typically used while reading a HB problem. However, the user can set a starting solution using Set("starting solution", "value"). Value can be
References CreateStartingSolution(), and StartingSolution_.
Referenced by GetLinearProblem().
void Trilinos_Util::CrsMatrixGallery::PrintMatrixAndVectors | ( | ) |
void Trilinos_Util::CrsMatrixGallery::PrintMatrixAndVectors | ( | ostream & | os | ) |
void Trilinos_Util::CrsMatrixGallery::ReadMatrix | ( | void | ) | [protected] |
References comm_, Copy, CreateMap(), ErrorMsg, ExactSolution_, FileName_, map_, MapType_, matrix_, MyGlobalElements_, name_, NumGlobalElements_, NumMyElements_, NumVectors_, OutputMsg, rhs_, StartingSolution_, Trilinos_Util_ReadHb2Epetra(), Trilinos_Util_ReadMatrixMarket2Epetra(), Trilinos_Util_ReadTriples2Epetra(), and verbose_.
Referenced by CreateMatrix().
int Trilinos_Util::CrsMatrixGallery::Set | ( | Trilinos_Util::CommandLineParser & | CLP | ) |
Sets gallery options using values passed from the shell.
References Trilinos_Util_Map::Get(), Trilinos_Util_Map::Has(), and Set().
int Trilinos_Util::CrsMatrixGallery::Set | ( | const string | parameter, | |
const Epetra_Vector & | value | |||
) |
int Trilinos_Util::CrsMatrixGallery::Set | ( | const string | parameter, | |
const double | value | |||
) |
int Trilinos_Util::CrsMatrixGallery::Set | ( | const string | parameter, | |
const string | value | |||
) |
Sets a gallery options using a C++ string .
References comm_, ContiguousMap_, ErrorMsg, ExactSolutionType_, ExpandType_, FileName_, MapType_, name_, RhsType_, StartingSolutionType_, and verbose_.
int Trilinos_Util::CrsMatrixGallery::Set | ( | const string | parameter, | |
const int | value | |||
) |
Sets a gallery options using an interger value.
References comm_, ErrorMsg, map_, mx_, my_, mz_, NumGlobalElements_, NumPDEEqns_, NumVectors_, nx_, ny_, nz_, and verbose_.
Referenced by Set().
void Trilinos_Util::CrsMatrixGallery::SetupCartesianGrid2D | ( | ) | [protected] |
References ErrorMsg, NumGlobalElements_, nx_, and ny_.
Referenced by CreateExactSolution(), CreateMap(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixStretched2d(), CreateMatrixUniFlow2d(), and CreateRHS().
void Trilinos_Util::CrsMatrixGallery::SetupCartesianGrid3D | ( | ) | [protected] |
References ErrorMsg, NumGlobalElements_, nx_, ny_, and nz_.
Referenced by CreateMap(), and CreateMatrixCrossStencil3d().
int Trilinos_Util::CrsMatrixGallery::WriteMatrix | ( | const string & | FileName, | |
const bool | UseSparse = true | |||
) |
void Trilinos_Util::CrsMatrixGallery::ZeroOutData | ( | ) | [protected] |
References a_, alpha_, b_, beta_, c_, ContiguousMap_, conv_, d_, delta_, diff_, e_, epsilon_, ExactSolution_, ExactSolutionType_, ExpandType_, f_, g_, gamma_, LinearProblem_, lx_, ly_, lz_, map_, MapType_, matrix_, mx_, mz_, NumGlobalElements_, NumPDEEqns_, NumVectors_, nx_, ny_, nz_, rhs_, RhsType_, source_, StartingSolution_, StartingSolutionType_, UNDEF, VectorA_, VectorB_, VectorC_, VectorD_, VectorE_, VectorF_, and VectorG_.
Referenced by CrsMatrixGallery(), and ~CrsMatrixGallery().
ostream& operator<< | ( | ostream & | os, | |
const Trilinos_Util::CrsMatrixGallery & | G | |||
) | [friend] |
Print out detailed information about the problem at hand.
double Trilinos_Util::CrsMatrixGallery::a_ [protected] |
Referenced by CreateEye(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil3d(), CreateMatrixDiag(), CreateMatrixHanowa(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1d(), CreateMatrixLaplace2d(), CreateMatrixLaplace3d(), CreateMatrixOnes(), CreateMatrixPei(), CreateMatrixTriDiag(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::alpha_ [protected] |
Referenced by CreateMatrixUniFlow2d(), CreateRHS(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::b_ [protected] |
double Trilinos_Util::CrsMatrixGallery::beta_ [protected] |
Referenced by ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::c_ [protected] |
const Epetra_Comm* Trilinos_Util::CrsMatrixGallery::comm_ [protected] |
bool Trilinos_Util::CrsMatrixGallery::ContiguousMap_ [protected] |
Referenced by CreateMap(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::conv_ [protected] |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), CreateRHS(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::d_ [protected] |
double Trilinos_Util::CrsMatrixGallery::delta_ [protected] |
Referenced by ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::diff_ [protected] |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), CreateRHS(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::e_ [protected] |
double Trilinos_Util::CrsMatrixGallery::epsilon_ [protected] |
Referenced by CreateMatrixStretched2d(), Set(), and ZeroOutData().
string Trilinos_Util::CrsMatrixGallery::ErrorMsg [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateMap(), CreateMatrix(), CreateMatrixCrossStencil3dVector(), CreateMatrixHanowa(), CreateRHS(), CreateStartingSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), CrsMatrixGallery(), GetCartesianCoordinates(), ReadMatrix(), Set(), SetupCartesianGrid2D(), and SetupCartesianGrid3D().
Epetra_MultiVector* Trilinos_Util::CrsMatrixGallery::ExactSolution_ [protected] |
string Trilinos_Util::CrsMatrixGallery::ExactSolutionType_ [protected] |
Referenced by CreateExactSolution(), Trilinos_Util::operator<<(), Set(), and ZeroOutData().
string Trilinos_Util::CrsMatrixGallery::ExpandType_ [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::f_ [protected] |
Referenced by CreateMatrixCrossStencil3d(), CreateMatrixLaplace3d(), Set(), and ZeroOutData().
string Trilinos_Util::CrsMatrixGallery::FileName_ [protected] |
Referenced by ReadMatrix(), and Set().
double Trilinos_Util::CrsMatrixGallery::g_ [protected] |
Referenced by CreateMatrixCrossStencil3d(), CreateMatrixLaplace3d(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::gamma_ [protected] |
Referenced by ZeroOutData().
Epetra_LinearProblem* Trilinos_Util::CrsMatrixGallery::LinearProblem_ [protected] |
Referenced by GetLinearProblem(), ZeroOutData(), and ~CrsMatrixGallery().
double Trilinos_Util::CrsMatrixGallery::lx_ [protected] |
double Trilinos_Util::CrsMatrixGallery::ly_ [protected] |
double Trilinos_Util::CrsMatrixGallery::lz_ [protected] |
Referenced by GetCartesianCoordinates(), Set(), and ZeroOutData().
Epetra_Map* Trilinos_Util::CrsMatrixGallery::map_ [protected] |
Referenced by ComputeDiffBetweenStartingAndExactSolutions(), ComputeResidual(), Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateMap(), CreateMatrix(), CreateMatrixCauchy(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixDiag(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1dNeumann(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixRis(), CreateMatrixStretched2d(), CreateMatrixTriDiag(), CreateMatrixUniFlow2d(), CreateMatrixVander(), CreateRHS(), CreateStartingSolution(), CrsMatrixGallery(), GetCartesianCoordinates(), GetMap(), GetMapRef(), ReadMatrix(), Set(), ZeroOutData(), and ~CrsMatrixGallery().
std::vector<int> Trilinos_Util::CrsMatrixGallery::MapMap_ [protected] |
Referenced by CreateMap().
string Trilinos_Util::CrsMatrixGallery::MapType_ [protected] |
Referenced by CreateMap(), Trilinos_Util::operator<<(), ReadMatrix(), Set(), and ZeroOutData().
Epetra_CrsMatrix* Trilinos_Util::CrsMatrixGallery::matrix_ [protected] |
Referenced by ComputeResidual(), CreateMatrix(), CreateMatrixCauchy(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixDiag(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1dNeumann(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRis(), CreateMatrixStretched2d(), CreateMatrixTriDiag(), CreateMatrixVander(), CreateRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), GetCartesianCoordinates(), GetMatrix(), GetMatrixRef(), Trilinos_Util::operator<<(), PrintMatrixAndVectors(), ReadMatrix(), WriteMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
int Trilinos_Util::CrsMatrixGallery::mx_ [protected] |
Referenced by CreateMap(), Set(), and ZeroOutData().
int Trilinos_Util::CrsMatrixGallery::my_ [protected] |
Referenced by CreateMap(), and Set().
int* Trilinos_Util::CrsMatrixGallery::MyGlobalElements_ [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateMap(), CreateMatrixCauchy(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixDiag(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1dNeumann(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixRis(), CreateMatrixStretched2d(), CreateMatrixTriDiag(), CreateMatrixUniFlow2d(), CreateMatrixVander(), CreateRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), CrsMatrixGallery(), GetCartesianCoordinates(), and ReadMatrix().
int Trilinos_Util::CrsMatrixGallery::mz_ [protected] |
Referenced by CreateMap(), Set(), and ZeroOutData().
string Trilinos_Util::CrsMatrixGallery::name_ [protected] |
Referenced by CreateMap(), CreateMatrix(), GetCartesianCoordinates(), Trilinos_Util::operator<<(), ReadMatrix(), and Set().
int Trilinos_Util::CrsMatrixGallery::NumGlobalElements_ [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateMap(), CreateMatrixCauchy(), CreateMatrixCrossStencil3dVector(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1dNeumann(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRis(), CreateMatrixTriDiag(), CreateMatrixVander(), CrsMatrixGallery(), Trilinos_Util::operator<<(), ReadMatrix(), Set(), SetupCartesianGrid2D(), SetupCartesianGrid3D(), and ZeroOutData().
int Trilinos_Util::CrsMatrixGallery::NumMyElements_ [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateMap(), CreateMatrixCauchy(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixDiag(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1dNeumann(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixRis(), CreateMatrixStretched2d(), CreateMatrixTriDiag(), CreateMatrixUniFlow2d(), CreateMatrixVander(), CreateRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), CrsMatrixGallery(), and ReadMatrix().
int Trilinos_Util::CrsMatrixGallery::NumPDEEqns_ [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), Trilinos_Util::VbrMatrixGallery::GetVbrMatrix(), Trilinos_Util::operator<<(), Set(), and ZeroOutData().
int Trilinos_Util::CrsMatrixGallery::NumVectors_ [protected] |
Referenced by ComputeDiffBetweenStartingAndExactSolutions(), Trilinos_Util::VbrMatrixGallery::ComputeDiffBetweenStartingAndExactSolutionsVbr(), ComputeResidual(), Trilinos_Util::VbrMatrixGallery::ComputeResidualVbr(), CreateExactSolution(), CreateRHS(), CreateStartingSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), ReadMatrix(), Set(), and ZeroOutData().
int Trilinos_Util::CrsMatrixGallery::nx_ [protected] |
Referenced by CreateExactSolution(), CreateMap(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixStretched2d(), CreateMatrixUniFlow2d(), CreateRHS(), GetCartesianCoordinates(), Set(), SetupCartesianGrid2D(), SetupCartesianGrid3D(), and ZeroOutData().
int Trilinos_Util::CrsMatrixGallery::ny_ [protected] |
Referenced by CreateExactSolution(), CreateMap(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixStretched2d(), CreateMatrixUniFlow2d(), CreateRHS(), GetCartesianCoordinates(), Set(), SetupCartesianGrid2D(), SetupCartesianGrid3D(), and ZeroOutData().
int Trilinos_Util::CrsMatrixGallery::nz_ [protected] |
string Trilinos_Util::CrsMatrixGallery::OutputMsg [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateEye(), CreateMap(), CreateMatrix(), CreateMatrixCauchy(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixDiag(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1d(), CreateMatrixLaplace1dNeumann(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixLaplace3d(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixRis(), CreateMatrixStretched2d(), CreateMatrixTriDiag(), CreateMatrixUniFlow2d(), CreateMatrixVander(), CreateRHS(), CreateStartingSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), CrsMatrixGallery(), and ReadMatrix().
Epetra_MultiVector* Trilinos_Util::CrsMatrixGallery::rhs_ [protected] |
string Trilinos_Util::CrsMatrixGallery::RhsType_ [protected] |
Referenced by CreateRHS(), Set(), and ZeroOutData().
double Trilinos_Util::CrsMatrixGallery::source_ [protected] |
Referenced by Set(), and ZeroOutData().
Epetra_MultiVector* Trilinos_Util::CrsMatrixGallery::StartingSolution_ [protected] |
string Trilinos_Util::CrsMatrixGallery::StartingSolutionType_ [protected] |
Referenced by CreateStartingSolution(), Set(), and ZeroOutData().
Epetra_Vector* Trilinos_Util::CrsMatrixGallery::VectorA_ [protected] |
Epetra_Vector * Trilinos_Util::CrsMatrixGallery::VectorB_ [protected] |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), Set(), ZeroOutData(), and ~CrsMatrixGallery().
Epetra_Vector * Trilinos_Util::CrsMatrixGallery::VectorC_ [protected] |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), Set(), ZeroOutData(), and ~CrsMatrixGallery().
Epetra_Vector * Trilinos_Util::CrsMatrixGallery::VectorD_ [protected] |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), Set(), ZeroOutData(), and ~CrsMatrixGallery().
Epetra_Vector * Trilinos_Util::CrsMatrixGallery::VectorE_ [protected] |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), Set(), ZeroOutData(), and ~CrsMatrixGallery().
Epetra_Vector * Trilinos_Util::CrsMatrixGallery::VectorF_ [protected] |
Referenced by Set(), ZeroOutData(), and ~CrsMatrixGallery().
Epetra_Vector * Trilinos_Util::CrsMatrixGallery::VectorG_ [protected] |
Referenced by Set(), ZeroOutData(), and ~CrsMatrixGallery().
bool Trilinos_Util::CrsMatrixGallery::verbose_ [protected] |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateBlockMap(), CreateExactSolution(), CreateEye(), CreateMap(), CreateMatrix(), CreateMatrixCauchy(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixDiag(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1d(), CreateMatrixLaplace1dNeumann(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixLaplace3d(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixRis(), CreateMatrixStretched2d(), CreateMatrixTriDiag(), CreateMatrixUniFlow2d(), CreateMatrixVander(), CreateRHS(), CreateStartingSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrMatrix(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), CrsMatrixGallery(), ReadMatrix(), and Set().