Tempus
Version of the Day
Time Integration
|
General Implicit Runge-Kutta Butcher Tableau. More...
#include <Tempus_StepperRKButcherTableau.hpp>
Public Member Functions | |
StepperDIRK_General () | |
Default constructor. More... | |
StepperDIRK_General (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel, const Teuchos::RCP< StepperRKObserverComposite< Scalar > > &obs, const Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > &solver, bool useFSAL, std::string ICConsistency, bool ICConsistencyCheck, bool useEmbedded, bool zeroInitialGuess, const Teuchos::SerialDenseMatrix< int, Scalar > &A, const Teuchos::SerialDenseVector< int, Scalar > &b, const Teuchos::SerialDenseVector< int, Scalar > &c, const int order, const int orderMin, const int orderMax, const Teuchos::SerialDenseVector< int, Scalar > &bstar) | |
StepperDIRK_General (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel, const Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > &solver, bool useFSAL, std::string ICConsistency, bool ICConsistencyCheck, bool useEmbedded, bool zeroInitialGuess, const Teuchos::RCP< StepperRKAppAction< Scalar > > &stepperRKAppAction, const Teuchos::SerialDenseMatrix< int, Scalar > &A, const Teuchos::SerialDenseVector< int, Scalar > &b, const Teuchos::SerialDenseVector< int, Scalar > &c, const int order, const int orderMin, const int orderMax, const Teuchos::SerialDenseVector< int, Scalar > &bstar) | |
std::string | getDescription () const |
virtual bool | getICConsistencyCheckDefault () const |
void | setupTableau () |
void | setTableau (const Teuchos::SerialDenseMatrix< int, Scalar > &A, const Teuchos::SerialDenseVector< int, Scalar > &b, const Teuchos::SerialDenseVector< int, Scalar > &c, const int order, const int orderMin, const int orderMax, const Teuchos::SerialDenseVector< int, Scalar > &bstar=Teuchos::SerialDenseVector< int, Scalar >()) |
Teuchos::RCP< const Teuchos::ParameterList > | getValidParameters () const |
Public Member Functions inherited from Tempus::StepperDIRK< Scalar > | |
std::vector< Teuchos::RCP < Thyra::VectorBase< Scalar > > > & | getStageXDot () |
Teuchos::RCP < Thyra::VectorBase< Scalar > > & | getXTilde () |
virtual Scalar | getAlpha (const Scalar dt) const |
Return alpha = d(xDot)/dx. More... | |
virtual Scalar | getBeta (const Scalar) const |
Return beta = d(x)/dx. More... | |
virtual bool | isValidSetup (Teuchos::FancyOStream &out) const |
virtual void | setObserver (Teuchos::RCP< StepperObserver< Scalar > > obs=Teuchos::null) |
Set Observer. More... | |
virtual Teuchos::RCP < StepperObserver< Scalar > > | getObserver () const |
Get Observer. More... | |
virtual void | initialize () |
Initialize after construction and changing input parameters. More... | |
virtual void | setInitialConditions (const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory) |
Set the initial conditions and make them consistent. More... | |
virtual void | setResetInitialGuess (bool reset_guess) |
Set parameter so that the initial guess is reset at the beginning of each timestep. More... | |
virtual bool | getResetInitialGuess () const |
virtual void | takeStep (const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory) |
Take the specified timestep, dt, and return true if successful. More... | |
virtual Teuchos::RCP < Tempus::StepperState< Scalar > > | getDefaultStepperState () |
Get a default (initial) StepperState. More... | |
virtual bool | isExplicit () const |
virtual bool | isImplicit () const |
virtual bool | isExplicitImplicit () const |
virtual bool | isOneStepMethod () const |
virtual bool | isMultiStepMethod () const |
virtual OrderODE | getOrderODE () const |
void | getValidParametersBasicDIRK (Teuchos::RCP< Teuchos::ParameterList > pl) const |
virtual void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const |
virtual void | setUseEmbedded (bool a) |
Use embedded if avialable. More... | |
virtual bool | getUseEmbedded () const |
virtual bool | getUseEmbeddedDefault () const |
Public Member Functions inherited from Tempus::StepperImplicit< Scalar > | |
virtual void | setModel (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel) |
virtual Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > | getModel () |
virtual Teuchos::RCP< const WrapperModelEvaluator< Scalar > > | getWrapperModel () |
virtual void | setDefaultSolver () |
virtual void | setSolver (Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > solver) |
Set solver. More... | |
virtual Teuchos::RCP < Thyra::NonlinearSolverBase < Scalar > > | getSolver () const |
Get solver. More... | |
const Thyra::SolveStatus< Scalar > | solveImplicitODE (const Teuchos::RCP< Thyra::VectorBase< Scalar > > &x) |
Solve problem using x in-place. (Needs to be deprecated!) More... | |
const Thyra::SolveStatus< Scalar > | solveImplicitODE (const Teuchos::RCP< Thyra::VectorBase< Scalar > > &x, const Teuchos::RCP< Thyra::VectorBase< Scalar > > &xDot, const Scalar time, const Teuchos::RCP< ImplicitODEParameters< Scalar > > &p) |
Solve implicit ODE, f(x, xDot, t, p) = 0. More... | |
void | evaluateImplicitODE (Teuchos::RCP< Thyra::VectorBase< Scalar > > &f, const Teuchos::RCP< Thyra::VectorBase< Scalar > > &x, const Teuchos::RCP< Thyra::VectorBase< Scalar > > &xDot, const Scalar time, const Teuchos::RCP< ImplicitODEParameters< Scalar > > &p) |
Evaluate implicit ODE residual, f(x, xDot, t, p). More... | |
virtual void | setInitialGuess (Teuchos::RCP< const Thyra::VectorBase< Scalar > > initialGuess) |
Pass initial guess to Newton solver (only relevant for implicit solvers) More... | |
virtual void | setZeroInitialGuess (bool zIG) |
Set parameter so that the initial guess is set to zero (=True) or use last timestep (=False). More... | |
virtual bool | getZeroInitialGuess () const |
virtual Scalar | getInitTimeStep (const Teuchos::RCP< SolutionHistory< Scalar > > &) const |
Public Member Functions inherited from Tempus::Stepper< Scalar > | |
virtual void | setNonConstModel (const Teuchos::RCP< Thyra::ModelEvaluator< Scalar > > &) |
virtual bool | isInitialized () |
True if stepper's member data is initialized. More... | |
virtual void | checkInitialized () |
Check initialization, and error out on failure. More... | |
void | setStepperType (std::string s) |
std::string | getStepperType () const |
void | setUseFSAL (bool a) |
bool | getUseFSAL () const |
virtual bool | getUseFSALDefault () const |
void | setICConsistency (std::string s) |
std::string | getICConsistency () const |
virtual std::string | getICConsistencyDefault () const |
void | setICConsistencyCheck (bool c) |
bool | getICConsistencyCheck () const |
virtual Teuchos::RCP < Thyra::VectorBase< Scalar > > | getStepperX (Teuchos::RCP< SolutionState< Scalar > > state) |
Get x from SolutionState or Stepper storage. More... | |
virtual Teuchos::RCP < Thyra::VectorBase< Scalar > > | getStepperXDot (Teuchos::RCP< SolutionState< Scalar > > state) |
Get xDot from SolutionState or Stepper storage. More... | |
virtual Teuchos::RCP < Thyra::VectorBase< Scalar > > | getStepperXDotDot (Teuchos::RCP< SolutionState< Scalar > > state) |
Get xDotDot from SolutionState or Stepper storage. More... | |
virtual std::string | description () const |
virtual void | createSubSteppers (std::vector< Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > >) |
Public Member Functions inherited from Tempus::StepperRKBase< Scalar > | |
virtual Teuchos::RCP< const RKButcherTableau< Scalar > > | getTableau () const |
virtual Scalar | getOrder () const |
virtual Scalar | getOrderMin () const |
virtual Scalar | getOrderMax () const |
virtual int | getNumberOfStages () const |
virtual int | getStageNumber () const |
virtual void | setStageNumber (int s) |
virtual Teuchos::RCP < Thyra::VectorBase< Scalar > > | getStageX () |
virtual Teuchos::RCP< const Thyra::VectorBase< Scalar > > | getStageX () const |
virtual void | setAppAction (Teuchos::RCP< StepperRKAppAction< Scalar > > appAction) |
virtual Teuchos::RCP < StepperRKAppAction< Scalar > > | getAppAction () const |
Additional Inherited Members | |
Protected Member Functions inherited from Tempus::StepperDIRK< Scalar > | |
virtual void | setupDefault () |
Default setup for constructor. More... | |
virtual void | setup (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &wrapperModel, const Teuchos::RCP< StepperRKObserver< Scalar > > &obs, const Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > &solver, bool useFSAL, std::string ICConsistency, bool ICConsistencyCheck, bool useEmbedded, bool zeroInitialGuess) |
Setup for constructor. More... | |
virtual void | setup (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &wrapperModel, const Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > &solver, bool useFSAL, std::string ICConsistency, bool ICConsistencyCheck, bool useEmbedded, bool zeroInitialGuess, const Teuchos::RCP< StepperRKAppAction< Scalar > > &stepperRKAppAction) |
Protected Member Functions inherited from Tempus::Stepper< Scalar > | |
virtual void | setStepperX (Teuchos::RCP< Thyra::VectorBase< Scalar > > x) |
Set x for Stepper storage. More... | |
virtual void | setStepperXDot (Teuchos::RCP< Thyra::VectorBase< Scalar > > xDot) |
Set xDot for Stepper storage. More... | |
virtual void | setStepperXDotDot (Teuchos::RCP< Thyra::VectorBase< Scalar > > xDotDot) |
Set x for Stepper storage. More... | |
Protected Attributes inherited from Tempus::StepperDIRK< Scalar > | |
std::vector< Teuchos::RCP < Thyra::VectorBase< Scalar > > > | stageXDot_ |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | xTilde_ |
Teuchos::RCP < StepperRKObserverComposite < Scalar > > | stepperObserver_ |
bool | useEmbedded_ |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | ee_ |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | abs_u0 |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | abs_u |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | sc |
bool | resetGuess_ = true |
Protected Attributes inherited from Tempus::StepperImplicit< Scalar > | |
Teuchos::RCP < WrapperModelEvaluator < Scalar > > | wrapperModel_ |
Teuchos::RCP < Thyra::NonlinearSolverBase < Scalar > > | solver_ |
Teuchos::RCP< const Thyra::VectorBase< Scalar > > | initialGuess_ |
bool | zeroInitialGuess_ |
Teuchos::RCP< StepperObserver < Scalar > > | stepperObserver_ |
Protected Attributes inherited from Tempus::Stepper< Scalar > | |
bool | isInitialized_ = false |
True if stepper's member data is initialized. More... | |
Protected Attributes inherited from Tempus::StepperRKBase< Scalar > | |
Teuchos::RCP< RKButcherTableau < Scalar > > | tableau_ |
int | stageNumber_ |
The current Runge-Kutta stage number, {0,...,s-1}. -1 indicates outside stage loop. More... | |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | stageX_ |
Teuchos::RCP < StepperRKAppAction< Scalar > > | stepperRKAppAction_ |
General Implicit Runge-Kutta Butcher Tableau.
The format of the Butcher Tableau parameter list is
<Parameter name="A" type="string" value="# # # ; # # # ; # # #"> <Parameter name="b" type="string" value="# # #"> <Parameter name="c" type="string" value="# # #">
Note the number of stages is implicit in the number of entries. The number of stages must be consistent.
Default tableau is "SDIRK 2 Stage 2nd order":
where . This will produce an L-stable 2nd order method.
Reference: U. M. Ascher and L. R. Petzold, Computer Methods for ODEs and DAEs, p. 106.
Definition at line 4688 of file Tempus_StepperRKButcherTableau.hpp.
|
inline |
Default constructor.
Requires subsequent setModel() and initialize() calls before calling takestep().
Definition at line 4697 of file Tempus_StepperRKButcherTableau.hpp.
|
inline |
Definition at line 4705 of file Tempus_StepperRKButcherTableau.hpp.
|
inline |
Definition at line 4733 of file Tempus_StepperRKButcherTableau.hpp.
|
inlinevirtual |
Implements Tempus::StepperDIRK< Scalar >.
Definition at line 4761 of file Tempus_StepperRKButcherTableau.hpp.
|
inlinevirtual |
Reimplemented from Tempus::Stepper< Scalar >.
Definition at line 4786 of file Tempus_StepperRKButcherTableau.hpp.
|
inlinevirtual |
Reimplemented from Tempus::StepperDIRK< Scalar >.
Definition at line 4818 of file Tempus_StepperRKButcherTableau.hpp.
|
inline |
Definition at line 4803 of file Tempus_StepperRKButcherTableau.hpp.
|
inlinevirtual |
Implements Tempus::StepperDIRK< Scalar >.
Definition at line 4788 of file Tempus_StepperRKButcherTableau.hpp.