EpetraExt Package Browser (Single Doxygen Collection) Development
Loading...
Searching...
No Matches
Related Functions | List of all members
EpetraExt::DiagonalTransientModel Class Reference

Simple transient diagonal model for an implicit or explicit ODE. More...

#include <EpetraExt_DiagonalTransientModel.hpp>

Inheritance diagram for EpetraExt::DiagonalTransientModel:
Inheritance graph
[legend]

Related Functions

(Note that these are not member functions.)

Teuchos::RCP< DiagonalTransientModeldiagonalTransientModel (Teuchos::RCP< Epetra_Comm > const &epetra_comm, Teuchos::RCP< Teuchos::ParameterList > const &paramList=Teuchos::null)
 Nonmember constructor.
 

Overridden from EpetraExt::ModelEvaluator .

enum  EGammaFit { GAMMA_FIT_LINEAR , GAMMA_FIT_RANDOM }
 
typedef Teuchos::Array< double > coeff_s_t
 
typedef Teuchos::Array< int > coeff_s_idx_t
 
typedef Teuchos::Array< Teuchos::RCP< const Epetra_Map > > RCP_Eptra_Map_Array_t
 
typedef Teuchos::Array< Teuchos::RCP< Epetra_Vector > > RCP_Eptra_Vector_Array_t
 
typedef Teuchos::Array< Teuchos::RCP< Teuchos::Array< std::string > > > RCP_Array_String_Array_t
 
Teuchos::RCP< Teuchos::ParameterList > paramList_
 
Teuchos::RCP< Epetra_Commepetra_comm_
 
Teuchos::RCP< Epetra_Mapepetra_map_
 
bool implicit_
 
int numElements_
 
double gamma_min_
 
double gamma_max_
 
coeff_s_t coeff_s_
 
coeff_s_idx_t coeff_s_idx_
 
EGammaFit gamma_fit_
 
double x0_
 
bool exactSolutionAsResponse_
 
Teuchos::RCP< Epetra_Vectorgamma_
 
Teuchos::RCP< Epetra_CrsGraphW_graph_
 
int Np_
 
int np_
 
int Ng_
 
RCP_Eptra_Map_Array_t map_p_
 
RCP_Array_String_Array_t names_p_
 
RCP_Eptra_Map_Array_t map_g_
 
RCP_Eptra_Vector_Array_t p_init_
 
Teuchos::RCP< Epetra_Vectorx_init_
 
Teuchos::RCP< Epetra_Vectorx_dot_init_
 
Teuchos::RCP< const Epetra_Vectorcoeff_s_p_
 
bool isIntialized_
 
Teuchos::RCP< const Epetra_Mapget_x_map () const
 
Teuchos::RCP< const Epetra_Mapget_f_map () const
 
Teuchos::RCP< const Epetra_Mapget_p_map (int l) const
 \breif .
 
Teuchos::RCP< const Teuchos::Array< std::string > > get_p_names (int l) const
 \breif .
 
Teuchos::RCP< const Epetra_Mapget_g_map (int j) const
 \breif .
 
Teuchos::RCP< const Epetra_Vectorget_x_init () const
 
Teuchos::RCP< const Epetra_Vectorget_x_dot_init () const
 
Teuchos::RCP< const Epetra_Vectorget_p_init (int l) const
 
Teuchos::RCP< Epetra_Operatorcreate_W () const
 
InArgs createInArgs () const
 
OutArgs createOutArgs () const
 
void evalModel (const InArgs &inArgs, const OutArgs &outArgs) const
 
void initialize ()
 
void set_coeff_s_p (const Teuchos::RCP< const Epetra_Vector > &coeff_s_p) const
 
void unset_coeff_s_p () const
 
int coeff_s_idx (int i) const
 
double coeff_s (int i) const
 

Constructors, Initializers, Misc.

 DiagonalTransientModel (Teuchos::RCP< Epetra_Comm > const &epetra_comm)
 
Teuchos::RCP< const Epetra_Vectorget_gamma () const
 Return the model vector gamma,.
 
Teuchos::RCP< const Epetra_VectorgetExactSolution (const double t, const Epetra_Vector *coeff_s_p=0) const
 Return the exact solution as a function of time.
 
Teuchos::RCP< const Epetra_MultiVectorgetExactSensSolution (const double t, const Epetra_Vector *coeff_s_p=0) const
 Return the exact sensitivity of x as a function of time.
 

Overridden from ParameterListAcceptor

void setParameterList (Teuchos::RCP< Teuchos::ParameterList > const &paramList)
 
Teuchos::RCP< Teuchos::ParameterList > getNonconstParameterList ()
 
Teuchos::RCP< Teuchos::ParameterList > unsetParameterList ()
 
Teuchos::RCP< const Teuchos::ParameterList > getParameterList () const
 
Teuchos::RCP< const Teuchos::ParameterList > getValidParameters () const
 

Additional Inherited Members

- Public Types inherited from EpetraExt::ModelEvaluator
enum  EInArgsMembers {
  IN_ARG_x_dot , IN_ARG_x , IN_ARG_x_dot_poly , IN_ARG_x_poly ,
  IN_ARG_x_dot_sg , IN_ARG_x_sg , IN_ARG_x_dot_mp , IN_ARG_x_mp ,
  IN_ARG_t , IN_ARG_alpha , IN_ARG_beta , IN_ARG_step_size ,
  IN_ARG_stage_number , IN_ARG_x_dotdot , IN_ARG_x_dotdot_poly , IN_ARG_x_dotdot_sg ,
  IN_ARG_x_dotdot_mp , IN_ARG_omega , IN_ARG_sg_basis , IN_ARG_sg_quadrature ,
  IN_ARG_sg_expansion
}
 
enum  EInArgs_p_sg { IN_ARG_p_sg }
 
enum  EInArgs_p_mp { IN_ARG_p_mp }
 
enum  EEvalType { EVAL_TYPE_EXACT , EVAL_TYPE_APPROX_DERIV , EVAL_TYPE_VERY_APPROX_DERIV }
 
enum  EDerivativeMultiVectorOrientation { DERIV_MV_BY_COL , DERIV_TRANS_MV_BY_ROW }
 
enum  EDerivativeLinearOp { DERIV_LINEAR_OP }
 
enum  EDerivativeLinearity { DERIV_LINEARITY_UNKNOWN , DERIV_LINEARITY_CONST , DERIV_LINEARITY_NONCONST }
 
enum  ERankStatus { DERIV_RANK_UNKNOWN , DERIV_RANK_FULL , DERIV_RANK_DEFICIENT }
 
enum  EOutArgsMembers {
  OUT_ARG_f , OUT_ARG_W , OUT_ARG_f_poly , OUT_ARG_f_sg ,
  OUT_ARG_W_sg , OUT_ARG_f_mp , OUT_ARG_W_mp , OUT_ARG_WPrec
}
 
enum  EOutArgsDfDp { OUT_ARG_DfDp }
 
enum  EOutArgsDgDx_dot { OUT_ARG_DgDx_dot }
 
enum  EOutArgsDgDx_dotdot { OUT_ARG_DgDx_dotdot }
 
enum  EOutArgsDgDx { OUT_ARG_DgDx }
 
enum  EOutArgsDgDp { OUT_ARG_DgDp }
 
enum  EOutArgsDfDp_sg { OUT_ARG_DfDp_sg }
 
enum  EOutArgs_g_sg { OUT_ARG_g_sg }
 
enum  EOutArgsDgDx_dot_sg { OUT_ARG_DgDx_dot_sg }
 
enum  EOutArgsDgDx_dotdot_sg { OUT_ARG_DgDx_dotdot_sg }
 
enum  EOutArgsDgDx_sg { OUT_ARG_DgDx_sg }
 
enum  EOutArgsDgDp_sg { OUT_ARG_DgDp_sg }
 
enum  EOutArgsDfDp_mp { OUT_ARG_DfDp_mp }
 
enum  EOutArgs_g_mp { OUT_ARG_g_mp }
 
enum  EOutArgsDgDx_dot_mp { OUT_ARG_DgDx_dot_mp }
 
enum  EOutArgsDgDx_dotdot_mp { OUT_ARG_DgDx_dotdot_mp }
 
enum  EOutArgsDgDx_mp { OUT_ARG_DgDx_mp }
 
enum  EOutArgsDgDp_mp { OUT_ARG_DgDp_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
 
- Public Member Functions inherited from EpetraExt::ModelEvaluator
virtual ~ModelEvaluator ()
 
virtual Teuchos::ArrayView< const std::string > get_g_names (int j) const
 Get the names of the response functions associated with response subvector j if available.
 
virtual Teuchos::RCP< const Epetra_Vectorget_x_dotdot_init () const
 
virtual double get_t_init () const
 
virtual double getInfBound () const
 Return the value of an infinite bound.
 
virtual Teuchos::RCP< const Epetra_Vectorget_x_lower_bounds () const
 
virtual Teuchos::RCP< const Epetra_Vectorget_x_upper_bounds () const
 
virtual Teuchos::RCP< const Epetra_Vectorget_p_lower_bounds (int l) const
 
virtual Teuchos::RCP< const Epetra_Vectorget_p_upper_bounds (int l) const
 
virtual double get_t_lower_bound () const
 
virtual double get_t_upper_bound () const
 
virtual Teuchos::RCP< EpetraExt::ModelEvaluator::Preconditionercreate_WPrec () const
 
virtual Teuchos::RCP< Epetra_Operatorcreate_DfDp_op (int l) const
 
virtual Teuchos::RCP< Epetra_Operatorcreate_DgDx_dot_op (int j) const
 
virtual Teuchos::RCP< Epetra_Operatorcreate_DgDx_dotdot_op (int j) const
 
virtual Teuchos::RCP< Epetra_Operatorcreate_DgDx_op (int j) const
 
virtual Teuchos::RCP< Epetra_Operatorcreate_DgDp_op (int j, int l) const
 
- Static Public Attributes inherited from EpetraExt::ModelEvaluator
static const int NUM_E_IN_ARGS_MEMBERS =21
 
static const int NUM_E_OUT_ARGS_MEMBERS =9
 

Detailed Description

Simple transient diagonal model for an implicit or explicit ODE.

The explicit ODE form of the model is:

 x_dot(i) = f_hat(x(i), gamma(i), s(i), t), for i = 0...n-1, on t in [0,t_f]

where:

 f_hat(x(i), gamma(i), s(i), t) = gama(i)*x(i) + exp(gamma(i)*t)*sin(s(i),t)

The implicit ODE form of the model i:

 f(i)(x_dot(i), x(i), t) = x_dot(i) - f_hat(x(i), gamma(i), s(i), t),
 
   for i = 0...n-1, on t in [0,t_f]

This is a diagonal problem so it does not make the greatest test problem but it does make it easy to derive tests for as a starter.

The coefficients s can be exposed as model parameters and are called coeff_s_p in the code. The selection of the coefficients is handled through the

ToDo: Finish Documentation!

Definition at line 99 of file EpetraExt_DiagonalTransientModel.hpp.

Member Typedef Documentation

◆ coeff_s_t

typedef Teuchos::Array<double> EpetraExt::DiagonalTransientModel::coeff_s_t
private

Definition at line 186 of file EpetraExt_DiagonalTransientModel.hpp.

◆ coeff_s_idx_t

typedef Teuchos::Array<int> EpetraExt::DiagonalTransientModel::coeff_s_idx_t
private

Definition at line 187 of file EpetraExt_DiagonalTransientModel.hpp.

◆ RCP_Eptra_Map_Array_t

typedef Teuchos::Array<Teuchos::RCP<const Epetra_Map> > EpetraExt::DiagonalTransientModel::RCP_Eptra_Map_Array_t
private

Definition at line 188 of file EpetraExt_DiagonalTransientModel.hpp.

◆ RCP_Eptra_Vector_Array_t

typedef Teuchos::Array<Teuchos::RCP<Epetra_Vector> > EpetraExt::DiagonalTransientModel::RCP_Eptra_Vector_Array_t
private

Definition at line 189 of file EpetraExt_DiagonalTransientModel.hpp.

◆ RCP_Array_String_Array_t

typedef Teuchos::Array<Teuchos::RCP<Teuchos::Array<std::string> > > EpetraExt::DiagonalTransientModel::RCP_Array_String_Array_t
private

Definition at line 190 of file EpetraExt_DiagonalTransientModel.hpp.

Member Enumeration Documentation

◆ EGammaFit

Enumerator
GAMMA_FIT_LINEAR 
GAMMA_FIT_RANDOM 

Definition at line 179 of file EpetraExt_DiagonalTransientModel.hpp.

Constructor & Destructor Documentation

◆ DiagonalTransientModel()

EpetraExt::DiagonalTransientModel::DiagonalTransientModel ( Teuchos::RCP< Epetra_Comm > const &  epetra_comm)

Definition at line 166 of file EpetraExt_DiagonalTransientModel.cpp.

Member Function Documentation

◆ get_gamma()

Teuchos::RCP< const Epetra_Vector > EpetraExt::DiagonalTransientModel::get_gamma ( ) const

Return the model vector gamma,.

Definition at line 185 of file EpetraExt_DiagonalTransientModel.cpp.

◆ getExactSolution()

Teuchos::RCP< const Epetra_Vector > EpetraExt::DiagonalTransientModel::getExactSolution ( const double  t,
const Epetra_Vector coeff_s_p = 0 
) const

Return the exact solution as a function of time.

Definition at line 192 of file EpetraExt_DiagonalTransientModel.cpp.

◆ getExactSensSolution()

Teuchos::RCP< const Epetra_MultiVector > EpetraExt::DiagonalTransientModel::getExactSensSolution ( const double  t,
const Epetra_Vector coeff_s_p = 0 
) const

Return the exact sensitivity of x as a function of time.

Definition at line 211 of file EpetraExt_DiagonalTransientModel.cpp.

◆ setParameterList()

void EpetraExt::DiagonalTransientModel::setParameterList ( Teuchos::RCP< Teuchos::ParameterList > const &  paramList)

Definition at line 237 of file EpetraExt_DiagonalTransientModel.cpp.

◆ getNonconstParameterList()

Teuchos::RCP< Teuchos::ParameterList > EpetraExt::DiagonalTransientModel::getNonconstParameterList ( )

Definition at line 260 of file EpetraExt_DiagonalTransientModel.cpp.

◆ unsetParameterList()

Teuchos::RCP< Teuchos::ParameterList > EpetraExt::DiagonalTransientModel::unsetParameterList ( )

Definition at line 267 of file EpetraExt_DiagonalTransientModel.cpp.

◆ getParameterList()

Teuchos::RCP< const Teuchos::ParameterList > EpetraExt::DiagonalTransientModel::getParameterList ( ) const

Definition at line 276 of file EpetraExt_DiagonalTransientModel.cpp.

◆ getValidParameters()

Teuchos::RCP< const Teuchos::ParameterList > EpetraExt::DiagonalTransientModel::getValidParameters ( ) const

Definition at line 283 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_x_map()

Teuchos::RCP< const Epetra_Map > EpetraExt::DiagonalTransientModel::get_x_map ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 327 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_f_map()

Teuchos::RCP< const Epetra_Map > EpetraExt::DiagonalTransientModel::get_f_map ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 334 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_p_map()

Teuchos::RCP< const Epetra_Map > EpetraExt::DiagonalTransientModel::get_p_map ( int  l) const
virtual

\breif .

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 341 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_p_names()

Teuchos::RCP< const Teuchos::Array< std::string > > EpetraExt::DiagonalTransientModel::get_p_names ( int  l) const
virtual

\breif .

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 351 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_g_map()

Teuchos::RCP< const Epetra_Map > EpetraExt::DiagonalTransientModel::get_g_map ( int  j) const
virtual

\breif .

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 361 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_x_init()

Teuchos::RCP< const Epetra_Vector > EpetraExt::DiagonalTransientModel::get_x_init ( ) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 371 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_x_dot_init()

Teuchos::RCP< const Epetra_Vector > EpetraExt::DiagonalTransientModel::get_x_dot_init ( ) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 378 of file EpetraExt_DiagonalTransientModel.cpp.

◆ get_p_init()

Teuchos::RCP< const Epetra_Vector > EpetraExt::DiagonalTransientModel::get_p_init ( int  l) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 385 of file EpetraExt_DiagonalTransientModel.cpp.

◆ create_W()

Teuchos::RCP< Epetra_Operator > EpetraExt::DiagonalTransientModel::create_W ( ) const
virtual

Reimplemented from EpetraExt::ModelEvaluator.

Definition at line 395 of file EpetraExt_DiagonalTransientModel.cpp.

◆ createInArgs()

EpetraExt::ModelEvaluator::InArgs EpetraExt::DiagonalTransientModel::createInArgs ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 404 of file EpetraExt_DiagonalTransientModel.cpp.

◆ createOutArgs()

EpetraExt::ModelEvaluator::OutArgs EpetraExt::DiagonalTransientModel::createOutArgs ( ) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 420 of file EpetraExt_DiagonalTransientModel.cpp.

◆ evalModel()

void EpetraExt::DiagonalTransientModel::evalModel ( const InArgs inArgs,
const OutArgs outArgs 
) const
virtual

Implements EpetraExt::ModelEvaluator.

Definition at line 457 of file EpetraExt_DiagonalTransientModel.cpp.

◆ initialize()

void EpetraExt::DiagonalTransientModel::initialize ( )
private

Definition at line 566 of file EpetraExt_DiagonalTransientModel.cpp.

◆ set_coeff_s_p()

void EpetraExt::DiagonalTransientModel::set_coeff_s_p ( const Teuchos::RCP< const Epetra_Vector > &  coeff_s_p) const
private

Definition at line 735 of file EpetraExt_DiagonalTransientModel.cpp.

◆ unset_coeff_s_p()

void EpetraExt::DiagonalTransientModel::unset_coeff_s_p ( ) const
private

Definition at line 746 of file EpetraExt_DiagonalTransientModel.cpp.

◆ coeff_s_idx()

int EpetraExt::DiagonalTransientModel::coeff_s_idx ( int  i) const
inlineprivate

Definition at line 235 of file EpetraExt_DiagonalTransientModel.hpp.

◆ coeff_s()

double EpetraExt::DiagonalTransientModel::coeff_s ( int  i) const
inlineprivate

Definition at line 240 of file EpetraExt_DiagonalTransientModel.hpp.

Friends And Related Function Documentation

◆ diagonalTransientModel()

Teuchos::RCP< DiagonalTransientModel > diagonalTransientModel ( Teuchos::RCP< Epetra_Comm > const &  epetra_comm,
Teuchos::RCP< Teuchos::ParameterList > const &  paramList = Teuchos::null 
)
related

Nonmember constructor.

Member Data Documentation

◆ paramList_

Teuchos::RCP<Teuchos::ParameterList> EpetraExt::DiagonalTransientModel::paramList_
private

Definition at line 196 of file EpetraExt_DiagonalTransientModel.hpp.

◆ epetra_comm_

Teuchos::RCP<Epetra_Comm> EpetraExt::DiagonalTransientModel::epetra_comm_
private

Definition at line 197 of file EpetraExt_DiagonalTransientModel.hpp.

◆ epetra_map_

Teuchos::RCP<Epetra_Map> EpetraExt::DiagonalTransientModel::epetra_map_
private

Definition at line 198 of file EpetraExt_DiagonalTransientModel.hpp.

◆ implicit_

bool EpetraExt::DiagonalTransientModel::implicit_
private

Definition at line 199 of file EpetraExt_DiagonalTransientModel.hpp.

◆ numElements_

int EpetraExt::DiagonalTransientModel::numElements_
private

Definition at line 200 of file EpetraExt_DiagonalTransientModel.hpp.

◆ gamma_min_

double EpetraExt::DiagonalTransientModel::gamma_min_
private

Definition at line 201 of file EpetraExt_DiagonalTransientModel.hpp.

◆ gamma_max_

double EpetraExt::DiagonalTransientModel::gamma_max_
private

Definition at line 202 of file EpetraExt_DiagonalTransientModel.hpp.

◆ coeff_s_

coeff_s_t EpetraExt::DiagonalTransientModel::coeff_s_
private

Definition at line 203 of file EpetraExt_DiagonalTransientModel.hpp.

◆ coeff_s_idx_

coeff_s_idx_t EpetraExt::DiagonalTransientModel::coeff_s_idx_
private

Definition at line 204 of file EpetraExt_DiagonalTransientModel.hpp.

◆ gamma_fit_

EGammaFit EpetraExt::DiagonalTransientModel::gamma_fit_
private

Definition at line 205 of file EpetraExt_DiagonalTransientModel.hpp.

◆ x0_

double EpetraExt::DiagonalTransientModel::x0_
private

Definition at line 206 of file EpetraExt_DiagonalTransientModel.hpp.

◆ exactSolutionAsResponse_

bool EpetraExt::DiagonalTransientModel::exactSolutionAsResponse_
private

Definition at line 207 of file EpetraExt_DiagonalTransientModel.hpp.

◆ gamma_

Teuchos::RCP<Epetra_Vector> EpetraExt::DiagonalTransientModel::gamma_
private

Definition at line 208 of file EpetraExt_DiagonalTransientModel.hpp.

◆ W_graph_

Teuchos::RCP<Epetra_CrsGraph> EpetraExt::DiagonalTransientModel::W_graph_
private

Definition at line 209 of file EpetraExt_DiagonalTransientModel.hpp.

◆ Np_

int EpetraExt::DiagonalTransientModel::Np_
private

Definition at line 210 of file EpetraExt_DiagonalTransientModel.hpp.

◆ np_

int EpetraExt::DiagonalTransientModel::np_
private

Definition at line 211 of file EpetraExt_DiagonalTransientModel.hpp.

◆ Ng_

int EpetraExt::DiagonalTransientModel::Ng_
private

Definition at line 212 of file EpetraExt_DiagonalTransientModel.hpp.

◆ map_p_

RCP_Eptra_Map_Array_t EpetraExt::DiagonalTransientModel::map_p_
private

Definition at line 213 of file EpetraExt_DiagonalTransientModel.hpp.

◆ names_p_

RCP_Array_String_Array_t EpetraExt::DiagonalTransientModel::names_p_
private

Definition at line 214 of file EpetraExt_DiagonalTransientModel.hpp.

◆ map_g_

RCP_Eptra_Map_Array_t EpetraExt::DiagonalTransientModel::map_g_
private

Definition at line 215 of file EpetraExt_DiagonalTransientModel.hpp.

◆ p_init_

RCP_Eptra_Vector_Array_t EpetraExt::DiagonalTransientModel::p_init_
private

Definition at line 216 of file EpetraExt_DiagonalTransientModel.hpp.

◆ x_init_

Teuchos::RCP<Epetra_Vector> EpetraExt::DiagonalTransientModel::x_init_
private

Definition at line 217 of file EpetraExt_DiagonalTransientModel.hpp.

◆ x_dot_init_

Teuchos::RCP<Epetra_Vector> EpetraExt::DiagonalTransientModel::x_dot_init_
private

Definition at line 218 of file EpetraExt_DiagonalTransientModel.hpp.

◆ coeff_s_p_

Teuchos::RCP<const Epetra_Vector> EpetraExt::DiagonalTransientModel::coeff_s_p_
mutableprivate

Definition at line 220 of file EpetraExt_DiagonalTransientModel.hpp.

◆ isIntialized_

bool EpetraExt::DiagonalTransientModel::isIntialized_
private

Definition at line 222 of file EpetraExt_DiagonalTransientModel.hpp.


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