Tempus
Version of the Day
Time Integration
|
ModelEvaluator for forming adjoint sensitivity equations. More...
#include <Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp>
Public Types | |
typedef Thyra::VectorBase< Scalar > | Vector |
typedef Thyra::MultiVectorBase < Scalar > | MultiVector |
Public Types inherited from Thyra::ModelEvaluator< class > | |
enum | EInArgsMembers |
enum | EInArgs_p_mp |
enum | EEvalType |
enum | EDerivativeMultiVectorOrientation |
enum | EDerivativeLinearOp |
enum | EDerivativeLinearity |
enum | ERankStatus |
enum | EOutArgsMembers |
enum | EOutArgsDfDp |
enum | EOutArgsDgDx_dot |
enum | EOutArgsDgDx |
enum | EOutArgsDgDp |
enum | EOutArgs_hess_vec_prod_f_xx |
enum | EOutArgs_hess_vec_prod_f_xp |
enum | EOutArgs_hess_vec_prod_f_px |
enum | EOutArgs_hess_vec_prod_f_pp |
enum | EOutArgs_hess_vec_prod_g_xx |
enum | EOutArgs_hess_vec_prod_g_xp |
enum | EOutArgs_hess_vec_prod_g_px |
enum | EOutArgs_hess_vec_prod_g_pp |
enum | EOutArgs_hess_f_xx |
enum | EOutArgs_hess_f_xp |
enum | EOutArgs_hess_f_pp |
enum | EOutArgs_hess_g_xx |
enum | EOutArgs_hess_g_xp |
enum | EOutArgs_hess_g_pp |
enum | EOutArgs_H_xx |
enum | EOutArgs_H_xp |
enum | EOutArgs_H_pp |
enum | EOutArgsDfDp_mp |
enum | EOutArgs_g_mp |
enum | EOutArgsDgDx_dot_mp |
enum | EOutArgsDgDx_mp |
enum | EOutArgsDgDp_mp |
typedef Teuchos::ScalarTraits < Scalar >::magnitudeType | ScalarMag |
Public Member Functions | |
AdjointAuxSensitivityModelEvaluator (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &model, const Scalar &t_final, const Teuchos::RCP< const Teuchos::ParameterList > &pList=Teuchos::null) | |
Constructor. More... | |
Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > | getModel () const |
Get the underlying model 'f'. More... | |
void | setForwardSolutionHistory (const Teuchos::RCP< const Tempus::SolutionHistory< Scalar > > &sh) |
Set solution history from forward evaluation. More... | |
Public Member Functions inherited from Thyra::StateFuncModelEvaluatorBase< Scalar > | |
RCP< const VectorSpaceBase < Scalar > > | get_p_space (int l) const |
RCP< const Teuchos::Array < std::string > > | get_p_names (int l) const |
RCP< const VectorSpaceBase < Scalar > > | get_g_space (int j) const |
Teuchos::ArrayView< const std::string > | get_g_names (int j) const |
ModelEvaluatorBase::InArgs < Scalar > | getNominalValues () const |
ModelEvaluatorBase::InArgs < Scalar > | getLowerBounds () const |
ModelEvaluatorBase::InArgs < Scalar > | getUpperBounds () const |
RCP< LinearOpBase< Scalar > > | create_W_op () const |
RCP< PreconditionerBase< Scalar > > | create_W_prec () const |
RCP< const LinearOpWithSolveFactoryBase < Scalar > > | get_W_factory () const |
void | reportFinalPoint (const ModelEvaluatorBase::InArgs< Scalar > &finalPoint, const bool wasSolved) |
Public Member Functions inherited from Thyra::ModelEvaluator< class > | |
virtual int | Np () const =0 |
virtual int | Ng () const =0 |
virtual RCP< const VectorSpaceBase< Scalar > > | get_f_multiplier_space () const =0 |
virtual RCP< const VectorSpaceBase< Scalar > > | get_g_multiplier_space (int j) const =0 |
virtual RCP < LinearOpWithSolveBase < Scalar > > | create_W () const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_DfDp_op (int l) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_DgDx_dot_op (int j) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_DgDx_op (int j) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_DgDp_op (int j, int l) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_hess_f_xx () const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_hess_f_xp (int l) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_hess_f_pp (int l1, int l2) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_hess_g_xx (int j) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_hess_g_xp (int j, int l) const =0 |
virtual RCP< LinearOpBase < Scalar > > | create_hess_g_pp (int j, int l1, int l2) const =0 |
virtual ModelEvaluatorBase::OutArgs < Scalar > | createOutArgs () const =0 |
virtual void | evalModel (const ModelEvaluatorBase::InArgs< Scalar > &inArgs, const ModelEvaluatorBase::OutArgs< Scalar > &outArgs) const =0 |
ModelEvaluatorBase () | |
std::string | toString (ModelEvaluatorBase::EInArgsMembers) |
std::string | toString (ModelEvaluatorBase::EOutArgsMembers) |
std::string | toString (ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
ModelEvaluatorBase::EDerivativeMultiVectorOrientation | getOtherDerivativeMultiVectorOrientation (ModelEvaluatorBase::EDerivativeMultiVectorOrientation orientation) |
Public Member Functions inherited from Teuchos::Describable | |
virtual std::string | description () const |
virtual void | describe (FancyOStream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
void | describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const |
virtual | ~Describable () |
LabeledObject () | |
virtual | ~LabeledObject () |
virtual void | setObjectLabel (const std::string &objectLabel) |
virtual std::string | getObjectLabel () const |
DescribableStreamManipulatorState | describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default) |
std::ostream & | operator<< (std::ostream &os, const DescribableStreamManipulatorState &d) |
Static Public Member Functions | |
static Teuchos::RCP< const Teuchos::ParameterList > | getValidParameters () |
Private Types | |
typedef Thyra::DefaultProductVectorSpace < Scalar > | DPVS |
typedef Thyra::DefaultProductVector < Scalar > | DPV |
typedef Thyra::DefaultMultiVectorProductVectorSpace < Scalar > | DMVPVS |
typedef Thyra::DefaultMultiVectorProductVector < Scalar > | DMVPV |
Private Member Functions | |
Thyra::ModelEvaluatorBase::OutArgs < Scalar > | createOutArgsImpl () const |
void | evalModelImpl (const Thyra::ModelEvaluatorBase::InArgs< Scalar > &inArgs, const Thyra::ModelEvaluatorBase::OutArgs< Scalar > &outArgs) const |
Private Attributes | |
Thyra::ModelEvaluatorBase::InArgs < Scalar > | prototypeInArgs_ |
Thyra::ModelEvaluatorBase::OutArgs < Scalar > | prototypeOutArgs_ |
Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > | model_ |
Teuchos::RCP< const DMVPVS > | adjoint_space_ |
Teuchos::RCP< const DMVPVS > | residual_space_ |
Teuchos::RCP< const DMVPVS > | response_space_ |
Teuchos::RCP< const DPVS > | x_prod_space_ |
Teuchos::RCP< const DPVS > | f_prod_space_ |
Teuchos::RCP< const Tempus::SolutionHistory < Scalar > > | sh_ |
Scalar | t_final_ |
bool | mass_matrix_is_constant_ |
bool | mass_matrix_is_identity_ |
int | p_index_ |
int | g_index_ |
int | num_adjoint_ |
bool | mass_matrix_is_computed_ |
Teuchos::RCP < Thyra::LinearOpBase< Scalar > > | my_dfdx_ |
Teuchos::RCP < Thyra::LinearOpBase< Scalar > > | my_dfdxdot_ |
Teuchos::RCP < Thyra::LinearOpBase< Scalar > > | my_dfdp_op_ |
Teuchos::RCP < Thyra::MultiVectorBase < Scalar > > | my_dfdp_mv_ |
Teuchos::RCP < Tempus::SolutionState < Scalar > > | forward_state_ |
Scalar | t_interp_ |
Public functions overridden from ModelEvaulator. | |
Teuchos::RCP< const Thyra::VectorSpaceBase< Scalar > > | get_p_space (int p) const |
Teuchos::RCP< const Teuchos::Array< std::string > > | get_p_names (int p) const |
Teuchos::RCP< const Thyra::VectorSpaceBase< Scalar > > | get_x_space () const |
Teuchos::RCP< const Thyra::VectorSpaceBase< Scalar > > | get_f_space () const |
Teuchos::RCP < Thyra::LinearOpBase< Scalar > > | create_W_op () const |
Teuchos::RCP< const Thyra::LinearOpWithSolveFactoryBase < Scalar > > | get_W_factory () const |
Thyra::ModelEvaluatorBase::InArgs < Scalar > | createInArgs () const |
Thyra::ModelEvaluatorBase::InArgs < Scalar > | getNominalValues () const |
Additional Inherited Members | |
Static Public Attributes inherited from Thyra::ModelEvaluator< class > | |
static const int | NUM_E_IN_ARGS_MEMBERS |
static const int | NUM_E_OUT_ARGS_MEMBERS |
Static Public Attributes inherited from Teuchos::Describable | |
static const EVerbosityLevel | verbLevel_default |
ModelEvaluator for forming adjoint sensitivity equations.
This class wraps a given ModelEvalutor encapsulating f(x_dot,x,p) and creates a new "residual" for the adjoint sensitivity equations: F(y,z) = [ d/dt( df/dx_dot^T*y ) - df/dx^T*y ] = 0 [ dz/dt - df/dp^T*y ] where y is the adjoint variable and z is an auxiliary variable. Nominally y is a multi-vector belonging to the vector space of the residual f and a given number of columns and z is a multi-vector beling to the vector space p and the same number of columns. To satisfy the model evaluator interface, y and z are converted to a product vector formed by their columns. This is the form of the adjoint equations suitable for computing sensitivities of a response function g(x(T),p).
To compute adjoint sensitivities, the equations f(x_dot,x,p) = 0 are integrated forward in time to some final time T, with the adjoint equations above integrated backward in time starting at T. Since the tempus integrator can only integrate forward in time, we define tau = T - t and transform the adjoint equations to: F(y) = d/dtau( df/dx_dot^T*y ) + df/dx^T*y = 0. The initial conditions at t = T for y are y(T) = df/dx_dot(x_dot(T),x(T),p)^{-T} * dg/dx(x(T),p)^T. along with z(T) = 0. The sensitivity of g(T) is then dg/dp(T) - int_{0}^T(df/dp^T*y)dt + dx/dp(0)^T*df/dx_dot(0)^T*y(0) = dg/dp(T) - z(0) + dx/dp(0)^T*df/dx_dot(0)^T*y(0)
This model evaluator supports both implicit and explict forms of the governing equations. However it assumes df/dx_dot is constant with respect to x_dot, x, and t so that the adjoint equations become F(y) = df/dxdot^T*y_dot + df/dx^T*y = 0. Moving beyond this assumption will require modifications to the steppers in how they generate time-derivative terms.
Definition at line 57 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
typedef Thyra::VectorBase<Scalar> Tempus::AdjointAuxSensitivityModelEvaluator< Scalar >::Vector |
Definition at line 60 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
typedef Thyra::MultiVectorBase<Scalar> Tempus::AdjointAuxSensitivityModelEvaluator< Scalar >::MultiVector |
Definition at line 61 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 121 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 122 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 123 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 124 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
Tempus::AdjointAuxSensitivityModelEvaluator< Scalar >::AdjointAuxSensitivityModelEvaluator | ( | const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > & | model, |
const Scalar & | t_final, | ||
const Teuchos::RCP< const Teuchos::ParameterList > & | pList = Teuchos::null |
||
) |
Constructor.
t_final is the final integration time used to implement the time transformation described above. num_adjoint is the number of adjoint variables defining the number of columns in y, which is determined by the number of elements in the vector space for the response g. The optionally supplied parameter list supports the following options:
Definition at line 28 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
inline |
Get the underlying model 'f'.
Definition at line 88 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
void Tempus::AdjointAuxSensitivityModelEvaluator< Scalar >::setForwardSolutionHistory | ( | const Teuchos::RCP< const Tempus::SolutionHistory< Scalar > > & | sh | ) |
Set solution history from forward evaluation.
Definition at line 111 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 122 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 131 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 140 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 148 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 156 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 175 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 203 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
virtual |
Implements Thyra::ModelEvaluator< class >.
Definition at line 211 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
static |
Definition at line 436 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
private |
Definition at line 244 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
private |
Definition at line 252 of file Tempus_AdjointAuxSensitivityModelEvaluator_impl.hpp.
|
private |
Definition at line 133 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 134 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 136 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 138 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 139 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 140 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 141 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 142 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 143 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 144 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 145 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 146 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 147 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 148 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
private |
Definition at line 149 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
mutableprivate |
Definition at line 151 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
mutableprivate |
Definition at line 152 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
mutableprivate |
Definition at line 153 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
mutableprivate |
Definition at line 154 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
mutableprivate |
Definition at line 155 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
mutableprivate |
Definition at line 156 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.
|
mutableprivate |
Definition at line 157 of file Tempus_AdjointAuxSensitivityModelEvaluator_decl.hpp.