| 
    Tempus
    Version of the Day
    
   Time Integration 
   | 
 
RK Explicit Trapezoidal. More...
#include <Tempus_StepperRKButcherTableau.hpp>

Public Member Functions | |
| StepperERK_Trapezoidal () | |
| Default constructor.  More... | |
| StepperERK_Trapezoidal (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel, bool useFSAL, std::string ICConsistency, bool ICConsistencyCheck, bool useEmbedded, const Teuchos::RCP< StepperRKAppAction< Scalar > > &stepperRKAppAction) | |
| std::string | getDescription () const | 
  Public Member Functions inherited from Tempus::StepperExplicitRK< Scalar > | |
| virtual Teuchos::RCP< const  Teuchos::ParameterList >  | getValidParameters () const | 
| Teuchos::RCP < Teuchos::ParameterList >  | getValidParametersBasicERK () const | 
| virtual bool | isValidSetup (Teuchos::FancyOStream &out) const | 
| virtual void | initialize () | 
| Initialize during construction and after changing input parameters.  More... | |
| virtual void | setInitialConditions (const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory) | 
| Set the initial conditions and make them consistent.  More... | |
| 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 Scalar | getInitTimeStep (const Teuchos::RCP< SolutionHistory< Scalar > > &solutionHistory) const | 
| virtual bool | isExplicit () const | 
| virtual bool | isImplicit () const | 
| virtual bool | isExplicitImplicit () const | 
| virtual bool | isOneStepMethod () const | 
| virtual bool | isMultiStepMethod () const | 
| virtual OrderODE | getOrderODE () const | 
| virtual void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const | 
  Public Member Functions inherited from Tempus::StepperExplicit< Scalar > | |
| void | setStepperExplicitValues (Teuchos::RCP< Teuchos::ParameterList > pl) | 
| Set StepperExplicit member data from the ParameterList.  More... | |
| virtual void | setModel (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel) | 
| virtual Teuchos::RCP< const  Thyra::ModelEvaluator< Scalar > >  | getModel () | 
| virtual void | setSolver (Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > solver) | 
| Set solver.  More... | |
| virtual Teuchos::RCP < Thyra::NonlinearSolverBase < Scalar > >  | getSolver () const | 
| Get solver.  More... | |
| virtual void | setInitialGuess (Teuchos::RCP< const Thyra::VectorBase< Scalar > >) | 
| Pass initial guess to Newton solver (only relevant for implicit solvers)  More... | |
| virtual void | evaluateExplicitODE (Teuchos::RCP< Thyra::VectorBase< Scalar > > xDot, Teuchos::RCP< const Thyra::VectorBase< Scalar > > x, const Scalar time, const Teuchos::RCP< ExplicitODEParameters< Scalar > > &p) | 
| Evaluate xDot = f(x,t).  More... | |
| virtual void | evaluateExplicitODE (Teuchos::RCP< Thyra::VectorBase< Scalar > > xDotDot, Teuchos::RCP< const Thyra::VectorBase< Scalar > > x, Teuchos::RCP< const Thyra::VectorBase< Scalar > > xDot, const Scalar time, const Teuchos::RCP< ExplicitODEParameters< Scalar > > &p) | 
| Evaluate xDotDot = f(x, xDot, t).  More... | |
  Public Member Functions inherited from Tempus::Stepper< Scalar > | |
| void | setStepperValues (const Teuchos::RCP< Teuchos::ParameterList > pl) | 
| Set Stepper member data from ParameterList.  More... | |
| Teuchos::RCP < Teuchos::ParameterList >  | getValidParametersBasic () const | 
| Add basic parameters to Steppers ParameterList.  More... | |
| 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 | setStepperName (std::string s) | 
| Set the stepper name.  More... | |
| std::string | getStepperName () const | 
| Get the stepper name.  More... | |
| std::string | getStepperType () const | 
| Get the stepper type. The stepper type is used as an identifier for the stepper, and can only be set by the derived Stepper class.  More... | |
| virtual void | setUseFSAL (bool a) | 
| void | setUseFSALTrueOnly (bool a) | 
| void | setUseFSALFalseOnly (bool a) | 
| bool | getUseFSAL () const | 
| void | setICConsistency (std::string s) | 
| std::string | getICConsistency () const | 
| void | setICConsistencyCheck (bool c) | 
| bool | getICConsistencyCheck () const | 
| virtual Teuchos::RCP < Thyra::VectorBase< Scalar > >  | getStepperX () | 
| Get Stepper x.  More... | |
| virtual Teuchos::RCP < Thyra::VectorBase< Scalar > >  | getStepperXDot () | 
| Get Stepper xDot.  More... | |
| virtual Teuchos::RCP < Thyra::VectorBase< Scalar > >  | getStepperXDotDot () | 
| Get Stepper xDotDot.  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 | 
  Public Member Functions inherited from Teuchos::Describable | |
| 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) | 
  Public Member Functions inherited from Teuchos::VerboseObject< Stepper< Scalar > > | |
| VerboseObject (const EVerbosityLevel verbLevel=VERB_DEFAULT, const RCP< FancyOStream > &oStream=Teuchos::null) | |
| virtual const VerboseObject & | setVerbLevel (const EVerbosityLevel verbLevel) const | 
| virtual const VerboseObject & | setOverridingVerbLevel (const EVerbosityLevel verbLevel) const | 
| virtual EVerbosityLevel | getVerbLevel () const | 
| TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT  RCP< const ParameterList >  | getValidVerboseObjectSublist () | 
| TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT  void  | setupVerboseObjectSublist (ParameterList *paramList) | 
| TEUCHOSPARAMETERLIST_LIB_DLL_EXPORT  void  | readVerboseObjectSublist (ParameterList *paramList, RCP< FancyOStream > *oStream, EVerbosityLevel *verbLevel) | 
| void | readVerboseObjectSublist (ParameterList *paramList, VerboseObject< ObjectType > *verboseObject) | 
  Public Member Functions inherited from Teuchos::VerboseObjectBase | |
| virtual | ~VerboseObjectBase () | 
| VerboseObjectBase (const RCP< FancyOStream > &oStream=Teuchos::null) | |
| virtual const VerboseObjectBase & | setOStream (const RCP< FancyOStream > &oStream) const | 
| virtual const VerboseObjectBase & | setOverridingOStream (const RCP< FancyOStream > &oStream) const | 
| virtual VerboseObjectBase & | setLinePrefix (const std::string &linePrefix) | 
| virtual RCP< FancyOStream > | getOStream () const | 
| virtual RCP< FancyOStream > | getOverridingOStream () const | 
| virtual std::string | getLinePrefix () const | 
| virtual OSTab | getOSTab (const int tabs=1, const std::string &linePrefix="") const | 
  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 void | setUseEmbedded (bool a) | 
| virtual bool | getUseEmbedded () const | 
| virtual void | setAppAction (Teuchos::RCP< StepperRKAppAction< Scalar > > appAction) | 
| virtual Teuchos::RCP < StepperRKAppAction< Scalar > >  | getAppAction () const | 
| virtual void | setStepperRKValues (Teuchos::RCP< Teuchos::ParameterList > pl) | 
| Set StepperRK member data from the ParameterList.  More... | |
| virtual Teuchos::RCP < RKButcherTableau< Scalar > >  | createTableau (Teuchos::RCP< Teuchos::ParameterList > pl) | 
Protected Member Functions | |
| void | setupTableau () | 
  Protected Member Functions inherited from Tempus::StepperExplicitRK< Scalar > | |
| virtual void | setupDefault () | 
| Default setup for constructor.  More... | |
| 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.  More... | |
  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... | |
| void | setStepperType (std::string s) | 
| Set the stepper type.  More... | |
  Protected Member Functions inherited from Teuchos::VerboseObject< Stepper< Scalar > > | |
| void | initializeVerboseObject (const EVerbosityLevel verbLevel=VERB_DEFAULT, const RCP< FancyOStream > &oStream=Teuchos::null) | 
  Protected Member Functions inherited from Teuchos::VerboseObjectBase | |
| void | initializeVerboseObjectBase (const RCP< FancyOStream > &oStream=Teuchos::null) | 
| virtual void | informUpdatedVerbosityState () const | 
Additional Inherited Members | |
  Static Public Member Functions inherited from Teuchos::VerboseObject< Stepper< Scalar > > | |
| static void | setDefaultVerbLevel (const EVerbosityLevel defaultVerbLevel) | 
| static EVerbosityLevel | getDefaultVerbLevel () | 
  Static Public Member Functions inherited from Teuchos::VerboseObjectBase | |
| static void | setDefaultOStream (const RCP< FancyOStream > &defaultOStream) | 
| static RCP< FancyOStream > | getDefaultOStream () | 
  Static Public Attributes inherited from Teuchos::Describable | |
| static const EVerbosityLevel | verbLevel_default | 
  Protected Attributes inherited from Tempus::StepperExplicitRK< Scalar > | |
| std::vector< Teuchos::RCP < Thyra::VectorBase< Scalar > > >  | stageXDot_ | 
  Protected Attributes inherited from Tempus::StepperExplicit< Scalar > | |
| Teuchos::RCP< const  Thyra::ModelEvaluator< Scalar > >  | appModel_ | 
| Explicit ODE ModelEvaluator.  More... | |
| Thyra::ModelEvaluatorBase::InArgs < Scalar >  | inArgs_ | 
| Thyra::ModelEvaluatorBase::OutArgs < Scalar >  | outArgs_ | 
  Protected Attributes inherited from Tempus::Stepper< Scalar > | |
| bool | useFSAL_ = false | 
| Use First-Same-As-Last (FSAL) principle.  More... | |
| bool | isInitialized_ = false | 
| True if stepper's member data is initialized.  More... | |
  Protected Attributes inherited from Tempus::StepperRKBase< Scalar > | |
| Teuchos::RCP< RKButcherTableau < Scalar > >  | tableau_ | 
| 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 | 
| int | stageNumber_ | 
| The current Runge-Kutta stage number, {0,...,s-1}. -1 indicates outside stage loop.  More... | |
| Teuchos::RCP < StepperRKAppAction< Scalar > >  | stepperRKAppAction_ | 
RK Explicit Trapezoidal.
The tableau (order=2) is
Definition at line 1645 of file Tempus_StepperRKButcherTableau.hpp.
      
  | 
  inline | 
Default constructor.
Requires subsequent setModel() and initialize() calls before calling takestep().
Definition at line 1654 of file Tempus_StepperRKButcherTableau.hpp.
      
  | 
  inline | 
Definition at line 1665 of file Tempus_StepperRKButcherTableau.hpp.
      
  | 
  inlinevirtual | 
Implements Tempus::StepperExplicitRK< Scalar >.
Definition at line 1680 of file Tempus_StepperRKButcherTableau.hpp.
      
  | 
  inlineprotectedvirtual | 
Implements Tempus::StepperExplicitRK< Scalar >.
Definition at line 1695 of file Tempus_StepperRKButcherTableau.hpp.
 1.8.5