Panzer  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Private Member Functions | Private Attributes | List of all members
panzer::ModelEvaluator_Epetra Class Reference

#include <Panzer_ModelEvaluator_Epetra.hpp>

Inheritance diagram for panzer::ModelEvaluator_Epetra:
Inheritance graph
[legend]

Public Member Functions

 ModelEvaluator_Epetra (const Teuchos::RCP< panzer::FieldManagerBuilder > &fmb, const Teuchos::RCP< panzer::ResponseLibrary< panzer::Traits > > &rLibrary, const Teuchos::RCP< panzer::LinearObjFactory< panzer::Traits > > &lof, const std::vector< Teuchos::RCP< Teuchos::Array< std::string > > > &p_names, const std::vector< Teuchos::RCP< Teuchos::Array< double > > > &p_values, const Teuchos::RCP< panzer::GlobalData > &global_data, bool build_transient_support)
 
 ModelEvaluator_Epetra (const Teuchos::RCP< panzer::FieldManagerBuilder > &fmb, const Teuchos::RCP< panzer::ResponseLibrary< panzer::Traits > > &rLibrary, const Teuchos::RCP< panzer::BlockedEpetraLinearObjFactory< panzer::Traits, int > > &lof, const std::vector< Teuchos::RCP< Teuchos::Array< std::string > > > &p_names, const std::vector< Teuchos::RCP< Teuchos::Array< double > > > &p_values, const Teuchos::RCP< panzer::GlobalData > &global_data, bool build_transient_support)
 
void set_t_init (double t)
 Set initial time value. More...
 
Teuchos::RCP
< panzer::ResponseLibrary
< panzer::Traits > > 
getResponseLibrary () const
 Get the response library used by this evaluator. More...
 
void setOneTimeDirichletBeta (const double &beta) const
 
void applyDirichletBCs (const Teuchos::RCP< Thyra::VectorBase< double > > &x, const Teuchos::RCP< Thyra::VectorBase< double > > &f) const
 

Private Member Functions

void initializeEpetraObjs (panzer::BlockedEpetraLinearObjFactory< panzer::Traits, int > &lof)
 
void initializeParameterVector (const std::vector< Teuchos::RCP< Teuchos::Array< std::string > > > &p_names, const std::vector< Teuchos::RCP< Teuchos::Array< double > > > &p_values, const Teuchos::RCP< panzer::ParamLib > &parameter_library)
 
void evalModel_basic (const InArgs &inArgs, const OutArgs &outArgs) const
 for evaluation and handling of normal quantities, x,f,W, etc More...
 
void evalModel_basic_g (AssemblyEngineInArgs ae_inargs, const InArgs &inArgs, const OutArgs &outArgs) const
 
void evalModel_basic_dgdx (AssemblyEngineInArgs ae_inargs, const InArgs &inArgs, const OutArgs &outArgs) const
 
void evalModel_basic_dfdp (AssemblyEngineInArgs ae_inargs, const InArgs &inArgs, const OutArgs &outArgs) const
 
bool required_basic_g (const OutArgs &outArgs) const
 Are their required responses in the out args? g and DgDx. More...
 
bool required_basic_dgdx (const OutArgs &outArgs) const
 Are their required responses in the out args? DgDx. More...
 
bool required_basic_dfdp (const OutArgs &outArgs) const
 Are derivatives of the residual with respect to the parameters in the out args? DfDp. More...
 
void copyEpetraIntoThyra (const Epetra_MultiVector &x, const Teuchos::Ptr< Thyra::VectorBase< double > > &thyraVec) const
 
void copyThyraIntoEpetra (const Thyra::VectorBase< double > &thyraVec, Epetra_MultiVector &x) const
 

Private Attributes

Teuchos::RCP< const Epetra_Mapmap_x_
 
Teuchos::RCP< Epetra_Vectorx0_
 
Teuchos::RCP< Epetra_Vectorx_dot_init_
 
double t_init_
 
Teuchos::RCP< Epetra_Vectordummy_f_
 
Teuchos::RCP
< panzer::FieldManagerBuilder
fmb_
 
panzer::AssemblyEngine_TemplateManager
< panzer::Traits
ae_tm_
 
Teuchos::RCP
< panzer::ResponseLibrary
< panzer::Traits > > 
responseLibrary_
 
std::vector< Teuchos::RCP
< const Epetra_Map > > 
g_map_
 
std::vector< std::string > g_names_
 
std::vector< Teuchos::RCP
< Epetra_Map > > 
p_map_
 
std::vector< Teuchos::RCP
< Epetra_Vector > > 
p_init_
 
std::vector< Teuchos::RCP
< Teuchos::Array< std::string > > > 
p_names_
 
Teuchos::Array< panzer::ParamVecparameter_vector_
 
Teuchos::RCP< panzer::GlobalDataglobal_data_
 
bool build_transient_support_
 
std::vector< bool > is_distributed_parameter_
 
std::vector< std::tuple
< std::string, int,
Teuchos::RCP< Epetra_Import >
, Teuchos::RCP< Epetra_Vector > > > 
distributed_parameter_container_
 
Teuchos::RCP
< panzer::LinearObjFactory
< panzer::Traits > > 
lof_
 
Teuchos::RCP< LinearObjContainerghostedContainer_
 
Teuchos::RCP
< Teuchos::AbstractFactory
< Epetra_Operator > > 
epetraOperatorFactory_
 
bool oneTimeDirichletBeta_on_
 
double oneTimeDirichletBeta_
 

Overridden from EpetraExt::ModelEvaluator .

Teuchos::RCP< const Epetra_Mapget_x_map () const
 
Teuchos::RCP< const Epetra_Mapget_f_map () const
 
Teuchos::RCP< const Epetra_Vectorget_x_init () const
 
Teuchos::RCP< const Epetra_Vectorget_x_dot_init () const
 
double get_t_init () const
 
Teuchos::RCP< Epetra_Operatorcreate_W () const
 
Teuchos::RCP< const Epetra_Mapget_p_map (int l) const
 
Teuchos::RCP< const
Teuchos::Array< std::string > > 
get_p_names (int l) const
 
Teuchos::RCP< const Epetra_Vectorget_p_init (int l) const
 
Teuchos::RCP< const Epetra_Mapget_g_map (int l) const
 
InArgs createInArgs () const
 
OutArgs createOutArgs () const
 
void evalModel (const InArgs &inArgs, const OutArgs &outArgs) const
 

Post-Construction methods to add parameters and/or responses

int addDistributedParameter (const std::string name, const Teuchos::RCP< Epetra_Map > &global_map, const Teuchos::RCP< Epetra_Import > &importer, const Teuchos::RCP< Epetra_Vector > &ghosted_vector)
 
template<typename ResponseEvaluatorFactory_BuilderT >
int addResponse (const std::string &responseName, const std::vector< WorksetDescriptor > &wkst_desc, const ResponseEvaluatorFactory_BuilderT &builder)
 
void buildResponses (const std::vector< Teuchos::RCP< panzer::PhysicsBlock > > &physicsBlocks, const panzer::EquationSetFactory &eqset_factory, const panzer::ClosureModelFactory_TemplateManager< panzer::Traits > &cm_factory, const Teuchos::ParameterList &closure_models, const Teuchos::ParameterList &user_data, const bool write_graphviz_file=false, const std::string &graphviz_file_prefix="")
 
void buildResponses (const std::vector< Teuchos::RCP< panzer::PhysicsBlock > > &physicsBlocks, const panzer::ClosureModelFactory_TemplateManager< panzer::Traits > &cm_factory, const Teuchos::ParameterList &closure_models, const Teuchos::ParameterList &user_data, const bool write_graphviz_file=false, const std::string &graphviz_file_prefix="")
 

Additional Inherited Members

- Public Types inherited from EpetraExt::ModelEvaluator
enum  EInArgsMembers
 
enum  EInArgs_p_sg
 
enum  EInArgs_p_mp
 
enum  EEvalType
 
enum  EDerivativeMultiVectorOrientation
 
enum  EDerivativeLinearOp
 
enum  EDerivativeLinearity
 
enum  ERankStatus
 
enum  EOutArgsMembers
 
enum  EOutArgsDfDp
 
enum  EOutArgsDgDx_dot
 
enum  EOutArgsDgDx_dotdot
 
enum  EOutArgsDgDx
 
enum  EOutArgsDgDp
 
enum  EOutArgsDfDp_sg
 
enum  EOutArgs_g_sg
 
enum  EOutArgsDgDx_dot_sg
 
enum  EOutArgsDgDx_dotdot_sg
 
enum  EOutArgsDgDx_sg
 
enum  EOutArgsDgDp_sg
 
enum  EOutArgsDfDp_mp
 
enum  EOutArgs_g_mp
 
enum  EOutArgsDgDx_dot_mp
 
enum  EOutArgsDgDx_dotdot_mp
 
enum  EOutArgsDgDx_mp
 
enum  EOutArgsDgDp_mp
 
typedef Teuchos::RCP< const
Stokhos::ProductEpetraVector > 
mp_const_vector_t
 
typedef Teuchos::RCP< const
Stokhos::ProductEpetraMultiVector > 
mp_const_multivector_t
 
typedef Teuchos::RCP< const
Stokhos::ProductEpetraOperator > 
mp_const_operator_t
 
typedef Teuchos::RCP
< Stokhos::ProductEpetraVector > 
mp_vector_t
 
typedef Teuchos::RCP
< Stokhos::ProductEpetraMultiVector > 
mp_multivector_t
 
typedef Teuchos::RCP
< Stokhos::ProductEpetraOperator > 
mp_operator_t
 
- Static Public Attributes inherited from EpetraExt::ModelEvaluator
static const int NUM_E_IN_ARGS_MEMBERS
 
static const int NUM_E_OUT_ARGS_MEMBERS
 

Detailed Description

Definition at line 74 of file Panzer_ModelEvaluator_Epetra.hpp.

Constructor & Destructor Documentation

panzer::ModelEvaluator_Epetra::ModelEvaluator_Epetra ( const Teuchos::RCP< panzer::FieldManagerBuilder > &  fmb,
const Teuchos::RCP< panzer::ResponseLibrary< panzer::Traits > > &  rLibrary,
const Teuchos::RCP< panzer::LinearObjFactory< panzer::Traits > > &  lof,
const std::vector< Teuchos::RCP< Teuchos::Array< std::string > > > &  p_names,
const std::vector< Teuchos::RCP< Teuchos::Array< double > > > &  p_values,
const Teuchos::RCP< panzer::GlobalData > &  global_data,
bool  build_transient_support 
)

Definition at line 90 of file Panzer_ModelEvaluator_Epetra.cpp.

panzer::ModelEvaluator_Epetra::ModelEvaluator_Epetra ( const Teuchos::RCP< panzer::FieldManagerBuilder > &  fmb,
const Teuchos::RCP< panzer::ResponseLibrary< panzer::Traits > > &  rLibrary,
const Teuchos::RCP< panzer::BlockedEpetraLinearObjFactory< panzer::Traits, int > > &  lof,
const std::vector< Teuchos::RCP< Teuchos::Array< std::string > > > &  p_names,
const std::vector< Teuchos::RCP< Teuchos::Array< double > > > &  p_values,
const Teuchos::RCP< panzer::GlobalData > &  global_data,
bool  build_transient_support 
)

Definition at line 130 of file Panzer_ModelEvaluator_Epetra.cpp.

Member Function Documentation

Teuchos::RCP< const Epetra_Map > panzer::ModelEvaluator_Epetra::get_x_map ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 252 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< const Epetra_Map > panzer::ModelEvaluator_Epetra::get_f_map ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 258 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< const Epetra_Vector > panzer::ModelEvaluator_Epetra::get_x_init ( ) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 264 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< const Epetra_Vector > panzer::ModelEvaluator_Epetra::get_x_dot_init ( ) const

Definition at line 270 of file Panzer_ModelEvaluator_Epetra.cpp.

double panzer::ModelEvaluator_Epetra::get_t_init ( ) const

Definition at line 276 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< Epetra_Operator > panzer::ModelEvaluator_Epetra::create_W ( ) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 282 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< const Epetra_Map > panzer::ModelEvaluator_Epetra::get_p_map ( int  l) const

Definition at line 288 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< const Teuchos::Array< std::string > > panzer::ModelEvaluator_Epetra::get_p_names ( int  l) const

Definition at line 294 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< const Epetra_Vector > panzer::ModelEvaluator_Epetra::get_p_init ( int  l) const

Definition at line 300 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP< const Epetra_Map > panzer::ModelEvaluator_Epetra::get_g_map ( int  l) const

Definition at line 306 of file Panzer_ModelEvaluator_Epetra.cpp.

EpetraExt::ModelEvaluator::InArgs panzer::ModelEvaluator_Epetra::createInArgs ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 312 of file Panzer_ModelEvaluator_Epetra.cpp.

EpetraExt::ModelEvaluator::OutArgs panzer::ModelEvaluator_Epetra::createOutArgs ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 329 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::evalModel ( const InArgs inArgs,
const OutArgs outArgs 
) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 436 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::set_t_init ( double  t)

Set initial time value.

Definition at line 824 of file Panzer_ModelEvaluator_Epetra.cpp.

Teuchos::RCP<panzer::ResponseLibrary<panzer::Traits> > panzer::ModelEvaluator_Epetra::getResponseLibrary ( ) const
inline

Get the response library used by this evaluator.

Definition at line 117 of file Panzer_ModelEvaluator_Epetra.hpp.

int panzer::ModelEvaluator_Epetra::addDistributedParameter ( const std::string  name,
const Teuchos::RCP< Epetra_Map > &  global_map,
const Teuchos::RCP< Epetra_Import > &  importer,
const Teuchos::RCP< Epetra_Vector > &  ghosted_vector 
)
  Add a distributed parameter to the model evaluator

  Distributed parameters are special in that they most likely
  will require a global to ghost call before being used in the
  evaluator.  This function registers the parameter and any
  needed machinery to perform the global to ghost call.

  NOTE: We can't use the LinearObjFactory and
  LinearObjContainers here because those objects require a
  unique global indexer to build.  In general, the distributed
  parameters may NOT be coming from an object that has an
  associated unique global indexer.  An example of this is
  multiphysics coupling.  The parameters will be coming form
  another code that may not have a PDE discretization.
  Generalizing this function to hide the linear algebra type may
  not be possible unless we refactor the linear object support
  or write new wrapper objects.  Also note that Thyra has no
  concept of an import/export object so we can't use Thyra here
  to abstract the objects.

  \param[in] name Name of the distributed parameter
Parameters
[in]global_mapRCP to Epetra_Map used to construct the global parameter vector.
[in]importerRCP to a Epetra_Import object used for the global to ghost. If set to null, then no global to ghost will be performed.
[in]ghosted_vectorRCP to the ghosted vector that is the target of the global to ghost. If set to null, then no global to ghost will be performed.
Returns
The index associated with this parameter for accessing it through the ModelEvaluator interface.

Definition at line 219 of file Panzer_ModelEvaluator_Epetra.cpp.

template<typename ResponseEvaluatorFactory_BuilderT >
int panzer::ModelEvaluator_Epetra::addResponse ( const std::string &  responseName,
const std::vector< WorksetDescriptor > &  wkst_desc,
const ResponseEvaluatorFactory_BuilderT &  builder 
)

Add a response specified by a list of WorksetDescriptor objects. The specifics of the response are specified by the response factory builder.

NOTE: Response factories must use a response of type ResponseMESupportBase. This is how the model evaluator parses and puts responses in the right location. If this condition is violated the evalModel call will fail. Furthermore, this method cannot be called after buildRespones has been called.

Parameters
[in]responseNameName of the response to be added.
[in]wkst_descA vector of descriptors describing the types of elements that make up the response.
[in]builderBuilder that builds the correct response object.
Returns
The index associated with this response for accessing it through the ModelEvaluator interface.

Definition at line 330 of file Panzer_ModelEvaluator_Epetra.hpp.

void panzer::ModelEvaluator_Epetra::buildResponses ( const std::vector< Teuchos::RCP< panzer::PhysicsBlock > > &  physicsBlocks,
const panzer::EquationSetFactory eqset_factory,
const panzer::ClosureModelFactory_TemplateManager< panzer::Traits > &  cm_factory,
const Teuchos::ParameterList closure_models,
const Teuchos::ParameterList user_data,
const bool  write_graphviz_file = false,
const std::string &  graphviz_file_prefix = "" 
)
inline

Build all the responses set on the model evaluator. Once this method is called no other responses can be added. An exception is thrown if they are.

Definition at line 178 of file Panzer_ModelEvaluator_Epetra.hpp.

void panzer::ModelEvaluator_Epetra::buildResponses ( const std::vector< Teuchos::RCP< panzer::PhysicsBlock > > &  physicsBlocks,
const panzer::ClosureModelFactory_TemplateManager< panzer::Traits > &  cm_factory,
const Teuchos::ParameterList closure_models,
const Teuchos::ParameterList user_data,
const bool  write_graphviz_file = false,
const std::string &  graphviz_file_prefix = "" 
)
inline

Build all the responses set on the model evaluator. Once this method is called no other responses can be added. An exception is thrown if they are.

Definition at line 191 of file Panzer_ModelEvaluator_Epetra.hpp.

void panzer::ModelEvaluator_Epetra::setOneTimeDirichletBeta ( const double &  beta) const

This function is intended for experts only, it allows for a beta to be set for the dirichlet conditions only. This allows the dirichlet condition to be propagated to the mass matrix. The reason it is one time only is that it breaks encapsulation, and should be only used if absolutely neccessary.

Parameters
[in]betaValue of beta to use.

Definition at line 938 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::applyDirichletBCs ( const Teuchos::RCP< Thyra::VectorBase< double > > &  x,
const Teuchos::RCP< Thyra::VectorBase< double > > &  f 
) const

Apply the dirichlet boundary conditions to the vector "f" using the "x" values as the current solution.

Definition at line 371 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::initializeEpetraObjs ( panzer::BlockedEpetraLinearObjFactory< panzer::Traits, int > &  lof)
private

Initialize Epetra linear objects.

Note
Requires lof_ to be set.

Definition at line 160 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::initializeParameterVector ( const std::vector< Teuchos::RCP< Teuchos::Array< std::string > > > &  p_names,
const std::vector< Teuchos::RCP< Teuchos::Array< double > > > &  p_values,
const Teuchos::RCP< panzer::ParamLib > &  parameter_library 
)
private

Initialize the parameter vector object

Definition at line 194 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::evalModel_basic ( const InArgs inArgs,
const OutArgs outArgs 
) const
private

for evaluation and handling of normal quantities, x,f,W, etc

Definition at line 445 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::evalModel_basic_g ( AssemblyEngineInArgs  ae_inargs,
const InArgs inArgs,
const OutArgs outArgs 
) const
private

handles evaluation of responses g, dgdx

Note
This method should (basically) be a no-op if required_basic_g(outArgs)==false. However, for efficiency this is not checked.

Definition at line 651 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::evalModel_basic_dgdx ( AssemblyEngineInArgs  ae_inargs,
const InArgs inArgs,
const OutArgs outArgs 
) const
private

handles evaluation of responses dgdx

Note
This method should (basically) be a no-op if required_basic_dgdx(outArgs)==false. However, for efficiency this is not checked.

Definition at line 673 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::evalModel_basic_dfdp ( AssemblyEngineInArgs  ae_inargs,
const InArgs inArgs,
const OutArgs outArgs 
) const
private

handles evaluation of residual derivatives dfdp

Note
This method should (basically) be a no-op if required_basic_dfdp(outArgs)==false. However, for efficiency this is not checked.

Definition at line 701 of file Panzer_ModelEvaluator_Epetra.cpp.

bool panzer::ModelEvaluator_Epetra::required_basic_g ( const OutArgs outArgs) const
private

Are their required responses in the out args? g and DgDx.

Definition at line 782 of file Panzer_ModelEvaluator_Epetra.cpp.

bool panzer::ModelEvaluator_Epetra::required_basic_dgdx ( const OutArgs outArgs) const
private

Are their required responses in the out args? DgDx.

Definition at line 792 of file Panzer_ModelEvaluator_Epetra.cpp.

bool panzer::ModelEvaluator_Epetra::required_basic_dfdp ( const OutArgs outArgs) const
private

Are derivatives of the residual with respect to the parameters in the out args? DfDp.

Definition at line 808 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::copyEpetraIntoThyra ( const Epetra_MultiVector x,
const Teuchos::Ptr< Thyra::VectorBase< double > > &  thyraVec 
) const
private

Definition at line 870 of file Panzer_ModelEvaluator_Epetra.cpp.

void panzer::ModelEvaluator_Epetra::copyThyraIntoEpetra ( const Thyra::VectorBase< double > &  thyraVec,
Epetra_MultiVector x 
) const
private

Definition at line 830 of file Panzer_ModelEvaluator_Epetra.cpp.

Member Data Documentation

Teuchos::RCP<panzer::FieldManagerBuilder> panzer::ModelEvaluator_Epetra::fmb_
private

Definition at line 286 of file Panzer_ModelEvaluator_Epetra.hpp.

panzer::AssemblyEngine_TemplateManager<panzer::Traits> panzer::ModelEvaluator_Epetra::ae_tm_
mutableprivate

Definition at line 287 of file Panzer_ModelEvaluator_Epetra.hpp.

Teuchos::RCP<panzer::ResponseLibrary<panzer::Traits> > panzer::ModelEvaluator_Epetra::responseLibrary_
mutableprivate

Definition at line 290 of file Panzer_ModelEvaluator_Epetra.hpp.

std::vector<Teuchos::RCP<const Epetra_Map> > panzer::ModelEvaluator_Epetra::g_map_
private

Definition at line 291 of file Panzer_ModelEvaluator_Epetra.hpp.

std::vector<std::string> panzer::ModelEvaluator_Epetra::g_names_
private

Definition at line 292 of file Panzer_ModelEvaluator_Epetra.hpp.

std::vector<Teuchos::RCP<Epetra_Map> > panzer::ModelEvaluator_Epetra::p_map_
private

Definition at line 295 of file Panzer_ModelEvaluator_Epetra.hpp.

std::vector<Teuchos::RCP<Epetra_Vector> > panzer::ModelEvaluator_Epetra::p_init_
private

Definition at line 296 of file Panzer_ModelEvaluator_Epetra.hpp.

std::vector<Teuchos::RCP<Teuchos::Array<std::string> > > panzer::ModelEvaluator_Epetra::p_names_
private

Definition at line 298 of file Panzer_ModelEvaluator_Epetra.hpp.

Teuchos::Array<panzer::ParamVec> panzer::ModelEvaluator_Epetra::parameter_vector_
mutableprivate

Definition at line 300 of file Panzer_ModelEvaluator_Epetra.hpp.

Teuchos::RCP<panzer::GlobalData> panzer::ModelEvaluator_Epetra::global_data_
private

Definition at line 301 of file Panzer_ModelEvaluator_Epetra.hpp.

bool panzer::ModelEvaluator_Epetra::build_transient_support_
private

Definition at line 302 of file Panzer_ModelEvaluator_Epetra.hpp.

std::vector<bool> panzer::ModelEvaluator_Epetra::is_distributed_parameter_
private

Returns true if this is a distributed vector and false if it is a locally replicated scalar parameter. This is used to determine when to call a global to ghost method which is required for distributed parameters only.

Definition at line 306 of file Panzer_ModelEvaluator_Epetra.hpp.

std::vector<std::tuple<std::string,int,Teuchos::RCP<Epetra_Import>,Teuchos::RCP<Epetra_Vector> > > panzer::ModelEvaluator_Epetra::distributed_parameter_container_
private

Vector of tuples that contains objects needed for the global to ghost method for distributed parameters.

Tuple index 0: the string name for the parameter in the model evaluator. Tuple index 1: the integer index for the parameter in the model evaluator. Tuple index 2: an RCP to the linear object factory that performs the global to ghost operation. Tuple index 3: an RCP to the GHOSTED vector that is the target of the global to ghost operation.

Definition at line 315 of file Panzer_ModelEvaluator_Epetra.hpp.

Teuchos::RCP<panzer::LinearObjFactory<panzer::Traits> > panzer::ModelEvaluator_Epetra::lof_
private

Definition at line 318 of file Panzer_ModelEvaluator_Epetra.hpp.

Teuchos::RCP<LinearObjContainer> panzer::ModelEvaluator_Epetra::ghostedContainer_
mutableprivate

Definition at line 319 of file Panzer_ModelEvaluator_Epetra.hpp.

Teuchos::RCP<Teuchos::AbstractFactory<Epetra_Operator> > panzer::ModelEvaluator_Epetra::epetraOperatorFactory_
private

Definition at line 321 of file Panzer_ModelEvaluator_Epetra.hpp.

bool panzer::ModelEvaluator_Epetra::oneTimeDirichletBeta_on_
mutableprivate

Definition at line 323 of file Panzer_ModelEvaluator_Epetra.hpp.

double panzer::ModelEvaluator_Epetra::oneTimeDirichletBeta_
mutableprivate

Definition at line 324 of file Panzer_ModelEvaluator_Epetra.hpp.


The documentation for this class was generated from the following files: