Stokhos Package Browser (Single Doxygen Collection)
Version of the Day
|
A linear 2-D diffusion problem. More...
#include <twoD_diffusion_problem.hpp>
Classes | |
struct | KL_Diffusion_Func |
struct | LogNormal_Diffusion_Func |
struct | MeshPoint |
Public Types | |
typedef Tpetra::Map< LocalOrdinal, GlobalOrdinal, Node > | Tpetra_Map |
typedef Tpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Tpetra_Vector |
typedef Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Tpetra_Operator |
typedef Tpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Tpetra_CrsMatrix |
typedef Tpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node > | Tpetra_CrsGraph |
typedef Tpetra::Import< LocalOrdinal, GlobalOrdinal, Node > | Tpetra_Import |
Public Member Functions | |
twoD_diffusion_problem (const Teuchos::RCP< const Epetra_Comm > &comm, int n, int d, double s=0.1, double mu=0.2, const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > &basis=Teuchos::null, bool log_normal=false, bool eliminate_bcs=false) | |
Constructor. More... | |
Teuchos::RCP< Epetra_CrsMatrix > | get_mean () const |
Get mean matrix. More... | |
twoD_diffusion_problem (const Teuchos::RCP< const Teuchos::Comm< int > > &comm, LocalOrdinal n, LocalOrdinal d, BasisScalar s=0.1, BasisScalar mu=0.2, bool log_normal=false, bool eliminate_bcs=false) | |
Constructor. More... | |
Protected Member Functions | |
template<typename FuncT > | |
void | fillMatrices (const FuncT &func, int sz) |
Fill coefficient matrix given function to evaluate diffusion coefficient. More... | |
void | compute_A (const Epetra_Vector &p) |
Compute A matrix. More... | |
template<typename FuncT > | |
void | computeA (const FuncT &func, const Tpetra_Vector &p, Tpetra_CrsMatrix &jac) |
Fill coefficient matrix given function to evaluate diffusion coefficient. More... | |
Protected Attributes | |
double | h |
Teuchos::Array< MeshPoint > | mesh |
Teuchos::Array< int > | bcIndices |
Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > | basis |
bool | log_normal |
bool | eliminate_bcs |
Teuchos::RCP< Epetra_Map > | x_map |
Solution vector map. More... | |
Teuchos::RCP< Epetra_Import > | importer |
Importer to overlapped distribution. More... | |
Teuchos::RCP< Epetra_Vector > | x_init |
Initial guess. More... | |
Teuchos::RCP< Epetra_Map > | p_map |
Parameter vector map. More... | |
Teuchos::RCP< Epetra_Map > | g_map |
Response vector map. More... | |
Teuchos::RCP< Epetra_Vector > | p_init |
Initial parameters. More... | |
Teuchos::RCP< Teuchos::Array< std::string > > | p_names |
Parameter names. More... | |
Teuchos::RCP< Epetra_CrsGraph > | graph |
Jacobian graph. More... | |
Teuchos::Array< Teuchos::RCP< Epetra_CrsMatrix > > | A_k |
KL coefficients of operator. More... | |
Teuchos::RCP< Epetra_Vector > | b |
Deterministic RHS. More... | |
Teuchos::Array< Teuchos::RCP< Epetra_Vector > > | sg_kx_vec_all |
Vectors to store matrix-vector products in SG residual calculation. More... | |
Teuchos::RCP< Epetra_CrsMatrix > | A |
Matrix to store deterministic operator. More... | |
Teuchos::Array< double > | point |
Array to store a point for basis evaluation. More... | |
Teuchos::Array< double > | basis_vals |
Array to store values of basis at a point. More... | |
MeshScalar | h |
Teuchos::Array< GlobalOrdinal > | bcIndices |
Teuchos::RCP< const Tpetra_Map > | x_map |
Solution vector map. More... | |
Teuchos::RCP< Tpetra_Import > | importer |
Importer to overlapped distribution. More... | |
Teuchos::RCP< Tpetra_Vector > | x_init |
Initial guess. More... | |
Teuchos::RCP< const Tpetra_Map > | p_map |
Parameter vector map. More... | |
Teuchos::RCP< const Tpetra_Map > | g_map |
Response vector map. More... | |
Teuchos::RCP< Tpetra_Vector > | p_init |
Initial parameters. More... | |
Teuchos::RCP< Tpetra_CrsGraph > | graph |
Jacobian graph. More... | |
Teuchos::RCP< Tpetra_Vector > | b |
RHS. More... | |
Teuchos::RCP< Tpetra_CrsMatrix > | A |
Matrix to store operator. More... | |
Teuchos::RCP< KL_Diffusion_Func > | klFunc |
Teuchos::RCP< LogNormal_Diffusion_Func< KL_Diffusion_Func > > | lnFunc |
Overridden from EpetraExt::ModelEvaluator . | |
Teuchos::RCP< const Epetra_Map > | get_x_map () const |
Return solution vector map. More... | |
Teuchos::RCP< const Epetra_Map > | get_f_map () const |
Return residual vector map. More... | |
Teuchos::RCP< const Epetra_Map > | get_p_map (int l) const |
Return parameter vector map. More... | |
Teuchos::RCP< const Epetra_Map > | get_g_map (int j) const |
Return response function map. More... | |
Teuchos::RCP< const Teuchos::Array< std::string > > | get_p_names (int l) const |
Return array of parameter names. More... | |
Teuchos::RCP< const Epetra_Vector > | get_x_init () const |
Return initial solution. More... | |
Teuchos::RCP< const Epetra_Vector > | get_p_init (int l) const |
Return initial parameters. More... | |
Teuchos::RCP< Epetra_Operator > | create_W () const |
Create W = alpha*M + beta*J matrix. More... | |
void | computeResidual (const Epetra_Vector &x, const Epetra_Vector &p, Epetra_Vector &f) |
Compute residual. More... | |
void | computeJacobian (const Epetra_Vector &x, const Epetra_Vector &p, Epetra_Operator &J) |
Compute Jacobian. More... | |
void | computeResponse (const Epetra_Vector &x, const Epetra_Vector &p, Epetra_Vector &g) |
Compute response. More... | |
void | computeSGResidual (const Stokhos::EpetraVectorOrthogPoly &x_sg, const Stokhos::EpetraVectorOrthogPoly &p_sg, Stokhos::OrthogPolyExpansion< int, double > &expn, Stokhos::EpetraVectorOrthogPoly &f_sg) |
Compute SG residual. More... | |
void | computeSGJacobian (const Stokhos::EpetraVectorOrthogPoly &x_sg, const Stokhos::EpetraVectorOrthogPoly &p_sg, Stokhos::EpetraOperatorOrthogPoly &J_sg) |
Compute Jacobian. More... | |
void | computeSGResponse (const Stokhos::EpetraVectorOrthogPoly &x_sg, const Stokhos::EpetraVectorOrthogPoly &p_sg, Stokhos::EpetraVectorOrthogPoly &g_sg) |
Compute SG response. More... | |
Teuchos::RCP< const Tpetra_Map > | get_x_map () const |
Return solution vector map. More... | |
Teuchos::RCP< const Tpetra_Map > | get_f_map () const |
Return residual vector map. More... | |
Teuchos::RCP< const Tpetra_Map > | get_p_map (LocalOrdinal l) const |
Return parameter vector map. More... | |
Teuchos::RCP< const Tpetra_Map > | get_g_map (LocalOrdinal j) const |
Return response function map. More... | |
Teuchos::RCP< const Teuchos::Array< std::string > > | get_p_names (LocalOrdinal l) const |
Return array of parameter names. More... | |
Teuchos::RCP< const Tpetra_Vector > | get_x_init () const |
Return initial solution. More... | |
Teuchos::RCP< const Tpetra_Vector > | get_p_init (LocalOrdinal l) const |
Return initial parameters. More... | |
Teuchos::RCP< Tpetra_CrsMatrix > | create_W () const |
Create W = alpha*M + beta*J matrix. More... | |
void | computeResidual (const Tpetra_Vector &x, const Tpetra_Vector &p, Tpetra_Vector &f) |
Compute residual. More... | |
void | computeJacobian (const Tpetra_Vector &x, const Tpetra_Vector &p, Tpetra_CrsMatrix &J) |
Compute Jacobian. More... | |
void | computeResponse (const Tpetra_Vector &x, const Tpetra_Vector &p, Tpetra_Vector &g) |
Compute response. More... | |
A linear 2-D diffusion problem.
Definition at line 58 of file twoD_diffusion_problem.hpp.
typedef Tpetra::Map<LocalOrdinal,GlobalOrdinal,Node> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Map |
Definition at line 69 of file twoD_diffusion_problem_tpetra.hpp.
typedef Tpetra::Vector<Scalar,LocalOrdinal,GlobalOrdinal,Node> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Vector |
Definition at line 70 of file twoD_diffusion_problem_tpetra.hpp.
typedef Tpetra::Operator<Scalar,LocalOrdinal,GlobalOrdinal,Node> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Operator |
Definition at line 71 of file twoD_diffusion_problem_tpetra.hpp.
typedef Tpetra::CrsMatrix<Scalar,LocalOrdinal,GlobalOrdinal,Node> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_CrsMatrix |
Definition at line 72 of file twoD_diffusion_problem_tpetra.hpp.
typedef Tpetra::CrsGraph<LocalOrdinal,GlobalOrdinal,Node> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_CrsGraph |
Definition at line 73 of file twoD_diffusion_problem_tpetra.hpp.
typedef Tpetra::Import<LocalOrdinal,GlobalOrdinal,Node> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Import |
Definition at line 74 of file twoD_diffusion_problem_tpetra.hpp.
twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::twoD_diffusion_problem | ( | const Teuchos::RCP< const Epetra_Comm > & | comm, |
int | n, | ||
int | d, | ||
double | s = 0.1 , |
||
double | mu = 0.2 , |
||
const Teuchos::RCP< const Stokhos::OrthogPolyBasis< int, double > > & | basis = Teuchos::null , |
||
bool | log_normal = false , |
||
bool | eliminate_bcs = false |
||
) |
Constructor.
Definition at line 160 of file twoD_diffusion_problem.cpp.
twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::twoD_diffusion_problem | ( | const Teuchos::RCP< const Teuchos::Comm< int > > & | comm, |
LocalOrdinal | n, | ||
LocalOrdinal | d, | ||
BasisScalar | s = 0.1 , |
||
BasisScalar | mu = 0.2 , |
||
bool | log_normal = false , |
||
bool | eliminate_bcs = false |
||
) |
Constructor.
Definition at line 46 of file twoD_diffusion_problem_tpetra_def.hpp.
Teuchos::RCP< const typename twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Map > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_x_map | ( | ) | const |
Return solution vector map.
Definition at line 314 of file twoD_diffusion_problem.cpp.
Teuchos::RCP< const typename twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Map > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_f_map | ( | ) | const |
Return residual vector map.
Definition at line 321 of file twoD_diffusion_problem.cpp.
Teuchos::RCP< const typename twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Map > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_p_map | ( | int | l | ) | const |
Return parameter vector map.
Definition at line 328 of file twoD_diffusion_problem.cpp.
Teuchos::RCP< const typename twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Map > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_g_map | ( | int | j | ) | const |
Return response function map.
Definition at line 341 of file twoD_diffusion_problem.cpp.
Teuchos::RCP< const Teuchos::Array< std::string > > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_p_names | ( | int | l | ) | const |
Return array of parameter names.
Definition at line 354 of file twoD_diffusion_problem.cpp.
Teuchos::RCP< const typename twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Vector > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_x_init | ( | ) | const |
Return initial solution.
Definition at line 367 of file twoD_diffusion_problem.cpp.
Teuchos::RCP< const typename twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_Vector > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_p_init | ( | int | l | ) | const |
Return initial parameters.
Definition at line 374 of file twoD_diffusion_problem.cpp.
Teuchos::RCP< typename twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::Tpetra_CrsMatrix > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::create_W | ( | ) | const |
Create W = alpha*M + beta*J matrix.
Definition at line 387 of file twoD_diffusion_problem.cpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeResidual | ( | const Epetra_Vector & | x, |
const Epetra_Vector & | p, | ||
Epetra_Vector & | f | ||
) |
Compute residual.
Definition at line 398 of file twoD_diffusion_problem.cpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeJacobian | ( | const Epetra_Vector & | x, |
const Epetra_Vector & | p, | ||
Epetra_Operator & | J | ||
) |
Compute Jacobian.
Definition at line 410 of file twoD_diffusion_problem.cpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeResponse | ( | const Epetra_Vector & | x, |
const Epetra_Vector & | p, | ||
Epetra_Vector & | g | ||
) |
Compute response.
Definition at line 424 of file twoD_diffusion_problem.cpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeSGResidual | ( | const Stokhos::EpetraVectorOrthogPoly & | x_sg, |
const Stokhos::EpetraVectorOrthogPoly & | p_sg, | ||
Stokhos::OrthogPolyExpansion< int, double > & | expn, | ||
Stokhos::EpetraVectorOrthogPoly & | f_sg | ||
) |
Compute SG residual.
Definition at line 435 of file twoD_diffusion_problem.cpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeSGJacobian | ( | const Stokhos::EpetraVectorOrthogPoly & | x_sg, |
const Stokhos::EpetraVectorOrthogPoly & | p_sg, | ||
Stokhos::EpetraOperatorOrthogPoly & | J_sg | ||
) |
Compute Jacobian.
Definition at line 478 of file twoD_diffusion_problem.cpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeSGResponse | ( | const Stokhos::EpetraVectorOrthogPoly & | x_sg, |
const Stokhos::EpetraVectorOrthogPoly & | p_sg, | ||
Stokhos::EpetraVectorOrthogPoly & | g_sg | ||
) |
Compute SG response.
Definition at line 493 of file twoD_diffusion_problem.cpp.
|
inline |
Get mean matrix.
Definition at line 132 of file twoD_diffusion_problem.hpp.
|
protected |
Fill coefficient matrix given function to evaluate diffusion coefficient.
Definition at line 507 of file twoD_diffusion_problem.cpp.
|
protected |
Compute A matrix.
Definition at line 570 of file twoD_diffusion_problem.cpp.
Teuchos::RCP<const Tpetra_Map> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_x_map | ( | ) | const |
Return solution vector map.
Teuchos::RCP<const Tpetra_Map> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_f_map | ( | ) | const |
Return residual vector map.
Teuchos::RCP<const Tpetra_Map> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_p_map | ( | LocalOrdinal | l | ) | const |
Return parameter vector map.
Teuchos::RCP<const Tpetra_Map> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_g_map | ( | LocalOrdinal | j | ) | const |
Return response function map.
Teuchos::RCP<const Teuchos::Array<std::string> > twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_p_names | ( | LocalOrdinal | l | ) | const |
Return array of parameter names.
Teuchos::RCP<const Tpetra_Vector> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_x_init | ( | ) | const |
Return initial solution.
Teuchos::RCP<const Tpetra_Vector> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::get_p_init | ( | LocalOrdinal | l | ) | const |
Return initial parameters.
Teuchos::RCP<Tpetra_CrsMatrix> twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::create_W | ( | ) | const |
Create W = alpha*M + beta*J matrix.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeResidual | ( | const Tpetra_Vector & | x, |
const Tpetra_Vector & | p, | ||
Tpetra_Vector & | f | ||
) |
Compute residual.
Definition at line 319 of file twoD_diffusion_problem_tpetra_def.hpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeJacobian | ( | const Tpetra_Vector & | x, |
const Tpetra_Vector & | p, | ||
Tpetra_CrsMatrix & | J | ||
) |
Compute Jacobian.
Definition at line 337 of file twoD_diffusion_problem_tpetra_def.hpp.
void twoD_diffusion_problem< Scalar, MeshScalar, BasisScalar, LocalOrdinal, GlobalOrdinal, Node >::computeResponse | ( | const Tpetra_Vector & | x, |
const Tpetra_Vector & | p, | ||
Tpetra_Vector & | g | ||
) |
Compute response.
Definition at line 352 of file twoD_diffusion_problem_tpetra_def.hpp.
|
protected |
Fill coefficient matrix given function to evaluate diffusion coefficient.
Definition at line 368 of file twoD_diffusion_problem_tpetra_def.hpp.
|
protected |
Definition at line 145 of file twoD_diffusion_problem.hpp.
|
protected |
Definition at line 152 of file twoD_diffusion_problem.hpp.
|
protected |
Definition at line 153 of file twoD_diffusion_problem.hpp.
|
protected |
Definition at line 155 of file twoD_diffusion_problem.hpp.
|
protected |
Definition at line 156 of file twoD_diffusion_problem.hpp.
|
protected |
Definition at line 157 of file twoD_diffusion_problem.hpp.
|
protected |
Solution vector map.
Definition at line 160 of file twoD_diffusion_problem.hpp.
|
protected |
Importer to overlapped distribution.
Definition at line 163 of file twoD_diffusion_problem.hpp.
|
protected |
Initial guess.
Definition at line 166 of file twoD_diffusion_problem.hpp.
|
protected |
Parameter vector map.
Definition at line 169 of file twoD_diffusion_problem.hpp.
|
protected |
Response vector map.
Definition at line 172 of file twoD_diffusion_problem.hpp.
|
protected |
Initial parameters.
Definition at line 175 of file twoD_diffusion_problem.hpp.
|
protected |
Parameter names.
Definition at line 178 of file twoD_diffusion_problem.hpp.
|
protected |
Jacobian graph.
Definition at line 181 of file twoD_diffusion_problem.hpp.
|
protected |
KL coefficients of operator.
Definition at line 184 of file twoD_diffusion_problem.hpp.
|
protected |
Deterministic RHS.
Definition at line 187 of file twoD_diffusion_problem.hpp.
|
mutableprotected |
Vectors to store matrix-vector products in SG residual calculation.
Definition at line 190 of file twoD_diffusion_problem.hpp.
|
protected |
Matrix to store deterministic operator.
Definition at line 193 of file twoD_diffusion_problem.hpp.
|
mutableprotected |
Array to store a point for basis evaluation.
Definition at line 196 of file twoD_diffusion_problem.hpp.
|
mutableprotected |
Array to store values of basis at a point.
Definition at line 199 of file twoD_diffusion_problem.hpp.
|
protected |
Definition at line 139 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Definition at line 147 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Solution vector map.
Definition at line 152 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Importer to overlapped distribution.
Definition at line 155 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Initial guess.
Definition at line 158 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Parameter vector map.
Definition at line 161 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Response vector map.
Definition at line 164 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Initial parameters.
Definition at line 167 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Jacobian graph.
Definition at line 173 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
RHS.
Definition at line 176 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Matrix to store operator.
Definition at line 179 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Definition at line 204 of file twoD_diffusion_problem_tpetra.hpp.
|
protected |
Definition at line 205 of file twoD_diffusion_problem_tpetra.hpp.