9 #ifndef Tempus_StepperExplicitRK_impl_hpp
10 #define Tempus_StepperExplicitRK_impl_hpp
12 #include "Thyra_VectorStdOps.hpp"
21 template<
class Scalar>
24 this->setUseEmbedded(
false);
25 this->setStageNumber(-1);
26 this->setAppAction(Teuchos::null);
30 template<
class Scalar>
34 std::string ICConsistency,
35 bool ICConsistencyCheck,
39 this->setUseFSAL( useFSAL);
40 this->setICConsistency( ICConsistency);
41 this->setICConsistencyCheck( ICConsistencyCheck);
42 this->setUseEmbedded( useEmbedded);
43 this->setStageNumber(-1);
46 this->setAppAction(stepperRKAppAction);
48 if (appModel != Teuchos::null) {
49 this->setModel(appModel);
55 template<
class Scalar>
60 Scalar dt = Scalar(1.0e+99);
61 if (!this->getUseEmbedded())
return dt;
64 const int order = currentState->getOrder();
65 const Scalar time = currentState->getTime();
66 const Scalar errorRel = currentState->getTolRel();
67 const Scalar errorAbs = currentState->getTolAbs();
70 stageX = Thyra::createMember(this->appModel_->get_f_space());
71 scratchX = Thyra::createMember(this->appModel_->get_f_space());
72 Thyra::assign(stageX.
ptr(), *(currentState->getX()));
74 std::vector<Teuchos::RCP<Thyra::VectorBase<Scalar> > > stageXDot(2);
75 for (
int i=0; i<2; ++i) {
76 stageXDot[i] = Thyra::createMember(this->appModel_->get_f_space());
82 MEB::InArgs<Scalar> inArgs = this->appModel_->getNominalValues();
83 MEB::OutArgs<Scalar> outArgs = this->appModel_->createOutArgs();
85 if (inArgs.supports(MEB::IN_ARG_t)) inArgs.set_t(time);
86 if (inArgs.supports(MEB::IN_ARG_x_dot)) inArgs.set_x_dot(Teuchos::null);
87 outArgs.set_f(stageXDot[0]);
88 this->appModel_->evalModel(inArgs, outArgs);
90 this->stepperErrorNormCalculator_->setRelativeTolerance(errorRel);
91 this->stepperErrorNormCalculator_->setAbsoluteTolerance(errorAbs);
93 Scalar d0 = this->stepperErrorNormCalculator_->errorNorm(stageX);
94 Scalar d1 = this->stepperErrorNormCalculator_->errorNorm(stageXDot[0]);
97 dt = Teuchos::as<Scalar>(0.01)*(d0/d1);
100 Thyra::Vp_StV(stageX.
ptr(), dt, *(stageXDot[0]));
103 inArgs.set_x(stageX);
104 if (inArgs.supports(MEB::IN_ARG_t)) inArgs.set_t(time + dt);
105 if (inArgs.supports(MEB::IN_ARG_x_dot)) inArgs.set_x_dot(Teuchos::null);
106 outArgs.set_f(stageXDot[1]);
107 this->appModel_->evalModel(inArgs, outArgs);
112 errX = Thyra::createMember(this->appModel_->get_f_space());
114 Thyra::V_VmV(errX.
ptr(), *(stageXDot[1]), *(stageXDot[0]));
115 Scalar d2 = this->stepperErrorNormCalculator_->errorNorm(errX) / dt;
118 Scalar max_d1_d2 = std::max(d1, d2);
119 Scalar h1 = std::pow((0.01/max_d1_d2),(1.0/(order+1)));
122 dt = std::min(100*dt, h1);
127 template<
class Scalar>
131 return this->getValidParametersBasicERK();
135 template<
class Scalar>
139 auto pl = this->getValidParametersBasic();
140 pl->template set<bool>(
"Use Embedded", this->getUseEmbedded(),
141 "'Whether to use Embedded Stepper (if available) or not\n"
142 " 'true' - Stepper will compute embedded solution and is adaptive.\n"
143 " 'false' - Stepper is not embedded(adaptive).\n");
144 pl->template set<std::string>(
"Description", this->getDescription());
150 template<
class Scalar>
154 "Error - Need to set the tableau, before calling "
155 "StepperExplicitRK::initialize()\n");
158 "Error - Need to set the model, setModel(), before calling "
159 "StepperExplicitRK::initialize()\n");
165 template<
class Scalar>
172 int numStages = this->tableau_->numStages();
173 stageXDot_.resize(numStages);
174 for (
int i=0; i<numStages; ++i) {
175 stageXDot_[i] = Thyra::createMember(this->appModel_->get_f_space());
179 this->setEmbeddedMemory();
180 this->setErrorNorm();
182 this->isInitialized_ =
false;
186 template<
class Scalar>
189 if (this->getModel() == Teuchos::null)
192 if ( this->tableau_->isEmbedded() && this->getUseEmbedded() ){
193 this->ee_ = Thyra::createMember(this->appModel_->get_f_space());
194 this->abs_u0 = Thyra::createMember(this->appModel_->get_f_space());
195 this->abs_u = Thyra::createMember(this->appModel_->get_f_space());
196 this->sc = Thyra::createMember(this->appModel_->get_f_space());
198 this->ee_ = Teuchos::null;
199 this->abs_u0 = Teuchos::null;
200 this->abs_u = Teuchos::null;
201 this->sc = Teuchos::null;
206 template<
class Scalar>
210 if (this->getUseFSAL())
211 this->setStepperXDot(stageXDot_.back());
213 this->setStepperXDot(stageXDot_[0]);
217 auto xDot = solutionHistory->getCurrentState()->getXDot();
218 if (xDot != Teuchos::null && this->getUseFSAL())
219 Thyra::assign(this->getStepperXDot().ptr(), *(xDot));
223 template<
class Scalar>
227 this->checkInitialized();
231 TEMPUS_FUNC_TIME_MONITOR(
"Tempus::StepperExplicitRK::takeStep()");
235 "Error - StepperExplicitRK<Scalar>::takeStep(...)\n"
236 "Need at least two SolutionStates for ExplicitRK.\n"
237 " Number of States = " << solutionHistory->getNumStates() <<
"\n"
238 "Try setting in \"Solution History\" \"Storage Type\" = \"Undo\"\n"
239 " or \"Storage Type\" = \"Static\" and \"Storage Limit\" = \"2\"\n");
241 RCP<SolutionState<Scalar> > currentState=solutionHistory->getCurrentState();
242 RCP<SolutionState<Scalar> > workingState=solutionHistory->getWorkingState();
243 const Scalar dt = workingState->getTimeStep();
244 const Scalar time = currentState->getTime();
246 const int numStages = this->tableau_->numStages();
251 Thyra::assign(workingState->getX().ptr(), *(currentState->getX()));
253 RCP<StepperExplicitRK<Scalar> > thisStepper = Teuchos::rcpFromRef(*
this);
254 this->stepperRKAppAction_->execute(solutionHistory, thisStepper,
258 for (
int i=0; i < numStages; ++i) {
259 this->setStageNumber(i);
260 Thyra::assign(workingState->getX().ptr(), *(currentState->getX()));
261 for (
int j=0; j < i; ++j) {
263 Thyra::Vp_StV(workingState->getX().ptr(), dt*A(i,j), *stageXDot_[j]);
266 this->setStepperXDot(stageXDot_[i]);
268 this->stepperRKAppAction_->execute(solutionHistory, thisStepper,
270 this->stepperRKAppAction_->execute(solutionHistory, thisStepper,
272 this->stepperRKAppAction_->execute(solutionHistory, thisStepper,
274 this->stepperRKAppAction_->execute(solutionHistory, thisStepper,
277 if ( i == 0 && this->getUseFSAL() &&
278 workingState->getNConsecutiveFailures() == 0 ) {
279 RCP<Thyra::VectorBase<Scalar> > tmp = stageXDot_[0];
280 stageXDot_[0] = stageXDot_.back();
281 stageXDot_.back() = tmp;
282 this->setStepperXDot(stageXDot_[0]);
285 const Scalar ts = time + c(i)*dt;
289 this->evaluateExplicitODE(stageXDot_[i], workingState->getX(), ts, p);
292 this->stepperRKAppAction_->execute(solutionHistory, thisStepper,
296 this->setStageNumber(-1);
299 Thyra::assign((workingState->getX()).ptr(), *(currentState->getX()));
300 for (
int i=0; i < numStages; ++i) {
302 Thyra::Vp_StV((workingState->getX()).ptr(), dt*b(i), *(stageXDot_[i]));
306 if (this->getUseFSAL()) {
307 if (numStages == 1) {
308 const Scalar ts = time + dt;
311 this->evaluateExplicitODE(stageXDot_[0], workingState->getX(), ts, p);
313 if (workingState->getXDot() != Teuchos::null)
314 Thyra::assign((workingState->getXDot()).ptr(), *(stageXDot_.back()));
323 if (this->tableau_->isEmbedded() && this->getUseEmbedded()) {
325 const Scalar tolRel = workingState->getTolRel();
326 const Scalar tolAbs = workingState->getTolAbs();
329 this->stepperErrorNormCalculator_->setRelativeTolerance(tolRel);
330 this->stepperErrorNormCalculator_->setAbsoluteTolerance(tolAbs);
335 errWght -= this->tableau_->bstar();
340 for (
int i=0; i < numStages; ++i) {
342 Thyra::Vp_StV(this->ee_.ptr(), dt*errWght(i), *(stageXDot_[i]));
347 Scalar err = this->stepperErrorNormCalculator_->computeWRMSNorm(currentState->getX(), workingState->getX(), this->ee_);
348 workingState->setErrorRel(err);
351 if (std::isinf(err) || std::isnan(err) || err > Teuchos::as<Scalar>(1.0))
355 workingState->setOrder(this->getOrder());
356 workingState->computeNorms(currentState);
357 this->stepperRKAppAction_->execute(solutionHistory, thisStepper,
370 template<
class Scalar>
380 template<
class Scalar>
390 out <<
"--- StepperExplicitRK ---\n";
391 if (this->tableau_ != Teuchos::null) this->tableau_->describe(out, verbLevel);
392 out <<
" tableau_ = " << this->tableau_ << std::endl;
393 out <<
" stepperRKAppAction_= " << this->stepperRKAppAction_ << std::endl;
394 out <<
" stageXDot_.size() = " << stageXDot_.size() << std::endl;
395 const int numStages = stageXDot_.size();
396 for (
int i=0; i<numStages; ++i)
397 out <<
" stageXDot_["<<i<<
"] = " << stageXDot_[i] << std::endl;
398 out <<
" useEmbedded_ = "
400 out <<
" ee_ = " << this->ee_ << std::endl;
401 out <<
" abs_u0 = " << this->abs_u0 << std::endl;
402 out <<
" abs_u = " << this->abs_u << std::endl;
403 out <<
" sc = " << this->sc << std::endl;
404 out <<
"-------------------------" << std::endl;
408 template<
class Scalar>
412 bool isValidSetup =
true;
417 if (this->tableau_ == Teuchos::null) {
418 isValidSetup =
false;
419 out <<
"The tableau is not set!\n";
422 if (this->stepperRKAppAction_ == Teuchos::null) {
423 isValidSetup =
false;
424 out <<
"The AppAction is not set!\n";
432 #endif // Tempus_StepperExplicitRK_impl_hpp
virtual void setModel(const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel)
Set model.
virtual void setupDefault()
Default setup for constructor.
virtual Scalar getInitTimeStep(const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory) const
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
virtual void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
virtual void initialize()
Initialize after construction and changing input parameters.
virtual bool isValidSetup(Teuchos::FancyOStream &out) const
virtual void setInitialConditions(const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory)
Set the initial conditions and make them consistent.
Thyra Base interface for time steppers.
StepperState is a simple class to hold state information about the stepper.
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
virtual void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
Application Action for StepperRKBase.
virtual Teuchos::RCP< const Teuchos::ParameterList > getValidParameters() const
virtual void setInitialConditions(const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory)
Set the initial conditions, make them consistent, and set needed memory.
virtual void describe(Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
SolutionHistory is basically a container of SolutionStates. SolutionHistory maintains a collection of...
virtual void setModel(const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel)
Set model.
basic_FancyOStream & setOutputToRootOnly(const int rootRank)
Teuchos::RCP< Teuchos::ParameterList > getValidParametersBasicERK() const
virtual void takeStep(const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory)
Take the specified timestep, dt, and return true if successful.
virtual void initialize()
Initialize during construction and after changing input parameters.
virtual Teuchos::RCP< Tempus::StepperState< Scalar > > getDefaultStepperState()
Get a default (initial) StepperState.
virtual void setEmbeddedMemory()
Thyra Base interface for implicit time steppers.
std::string toString(const T &t)
virtual void setup(const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel, bool useFSAL, std::string ICConsistency, bool ICConsistencyCheck, bool useEmbedded, const Teuchos::RCP< StepperRKAppAction< Scalar > > &stepperRKAppAction)
Setup for constructor.