Stokhos Package Browser (Single Doxygen Collection) Version of the Day
|
ModelEvaluator for a linear 2-D diffusion problem. More...
#include <twoD_diffusion_ME.hpp>
Inherits EpetraExt::ModelEvaluator.
Classes | |
struct | MeshPoint |
Public Member Functions | |
twoD_diffusion_ME (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, const Teuchos::RCP< Teuchos::ParameterList > &precParams=Teuchos::null) | |
Constructor. | |
~twoD_diffusion_ME () | |
Destructor. | |
Overridden from EpetraExt::ModelEvaluator . | |
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< Teuchos::ParameterList > | precParams |
Teuchos::RCP< Stokhos::AbstractPreconditionerFactory > | precFactory |
Teuchos::RCP< Epetra_Map > | x_map |
Solution vector map. | |
Teuchos::RCP< Epetra_Import > | importer |
Importer to overlapped distribution. | |
Teuchos::RCP< Epetra_Vector > | x_init |
Initial guess. | |
Teuchos::RCP< Epetra_Map > | p_map |
Parameter vector map. | |
Teuchos::RCP< Epetra_Map > | g_map |
Response vector map. | |
Teuchos::RCP< Epetra_Vector > | p_init |
Initial parameters. | |
Teuchos::RCP< Teuchos::Array< std::string > > | p_names |
Parameter names. | |
Teuchos::RCP< Epetra_CrsGraph > | graph |
Jacobian graph. | |
Teuchos::Array< Teuchos::RCP< Epetra_CrsMatrix > > | A_k |
KL coefficients of operator | |
Teuchos::RCP< Epetra_Vector > | b |
Deterministic RHS. | |
Teuchos::Array< Teuchos::RCP< Epetra_Vector > > | sg_kx_vec_all |
Vectors to store matrix-vector products in SG residual calculation. | |
Teuchos::RCP< Epetra_CrsMatrix > | A |
Matrix to store deterministic operator. | |
Teuchos::Array< double > | point |
Array to store a point for basis evaluation. | |
Teuchos::Array< double > | basis_vals |
Array to store values of basis at a point. | |
Teuchos::RCP< const Epetra_Map > | get_x_map () const |
Return solution vector map. | |
Teuchos::RCP< const Epetra_Map > | get_f_map () const |
Return residual vector map. | |
Teuchos::RCP< const Epetra_Map > | get_p_map (int l) const |
Return parameter vector map. | |
Teuchos::RCP< const Epetra_Map > | get_g_map (int j) const |
Return response function map. | |
Teuchos::RCP< const Teuchos::Array< std::string > > | get_p_names (int l) const |
Return array of parameter names. | |
Teuchos::RCP< const Epetra_Vector > | get_x_init () const |
Return initial solution. | |
Teuchos::RCP< const Epetra_Vector > | get_p_init (int l) const |
Return initial parameters. | |
Teuchos::RCP< Epetra_Operator > | create_W () const |
Create W = alpha*M + beta*J matrix. | |
Teuchos::RCP< EpetraExt::ModelEvaluator::Preconditioner > | create_WPrec () const |
Create preconditioner for W. | |
InArgs | createInArgs () const |
Create InArgs. | |
OutArgs | createOutArgs () const |
Create OutArgs. | |
void | evalModel (const InArgs &inArgs, const OutArgs &outArgs) const |
Evaluate model on InArgs. | |
Teuchos::RCP< Epetra_CrsMatrix > | get_mean () const |
Get mean matrix. | |
template<typename FuncT > | |
void | fillMatrices (const FuncT &func, int sz) |
Fill coefficient matrix given function to evaluate diffusion coefficient. | |
ModelEvaluator for a linear 2-D diffusion problem.
Definition at line 62 of file twoD_diffusion_ME.hpp.
twoD_diffusion_ME::twoD_diffusion_ME | ( | 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, | ||
const Teuchos::RCP< Teuchos::ParameterList > & | precParams = Teuchos::null ) |
Constructor.
Definition at line 162 of file twoD_diffusion_ME.cpp.
twoD_diffusion_ME::~twoD_diffusion_ME | ( | ) |
Destructor.
Definition at line 325 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< const Epetra_Map > twoD_diffusion_ME::get_x_map | ( | ) | const |
Return solution vector map.
Definition at line 334 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< const Epetra_Map > twoD_diffusion_ME::get_f_map | ( | ) | const |
Return residual vector map.
Definition at line 341 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< const Epetra_Map > twoD_diffusion_ME::get_p_map | ( | int | l | ) | const |
Return parameter vector map.
Definition at line 348 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< const Epetra_Map > twoD_diffusion_ME::get_g_map | ( | int | j | ) | const |
Return response function map.
Definition at line 361 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< const Teuchos::Array< std::string > > twoD_diffusion_ME::get_p_names | ( | int | l | ) | const |
Return array of parameter names.
Definition at line 374 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< const Epetra_Vector > twoD_diffusion_ME::get_x_init | ( | ) | const |
Return initial solution.
Definition at line 387 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< const Epetra_Vector > twoD_diffusion_ME::get_p_init | ( | int | l | ) | const |
Return initial parameters.
Definition at line 394 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< Epetra_Operator > twoD_diffusion_ME::create_W | ( | ) | const |
Create W = alpha*M + beta*J matrix.
Definition at line 407 of file twoD_diffusion_ME.cpp.
Teuchos::RCP< EpetraExt::ModelEvaluator::Preconditioner > twoD_diffusion_ME::create_WPrec | ( | ) | const |
Create preconditioner for W.
Definition at line 418 of file twoD_diffusion_ME.cpp.
EpetraExt::ModelEvaluator::InArgs twoD_diffusion_ME::createInArgs | ( | ) | const |
Create InArgs.
Definition at line 431 of file twoD_diffusion_ME.cpp.
EpetraExt::ModelEvaluator::OutArgs twoD_diffusion_ME::createOutArgs | ( | ) | const |
Create OutArgs.
Definition at line 456 of file twoD_diffusion_ME.cpp.
void twoD_diffusion_ME::evalModel | ( | const InArgs & | inArgs, |
const OutArgs & | outArgs ) const |
Evaluate model on InArgs.
Definition at line 483 of file twoD_diffusion_ME.cpp.
|
inline |
Get mean matrix.
Definition at line 121 of file twoD_diffusion_ME.hpp.
|
protected |
Fill coefficient matrix given function to evaluate diffusion coefficient.
Definition at line 194 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 131 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 138 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 139 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 141 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 142 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 143 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 145 of file twoD_diffusion_ME.hpp.
|
protected |
Definition at line 146 of file twoD_diffusion_ME.hpp.
|
protected |
Solution vector map.
Definition at line 149 of file twoD_diffusion_ME.hpp.
|
protected |
Importer to overlapped distribution.
Definition at line 152 of file twoD_diffusion_ME.hpp.
|
protected |
Initial guess.
Definition at line 155 of file twoD_diffusion_ME.hpp.
|
protected |
Parameter vector map.
Definition at line 158 of file twoD_diffusion_ME.hpp.
|
protected |
Response vector map.
Definition at line 161 of file twoD_diffusion_ME.hpp.
|
protected |
Initial parameters.
Definition at line 164 of file twoD_diffusion_ME.hpp.
|
protected |
Parameter names.
Definition at line 167 of file twoD_diffusion_ME.hpp.
|
protected |
Jacobian graph.
Definition at line 170 of file twoD_diffusion_ME.hpp.
|
protected |
KL coefficients of operator
Definition at line 173 of file twoD_diffusion_ME.hpp.
|
protected |
Deterministic RHS.
Definition at line 176 of file twoD_diffusion_ME.hpp.
|
mutableprotected |
Vectors to store matrix-vector products in SG residual calculation.
Definition at line 179 of file twoD_diffusion_ME.hpp.
|
protected |
Matrix to store deterministic operator.
Definition at line 182 of file twoD_diffusion_ME.hpp.
|
mutableprotected |
Array to store a point for basis evaluation.
Definition at line 185 of file twoD_diffusion_ME.hpp.
|
mutableprotected |
Array to store values of basis at a point.
Definition at line 188 of file twoD_diffusion_ME.hpp.