10 #ifndef Tempus_StepperIMEX_RK_Partition_decl_hpp
11 #define Tempus_StepperIMEX_RK_Partition_decl_hpp
13 #include "Tempus_config.hpp"
15 #include "Tempus_StepperImplicit.hpp"
16 #include "Tempus_WrapperModelEvaluatorPairPartIMEX_Basic.hpp"
310 template <
class Scalar>
320 std::string stepperType =
"Partitioned IMEX RK SSP2");
326 bool useFSAL, std::string ICConsistency,
bool ICConsistencyCheck,
327 bool zeroInitialGuess,
329 std::string stepperType,
344 std::string stepperType =
"",
351 std::string stepperType);
418 std::vector<Teuchos::RCP<Thyra::VectorBase<Scalar> > >&
getStageF()
422 std::vector<Teuchos::RCP<Thyra::VectorBase<Scalar> > >&
getStageGx()
432 return Scalar(1.0) / (dt * A(0, 0));
435 virtual Scalar
getBeta(
const Scalar)
const {
return Scalar(1.0); }
450 Scalar stepSize, Scalar stageNumber,
455 Scalar stepSize, Scalar stageNumber,
466 std::vector<Teuchos::RCP<Thyra::VectorBase<Scalar> > >
stageF_;
467 std::vector<Teuchos::RCP<Thyra::VectorBase<Scalar> > >
stageGx_;
484 template <
typename Scalar>
504 xDotDot = Teuchos::null;
511 Thyra::V_StVpStV(xDot.ptr(),
s_, *x, -
s_, *
xTilde_);
528 template <
class Scalar>
534 #endif // Tempus_StepperIMEX_RK_Partition_decl_hpp
virtual Scalar getAlpha(const Scalar dt) const
Return alpha = d(xDot)/dx.
Teuchos::RCP< const Teuchos::ParameterList > getValidParameters() const
Teuchos::RCP< WrapperModelEvaluator< Scalar > > wrapperModel_
StepperIMEX_RK_Partition(std::string stepperType="Partitioned IMEX RK SSP2")
Default constructor.
Teuchos::RCP< Thyra::VectorBase< Scalar > > xTilde_
virtual void setTableaus(std::string stepperType="", Teuchos::RCP< const RKButcherTableau< Scalar > > explicitTableau=Teuchos::null, Teuchos::RCP< const RKButcherTableau< Scalar > > implicitTableau=Teuchos::null)
Set both the explicit and implicit tableau from ParameterList.
virtual Teuchos::RCP< const RKButcherTableau< Scalar > > getImplicitTableau() const
Return implicit tableau.
virtual Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > getModel() const
virtual void setModelPair(const Teuchos::RCP< WrapperModelEvaluatorPairPartIMEX_Basic< Scalar > > &modelPair)
Create WrapperModelPairIMEX from user-supplied ModelEvaluator pair.
virtual bool isExplicitImplicit() const
Teuchos::RCP< const RKButcherTableau< Scalar > > implicitTableau_
Partitioned Implicit-Explicit Runge-Kutta (IMEX-RK) time stepper.
virtual Scalar getOrderMax() const
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar > > > & getStageGx()
void evalExplicitModel(const Teuchos::RCP< const Thyra::VectorBase< Scalar > > &X, Scalar time, Scalar stepSize, Scalar stageNumber, const Teuchos::RCP< Thyra::VectorBase< Scalar > > &F) const
StepperIMEX_RKPartTimeDerivative(Scalar s, Teuchos::RCP< const Thyra::VectorBase< Scalar > > xTilde)
Constructor.
virtual OrderODE getOrderODE() const
Base class for Runge-Kutta methods, ExplicitRK, DIRK and IMEX.
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar > > > stageF_
virtual bool isImplicit() const
Thyra Base interface for implicit time steppers.
virtual Teuchos::RCP< Tempus::StepperState< Scalar > > getDefaultStepperState()
Provide a StepperState to the SolutionState. This Stepper does not have any special state data...
ModelEvaluator pair for implicit and explicit (IMEX) evaulations.
Application Action for StepperRKBase.
virtual bool isExplicit() const
virtual ~StepperIMEX_RKPartTimeDerivative()
Destructor.
void evalImplicitModelExplicitly(const Teuchos::RCP< const Thyra::VectorBase< Scalar > > &X, const Teuchos::RCP< const Thyra::VectorBase< Scalar > > &Y, Scalar time, Scalar stepSize, Scalar stageNumber, const Teuchos::RCP< Thyra::VectorBase< Scalar > > &G) const
virtual Teuchos::RCP< const RKButcherTableau< Scalar > > getExplicitTableau() const
Return explicit tableau.
void setOrder(Scalar order)
SolutionHistory is basically a container of SolutionStates. SolutionHistory maintains a collection of...
virtual void setExplicitTableau(Teuchos::RCP< const RKButcherTableau< Scalar > > explicitTableau)
Set the explicit tableau from tableau.
virtual bool isValidSetup(Teuchos::FancyOStream &out) const
Stepper integrates first-order ODEs.
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar > > > & getStageF()
virtual bool isOneStepMethod() const
virtual void initialize(Scalar s, Teuchos::RCP< const Thyra::VectorBase< Scalar > > xTilde)
virtual Teuchos::RCP< const RKButcherTableau< Scalar > > getTableau() const
Returns the explicit tableau!
Teuchos::RCP< const RKButcherTableau< Scalar > > explicitTableau_
This interface defines the time derivative connection between an implicit Stepper and WrapperModelEva...
virtual Scalar getBeta(const Scalar) const
Return beta = d(x)/dx.
virtual void setImplicitTableau(Teuchos::RCP< const RKButcherTableau< Scalar > > implicitTableau)
Set the implicit tableau from tableau.
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar > > > stageGx_
Teuchos::RCP< const Thyra::VectorBase< Scalar > > xTilde_
Time-derivative interface for Partitioned IMEX RK.
virtual void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
virtual void setModel(const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel)
Set the model.
Teuchos::RCP< StepperIMEX_RK_Partition< Scalar > > createStepperIMEX_RK_Partition(const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &model, std::string stepperType, Teuchos::RCP< Teuchos::ParameterList > pl)
Nonmember constructor - ModelEvaluator and ParameterList.
virtual void setTableausPartition(Teuchos::RCP< Teuchos::ParameterList > pl, std::string stepperType)
virtual Scalar getOrder() const
virtual void takeStep(const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory)
Take the specified timestep, dt, and return true if successful.
virtual Scalar getOrderMin() const
virtual void setInitialConditions(const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory)
Set the initial conditions and make them consistent.
Teuchos::RCP< Thyra::VectorBase< Scalar > > & getXTilde()
virtual void initialize()
Initialize during construction and after changing input parameters.
virtual bool isMultiStepMethod() const
virtual void compute(Teuchos::RCP< const Thyra::VectorBase< Scalar > > x, Teuchos::RCP< Thyra::VectorBase< Scalar > > xDot, Teuchos::RCP< Thyra::VectorBase< Scalar > > xDotDot=Teuchos::null)
Compute the time derivative.