TriUtils
Development
|
#include <Trilinos_Util_CrsMatrixGallery.h>
Public Member Functions | |
CrsMatrixGallery (const std::string name, const Epetra_Comm &comm, bool UseLongLong=false) | |
Triutils_Gallery Constructor. More... | |
CrsMatrixGallery (const std::string name, const Epetra_Map &map) | |
Creates an Triutils_Gallery object using a given map. More... | |
~CrsMatrixGallery () | |
Triutils_Gallery destructor. More... | |
int | Set (const std::string parameter, const int value) |
Sets a gallery options using an interger value. More... | |
int | Set (const std::string parameter, const std::string value) |
Sets a gallery options using a C++ string . More... | |
int | Set (const std::string parameter, const double value) |
Sets a gallery options using an double value. More... | |
int | Set (const std::string parameter, const Epetra_Vector &value) |
Sets a gallery options using an Epetra_Vector. More... | |
int | Set (Trilinos_Util::CommandLineParser &CLP) |
Sets gallery options using values passed from the shell. More... | |
Protected Member Functions | |
template<typename int_type > | |
int_type *& | MyGlobalElementsPtr () |
template<typename int_type > | |
std::vector< int_type > & | MapMapRef () |
template<> | |
long long *& | MyGlobalElementsPtr () |
template<> | |
std::vector< long long > & | MapMapRef () |
template<> | |
int *& | MyGlobalElementsPtr () |
template<> | |
std::vector< int > & | MapMapRef () |
void | CreateMap () |
Creates a map. More... | |
template<typename int_type > | |
void | TCreateMap () |
void | CreateMatrix () |
Creates the CrdMatrix. More... | |
template<typename int_type > | |
void | TCreateMatrix () |
template<typename int_type > | |
void | TCreateExactSolution () |
Creates the exact solution. More... | |
void | CreateExactSolution () |
void | CreateStartingSolution () |
Creates the starting solution. More... | |
template<typename int_type > | |
void | TCreateRHS () |
Create the RHS corresponding to the desired exact solution. More... | |
void | CreateRHS () |
template<typename int_type > | |
void | CreateEye () |
template<typename int_type > | |
void | CreateMatrixDiag () |
template<typename int_type > | |
void | CreateMatrixTriDiag () |
template<typename int_type > | |
void | CreateMatrixLaplace1d () |
template<typename int_type > | |
void | CreateMatrixLaplace1dNeumann () |
template<typename int_type > | |
void | CreateMatrixCrossStencil2d () |
template<typename int_type > | |
void | CreateMatrixCrossStencil2dVector () |
template<typename int_type > | |
void | CreateMatrixLaplace2d () |
template<typename int_type > | |
void | CreateMatrixLaplace2d_BC () |
template<typename int_type > | |
void | CreateMatrixLaplace2d_9pt () |
template<typename int_type > | |
void | CreateMatrixStretched2d () |
template<typename int_type > | |
void | CreateMatrixRecirc2d () |
template<typename int_type > | |
void | CreateMatrixRecirc2dDivFree () |
template<typename int_type > | |
void | CreateMatrixLaplace2dNeumann () |
template<typename int_type > | |
void | CreateMatrixUniFlow2d () |
template<typename int_type > | |
void | CreateMatrixLaplace3d () |
template<typename int_type > | |
void | CreateMatrixCrossStencil3d () |
template<typename int_type > | |
void | CreateMatrixCrossStencil3dVector () |
template<typename int_type > | |
void | CreateMatrixLehmer () |
template<typename int_type > | |
void | CreateMatrixMinij () |
template<typename int_type > | |
void | CreateMatrixRis () |
template<typename int_type > | |
void | CreateMatrixHilbert () |
template<typename int_type > | |
void | CreateMatrixJordblock () |
template<typename int_type > | |
void | CreateMatrixCauchy () |
template<typename int_type > | |
void | CreateMatrixFiedler () |
template<typename int_type > | |
void | CreateMatrixHanowa () |
template<typename int_type > | |
void | CreateMatrixKMS () |
template<typename int_type > | |
void | CreateMatrixParter () |
template<typename int_type > | |
void | CreateMatrixPei () |
template<typename int_type > | |
void | CreateMatrixOnes () |
template<typename int_type > | |
void | CreateMatrixVander () |
template<typename int_type > | |
void | TReadMatrix () |
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) |
template<typename int_type > | |
void | TGetCartesianCoordinates (double *&x, double *&y, double *&z) |
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_ |
std::string | name_ |
long long | NumGlobalElements_ |
int | NumMyElements_ |
int * | MyGlobalElements_int_ |
std::vector< int > | MapMap_int_ |
long long * | MyGlobalElements_LL_ |
std::vector< long long > | MapMap_LL_ |
std::string | MapType_ |
bool | ContiguousMap_ |
std::string | ExactSolutionType_ |
std::string | StartingSolutionType_ |
std::string | ExpandType_ |
std::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_ |
std::string | FileName_ |
std::string | ErrorMsg |
std::string | OutputMsg |
bool | verbose_ |
bool | UseLongLong_ |
Epetra_CrsMatrix * | GetMatrix () |
Returns a pointer to the CrsMatrix. More... | |
Epetra_CrsMatrix & | GetMatrixRef () |
Epetra_MultiVector * | GetExactSolution () |
Returns a pointer to the exact solution. More... | |
Epetra_MultiVector * | GetStartingSolution () |
Returns a pointer to the starting solution (typically, for HB problems). More... | |
Epetra_MultiVector * | GetRHS () |
Returns a pointer to the rhs corresponding to the selected exact solution. More... | |
const Epetra_Map * | GetMap () |
Returns a pointer the internally stored Map. More... | |
const Epetra_Map & | GetMapRef () |
Epetra_LinearProblem * | GetLinearProblem () |
Returns a pointer to Epetra_LinearProblem. More... | |
void | ComputeResidual (double *residual) |
Computes the 2-norm of the residual. More... | |
void | ComputeDiffBetweenStartingAndExactSolutions (double *residual) |
Computes the 2-norm of the difference between the starting solution and the exact solution. More... | |
void | PrintMatrixAndVectors (std::ostream &os) |
Print out matrix and vectors. More... | |
void | PrintMatrixAndVectors () |
void | GetCartesianCoordinates (double *&x, double *&y, double *&z) |
Get pointers to double vectors containing coordinates of points. More... | |
int | WriteMatrix (const std::string &FileName, const bool UseSparse=true) |
Print matrix on file in MATLAB format. More... | |
std::ostream & | operator<< (std::ostream &os, const Trilinos_Util::CrsMatrixGallery &G) |
Print out detailed information about the problem at hand. More... | |
Trilinos_Util::CrsMatrixGallery::CrsMatrixGallery | ( | const std::string | name, |
const Epetra_Comm & | comm, | ||
bool | UseLongLong = false |
||
) |
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.
An example of program using this class is reported below.
Class CommandLineParser can be used as well. In this case, one may decide to use the following:
In | comm - Epetra communicator |
Trilinos_Util::CrsMatrixGallery::CrsMatrixGallery | ( | const std::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 |
Trilinos_Util::CrsMatrixGallery::~CrsMatrixGallery | ( | void | ) |
Triutils_Gallery destructor.
References a_, alpha_, b_, c_, comm_, ContiguousMap_, conv_, d_, diff_, e_, epsilon_, ErrorMsg, ExactSolution_, ExactSolutionType_, ExpandType_, f_, FileName_, g_, LinearProblem_, lx_, ly_, lz_, map_, MapType_, matrix_, mx_, my_, mz_, name_, NumGlobalElements_, NumPDEEqns_, NumVectors_, nx_, ny_, nz_, rhs_, RhsType_, Set(), source_, StartingSolution_, StartingSolutionType_, VectorA_, VectorB_, VectorC_, VectorD_, VectorE_, VectorF_, VectorG_, verbose_, 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_.
|
protected |
References UseLongLong_.
Referenced by Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), GetExactSolution(), and TCreateRHS().
|
protected |
|
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 UseLongLong_.
Referenced by CreateStartingSolution(), GetMap(), GetMapRef(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateExactSolution(), TCreateMatrix(), TCreateRHS(), TGetCartesianCoordinates(), and TReadMatrix().
|
protected |
Creates the CrdMatrix.
References UseLongLong_.
Referenced by GetMatrix(), GetMatrixRef(), TCreateRHS(), Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), and WriteMatrix().
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
|
protected |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
|
protected |
|
protected |
References Copy, ErrorMsg, GetNeighboursCartesian3d(), map_, matrix_, NumGlobalElements_, NumMyElements_, nx_, ny_, nz_, OutputMsg, TEUCHOS_TEST_FOR_EXCEPT_MSG, and verbose_.
|
protected |
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
References a_, Copy, ErrorMsg, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, TEUCHOS_TEST_FOR_EXCEPT_MSG, UNDEF, and verbose_.
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
References a_, Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, VectorA_, and verbose_.
|
protected |
References a_, Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, and verbose_.
|
protected |
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
|
protected |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
|
protected |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
|
protected |
References Copy, GetNeighboursCartesian2d(), map_, matrix_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), and verbose_.
|
protected |
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
References a_, Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, UNDEF, and verbose_.
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
References a_, Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
|
protected |
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, and verbose_.
|
protected |
References Copy, epsilon_, GetNeighboursCartesian2d(), map_, matrix_, NumMyElements_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), UNDEF, and verbose_.
|
protected |
|
protected |
|
protected |
References Copy, map_, matrix_, NumGlobalElements_, NumMyElements_, OutputMsg, VectorA_, and verbose_.
|
protected |
References UseLongLong_.
Referenced by ComputeDiffBetweenStartingAndExactSolutions(), ComputeResidual(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), and GetRHS().
|
protected |
Creates the starting solution.
References CreateMap(), ErrorMsg, map_, NumVectors_, OutputMsg, StartingSolution_, StartingSolutionType_, TEUCHOS_TEST_FOR_EXCEPT_MSG, and verbose_.
Referenced by Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), and GetStartingSolution().
|
protected |
Referenced by TCreateExactSolution(), and TCreateRHS().
|
protected |
void Trilinos_Util::CrsMatrixGallery::GetCartesianCoordinates | ( | double *& | x, |
double *& | y, | ||
double *& | z | ||
) |
Get pointers to double vectors containing coordinates of points.
References UseLongLong_.
Referenced by TGetCartesianCoordinates().
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 | ) |
Returns a pointer the internally stored Map.
References CreateMap(), and map_.
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_.
|
protected |
|
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().
|
protected |
|
inlineprotected |
References MapMap_LL_.
|
inlineprotected |
References MapMap_int_.
|
protected |
|
inlineprotected |
References MyGlobalElements_LL_.
|
inlineprotected |
References MyGlobalElements_int_.
void Trilinos_Util::CrsMatrixGallery::PrintMatrixAndVectors | ( | std::ostream & | os | ) |
Print out matrix and vectors.
void Trilinos_Util::CrsMatrixGallery::PrintMatrixAndVectors | ( | ) |
int Trilinos_Util::CrsMatrixGallery::Set | ( | const std::string | parameter, |
const int | value | ||
) |
Sets a gallery options using an interger value.
Referenced by Set(), and ~CrsMatrixGallery().
int Trilinos_Util::CrsMatrixGallery::Set | ( | const std::string | parameter, |
const std::string | value | ||
) |
Sets a gallery options using a C++ string .
int Trilinos_Util::CrsMatrixGallery::Set | ( | const std::string | parameter, |
const double | value | ||
) |
Sets a gallery options using an double value.
int Trilinos_Util::CrsMatrixGallery::Set | ( | const std::string | parameter, |
const Epetra_Vector & | value | ||
) |
Sets a gallery options using an Epetra_Vector.
Sets a gallery options using an Epetra_Vector. The Epetra_Vector is copied into internal structures, and freed by the destructor.
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().
|
protected |
References ErrorMsg, NumGlobalElements_, nx_, ny_, and TEUCHOS_TEST_FOR_EXCEPT_MSG.
Referenced by CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixStretched2d(), CreateMatrixUniFlow2d(), TCreateExactSolution(), TCreateMap(), and TCreateRHS().
|
protected |
References ErrorMsg, NumGlobalElements_, nx_, ny_, nz_, and TEUCHOS_TEST_FOR_EXCEPT_MSG.
Referenced by CreateMatrixCrossStencil3d(), and TCreateMap().
|
protected |
Creates the exact solution.
References CreateMap(), ErrorMsg, ExactSolQuadXY(), ExactSolution_, ExactSolutionType_, lx_, ly_, map_, NumGlobalElements_, NumMyElements_, NumVectors_, nx_, ny_, OutputMsg, SetupCartesianGrid2D(), TEUCHOS_TEST_FOR_EXCEPT_MSG, and verbose_.
|
protected |
References comm_, ContiguousMap_, ErrorMsg, map_, MapType_, mx_, my_, mz_, name_, NumGlobalElements_, NumMyElements_, nx_, ny_, nz_, OutputMsg, SetupCartesianGrid2D(), SetupCartesianGrid3D(), TEUCHOS_TEST_FOR_EXCEPT_MSG, and verbose_.
|
protected |
References comm_, CreateMap(), ErrorMsg, map_, matrix_, name_, OutputMsg, TEUCHOS_TEST_FOR_EXCEPT_MSG, and verbose_.
|
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_, NumMyElements_, NumVectors_, nx_, ny_, OutputMsg, rhs_, RhsType_, SetupCartesianGrid2D(), TEUCHOS_TEST_FOR_EXCEPT_MSG, UNDEF, and verbose_.
|
protected |
References CreateMap(), ErrorMsg, GetCartesianCoordinates(), lx_, ly_, lz_, map_, matrix_, name_, nx_, ny_, nz_, and TEUCHOS_TEST_FOR_EXCEPT_MSG.
|
protected |
References comm_, Copy, CreateMap(), ErrorMsg, ExactSolution_, FileName_, map_, MapType_, matrix_, name_, NumGlobalElements_, NumMyElements_, NumVectors_, OutputMsg, rhs_, StartingSolution_, TEUCHOS_ASSERT, TEUCHOS_TEST_FOR_EXCEPT_MSG, Trilinos_Util_ReadHb2Epetra(), Trilinos_Util_ReadHb2Epetra64(), Trilinos_Util_ReadMatrixMarket2Epetra(), Trilinos_Util_ReadMatrixMarket2Epetra64(), Trilinos_Util_ReadTriples2Epetra(), Trilinos_Util_ReadTriples2Epetra64(), UseLongLong_, and verbose_.
int Trilinos_Util::CrsMatrixGallery::WriteMatrix | ( | const std::string & | FileName, |
const bool | UseSparse = true |
||
) |
Print matrix on file in MATLAB format.
References comm_, CreateMatrix(), and matrix_.
|
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().
|
friend |
Print out detailed information about the problem at hand.
|
protected |
Referenced by CreateEye(), CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil3d(), CreateMatrixDiag(), CreateMatrixHanowa(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1d(), CreateMatrixLaplace2d(), CreateMatrixLaplace3d(), CreateMatrixOnes(), CreateMatrixPei(), CreateMatrixTriDiag(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixUniFlow2d(), TCreateRHS(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
|
protected |
Referenced by ZeroOutData().
|
protected |
|
protected |
Referenced by Trilinos_Util::VbrMatrixGallery::ComputeDiffBetweenStartingAndExactSolutionsVbr(), Trilinos_Util::operator<<(), PrintMatrixAndVectors(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateMap(), TCreateMatrix(), TCreateRHS(), TReadMatrix(), WriteMatrix(), and ~CrsMatrixGallery().
|
protected |
Referenced by TCreateMap(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
|
protected |
|
protected |
Referenced by ZeroOutData().
|
protected |
|
protected |
|
protected |
Referenced by CreateMatrixStretched2d(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixCrossStencil3dVector(), CreateMatrixHanowa(), CreateStartingSolution(), SetupCartesianGrid2D(), SetupCartesianGrid3D(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateExactSolution(), TCreateMap(), TCreateMatrix(), TCreateRHS(), Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), TGetCartesianCoordinates(), TReadMatrix(), and ~CrsMatrixGallery().
|
protected |
|
protected |
Referenced by Trilinos_Util::operator<<(), TCreateExactSolution(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixCrossStencil3d(), CreateMatrixLaplace3d(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by TReadMatrix(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixCrossStencil3d(), CreateMatrixLaplace3d(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by ZeroOutData().
|
protected |
Referenced by GetLinearProblem(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
|
protected |
|
protected |
Referenced by TGetCartesianCoordinates(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by ComputeDiffBetweenStartingAndExactSolutions(), ComputeResidual(), 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(), CreateStartingSolution(), GetMap(), GetMapRef(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateExactSolution(), TCreateMap(), TCreateMatrix(), TCreateRHS(), TGetCartesianCoordinates(), TReadMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by MapMapRef().
|
protected |
Referenced by MapMapRef().
|
protected |
Referenced by Trilinos_Util::operator<<(), TCreateMap(), TReadMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by ComputeResidual(), 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(), GetMatrix(), GetMatrixRef(), Trilinos_Util::operator<<(), PrintMatrixAndVectors(), TCreateMatrix(), TCreateRHS(), Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), TGetCartesianCoordinates(), TReadMatrix(), WriteMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by TCreateMap(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by TCreateMap(), and ~CrsMatrixGallery().
|
protected |
Referenced by MyGlobalElementsPtr().
|
protected |
Referenced by MyGlobalElementsPtr().
|
protected |
Referenced by TCreateMap(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by Trilinos_Util::operator<<(), TCreateMap(), TCreateMatrix(), TGetCartesianCoordinates(), TReadMatrix(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixCauchy(), CreateMatrixCrossStencil3dVector(), CreateMatrixFiedler(), CreateMatrixHanowa(), CreateMatrixHilbert(), CreateMatrixJordblock(), CreateMatrixKMS(), CreateMatrixLaplace1dNeumann(), CreateMatrixLehmer(), CreateMatrixMinij(), CreateMatrixOnes(), CreateMatrixParter(), CreateMatrixPei(), CreateMatrixRis(), CreateMatrixTriDiag(), CreateMatrixVander(), Trilinos_Util::operator<<(), SetupCartesianGrid2D(), SetupCartesianGrid3D(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateExactSolution(), TCreateMap(), TReadMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by 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(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateExactSolution(), TCreateMap(), TCreateRHS(), Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), and TReadMatrix().
|
protected |
Referenced by Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), Trilinos_Util::VbrMatrixGallery::GetVbrMatrix(), Trilinos_Util::operator<<(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by ComputeDiffBetweenStartingAndExactSolutions(), Trilinos_Util::VbrMatrixGallery::ComputeDiffBetweenStartingAndExactSolutionsVbr(), ComputeResidual(), Trilinos_Util::VbrMatrixGallery::ComputeResidualVbr(), CreateStartingSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), TCreateExactSolution(), TCreateRHS(), TReadMatrix(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixStretched2d(), CreateMatrixUniFlow2d(), SetupCartesianGrid2D(), SetupCartesianGrid3D(), TCreateExactSolution(), TCreateMap(), TCreateRHS(), TGetCartesianCoordinates(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixCrossStencil2d(), CreateMatrixCrossStencil2dVector(), CreateMatrixCrossStencil3d(), CreateMatrixCrossStencil3dVector(), CreateMatrixLaplace2d(), CreateMatrixLaplace2d_9pt(), CreateMatrixLaplace2d_BC(), CreateMatrixLaplace2dNeumann(), CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixStretched2d(), CreateMatrixUniFlow2d(), SetupCartesianGrid2D(), SetupCartesianGrid3D(), TCreateExactSolution(), TCreateMap(), TCreateRHS(), TGetCartesianCoordinates(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
|
protected |
Referenced by CreateEye(), 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(), CreateStartingSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateExactSolution(), TCreateMap(), TCreateMatrix(), TCreateRHS(), Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), and TReadMatrix().
|
protected |
|
protected |
Referenced by TCreateRHS(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
|
protected |
Referenced by CreateStartingSolution(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
|
protected |
|
protected |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateMatrixRecirc2d(), CreateMatrixRecirc2dDivFree(), CreateMatrixUniFlow2d(), ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by ZeroOutData(), and ~CrsMatrixGallery().
|
protected |
Referenced by CreateEye(), 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(), CreateStartingSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrExactSolution(), Trilinos_Util::VbrMatrixGallery::CreateVbrRHS(), Trilinos_Util::VbrMatrixGallery::CreateVbrStartingSolution(), Trilinos_Util::VbrMatrixGallery::TCreateBlockMap(), TCreateExactSolution(), TCreateMap(), TCreateMatrix(), TCreateRHS(), Trilinos_Util::VbrMatrixGallery::TCreateVbrMatrix(), TReadMatrix(), and ~CrsMatrixGallery().