Tempus
Version of the Day
Time Integration
|
HHT-Alpha time stepper. More...
#include <Tempus_StepperHHTAlpha_decl.hpp>
Public Member Functions | |
StepperHHTAlpha () | |
Default constructor. More... | |
StepperHHTAlpha (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel, Teuchos::RCP< Teuchos::ParameterList > pList=Teuchos::null) | |
Constructor. More... | |
virtual Scalar | getW_xDotDot_coeff (const Scalar dt) const |
Return W_xDotxDot_coeff = d(xDotDot)/d(x). More... | |
virtual Scalar | getAlpha (const Scalar dt) const |
Return alpha = d(xDot)/d(x). More... | |
virtual Scalar | getBeta (const Scalar) const |
Return beta = d(x)/d(x). More... | |
void | predictVelocity (Thyra::VectorBase< Scalar > &vPred, const Thyra::VectorBase< Scalar > &v, const Thyra::VectorBase< Scalar > &a, const Scalar dt) const |
void | predictDisplacement (Thyra::VectorBase< Scalar > &dPred, const Thyra::VectorBase< Scalar > &d, const Thyra::VectorBase< Scalar > &v, const Thyra::VectorBase< Scalar > &a, const Scalar dt) const |
void | predictVelocity_alpha_f (Thyra::VectorBase< Scalar > &vPred, const Thyra::VectorBase< Scalar > &v) const |
void | predictDisplacement_alpha_f (Thyra::VectorBase< Scalar > &dPred, const Thyra::VectorBase< Scalar > &d) const |
void | correctAcceleration (Thyra::VectorBase< Scalar > &a_n_plus1, const Thyra::VectorBase< Scalar > &a_n) const |
void | correctVelocity (Thyra::VectorBase< Scalar > &v, const Thyra::VectorBase< Scalar > &vPred, const Thyra::VectorBase< Scalar > &a, const Scalar dt) const |
void | correctDisplacement (Thyra::VectorBase< Scalar > &d, const Thyra::VectorBase< Scalar > &dPred, const Thyra::VectorBase< Scalar > &a, const Scalar dt) const |
Basic stepper methods | |
virtual void | setModel (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &appModel) |
virtual void | setObserver (Teuchos::RCP< StepperObserver< Scalar > >=Teuchos::null) |
Set Observer. More... | |
virtual void | initialize () |
Initialize during construction and after changing input parameters. More... | |
virtual void | setInitialConditions (const Teuchos::RCP< SolutionHistory< Scalar > > &) |
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 | getOrder () const |
virtual Scalar | getOrderMin () const |
virtual Scalar | getOrderMax () 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 |
ParameterList methods | |
void | setParameterList (const Teuchos::RCP< Teuchos::ParameterList > &pl) |
Teuchos::RCP < Teuchos::ParameterList > | getNonconstParameterList () |
Teuchos::RCP < Teuchos::ParameterList > | unsetParameterList () |
Teuchos::RCP< const Teuchos::ParameterList > | getValidParameters () const |
Teuchos::RCP < Teuchos::ParameterList > | getDefaultParameters () const |
Overridden from Teuchos::Describable | |
virtual std::string | description () const |
virtual void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const |
Public Member Functions inherited from Tempus::StepperImplicit< Scalar > | |
virtual void | setNonConstModel (const Teuchos::RCP< Thyra::ModelEvaluator< Scalar > > &appModel) |
virtual Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > | getModel () |
virtual Teuchos::RCP< const WrapperModelEvaluator< Scalar > > | getWrapperModel () |
virtual void | setSolver (std::string solverName) |
Set solver via ParameterList solver name. More... | |
virtual void | setSolver (Teuchos::RCP< Teuchos::ParameterList > solverPL=Teuchos::null) |
Set solver via solver ParameterList. More... | |
virtual void | setSolver (Teuchos::RCP< Thyra::NonlinearSolverBase< Scalar > > solver) |
Set solver. More... | |
virtual Teuchos::RCP < Thyra::NonlinearSolverBase < Scalar > > | getSolver () const |
Get solver. More... | |
virtual std::string | getStepperType () const |
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, f(x, xDot, t, p), residual. More... | |
virtual void | setInitialGuess (Teuchos::RCP< const Thyra::VectorBase< Scalar > > initial_guess) |
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 |
virtual bool | getEmbedded () const |
virtual void | setUseFSAL (bool a) |
virtual bool | getUseFSAL () const |
virtual void | setICConsistency (std::string s) |
virtual std::string | getICConsistency () const |
virtual void | setICConsistencyCheck (bool c) |
virtual bool | getICConsistencyCheck () const |
virtual void | setStepperXDot (Teuchos::RCP< Thyra::VectorBase< Scalar > > xDot) |
Set xDot for 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... | |
Public Member Functions inherited from Tempus::Stepper< Scalar > | |
virtual void | modelWarning () const |
void | getValidParametersBasic (Teuchos::RCP< Teuchos::ParameterList > pl) const |
virtual void | createSubSteppers (std::vector< Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > >) |
void | validExplicitODE (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &model) const |
Validate that the model supports explicit ODE evaluation, f(x,t) [=xdot]. More... | |
void | validSecondOrderExplicitODE (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &model) const |
Validate that the model supports explicit second order ODE evaluation, f(x,xdot,t) [=xdotdot]. More... | |
void | validImplicitODE_DAE (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &model) const |
Validate ME supports implicit ODE/DAE evaluation, f(xdot,x,t) [= 0]. More... | |
void | validSecondOrderODE_DAE (const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > &model) const |
Validate ME supports 2nd order implicit ODE/DAE evaluation, f(xdotdot,xdot,x,t) [= 0]. More... | |
Teuchos::RCP < Teuchos::ParameterList > | defaultSolverParameters () const |
Private Attributes | |
Scalar | beta_ |
Scalar | gamma_ |
Scalar | alpha_f_ |
Scalar | alpha_m_ |
Teuchos::RCP < Teuchos::FancyOStream > | out_ |
Additional Inherited Members | |
Protected Attributes inherited from Tempus::StepperImplicit< Scalar > | |
Teuchos::RCP < Teuchos::ParameterList > | stepperPL_ |
Teuchos::RCP < WrapperModelEvaluator < Scalar > > | wrapperModel_ |
Teuchos::RCP < Thyra::NonlinearSolverBase < Scalar > > | solver_ |
Teuchos::RCP< const Thyra::VectorBase< Scalar > > | initial_guess_ |
Teuchos::RCP< StepperObserver < Scalar > > | stepperObserver_ |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | stepperXDot_ |
Teuchos::RCP < Thyra::VectorBase< Scalar > > | stepperXDotDot_ |
HHT-Alpha time stepper.
Here, we implement the HHT-Alpha scheme in predictor/corrector form; see equations (10) and (13)-(19) in: G.M. Hulbert, J. Chung, "Explicit time integration algorithms for structural dynamics with optimal numerical dissipation", Comput. Methods Appl. Mech. Engrg. 137 175-188 (1996).
There are four parameters in the scheme: , , and , all of which must be in the range . When , the scheme reduces to the Newmark Beta scheme (see Tempus::StepperNewmark for details). Like the Newmark Beta scheme, the HHT-Alpha scheme can be either first or second order accurate, and either explicit or implicit.
Although the general form of the scheme has been implemented in Tempus, it has only been verified for the case when (corresponding to the Newmark Beta) scheme, so other values for these parameters are not allowed at the present time. Also, note that, like the Newmark Beta stepper, the linear solve for the explicit version of this scheme has not been optimized (the mass matrix is not lumped).
The First-Step-As-Last (FSAL) principle is not used with the HHT-Alpha method.
Definition at line 44 of file Tempus_StepperHHTAlpha_decl.hpp.
Tempus::StepperHHTAlpha< Scalar >::StepperHHTAlpha | ( | ) |
Default constructor.
Definition at line 131 of file Tempus_StepperHHTAlpha_impl.hpp.
Tempus::StepperHHTAlpha< Scalar >::StepperHHTAlpha | ( | const Teuchos::RCP< const Thyra::ModelEvaluator< Scalar > > & | appModel, |
Teuchos::RCP< Teuchos::ParameterList > | pList = Teuchos::null |
||
) |
Constructor.
Definition at line 144 of file Tempus_StepperHHTAlpha_impl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::correctAcceleration | ( | Thyra::VectorBase< Scalar > & | a_n_plus1, |
const Thyra::VectorBase< Scalar > & | a_n | ||
) | const |
Definition at line 88 of file Tempus_StepperHHTAlpha_impl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::correctDisplacement | ( | Thyra::VectorBase< Scalar > & | d, |
const Thyra::VectorBase< Scalar > & | dPred, | ||
const Thyra::VectorBase< Scalar > & | a, | ||
const Scalar | dt | ||
) | const |
Definition at line 117 of file Tempus_StepperHHTAlpha_impl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::correctVelocity | ( | Thyra::VectorBase< Scalar > & | v, |
const Thyra::VectorBase< Scalar > & | vPred, | ||
const Thyra::VectorBase< Scalar > & | a, | ||
const Scalar | dt | ||
) | const |
Definition at line 103 of file Tempus_StepperHHTAlpha_impl.hpp.
|
virtual |
Definition at line 343 of file Tempus_StepperHHTAlpha_impl.hpp.
|
virtual |
Definition at line 332 of file Tempus_StepperHHTAlpha_impl.hpp.
|
inlinevirtual |
Return alpha = d(xDot)/d(x).
Implements Tempus::StepperImplicit< Scalar >.
Definition at line 104 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Return beta = d(x)/d(x).
Implements Tempus::StepperImplicit< Scalar >.
Definition at line 106 of file Tempus_StepperHHTAlpha_decl.hpp.
|
virtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 484 of file Tempus_StepperHHTAlpha_impl.hpp.
|
virtual |
Get a default (initial) StepperState.
Provide a StepperState to the SolutionState. This Stepper does not have any special state data, so just provide the base class StepperState with the Stepper description. This can be checked to ensure that the input StepperState can be used by this Stepper.
Implements Tempus::Stepper< Scalar >.
Definition at line 320 of file Tempus_StepperHHTAlpha_impl.hpp.
Teuchos::RCP< Teuchos::ParameterList > Tempus::StepperHHTAlpha< Scalar >::getNonconstParameterList | ( | ) |
Definition at line 506 of file Tempus_StepperHHTAlpha_impl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 83 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 88 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 87 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 97 of file Tempus_StepperHHTAlpha_decl.hpp.
Teuchos::RCP< const Teuchos::ParameterList > Tempus::StepperHHTAlpha< Scalar >::getValidParameters | ( | ) | const |
Definition at line 467 of file Tempus_StepperHHTAlpha_impl.hpp.
|
inlinevirtual |
Return W_xDotxDot_coeff = d(xDotDot)/d(x).
Definition at line 101 of file Tempus_StepperHHTAlpha_decl.hpp.
|
virtual |
Initialize during construction and after changing input parameters.
Implements Tempus::Stepper< Scalar >.
Definition at line 181 of file Tempus_StepperHHTAlpha_impl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 90 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 92 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 91 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 95 of file Tempus_StepperHHTAlpha_decl.hpp.
|
inlinevirtual |
Implements Tempus::Stepper< Scalar >.
Definition at line 94 of file Tempus_StepperHHTAlpha_decl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::predictDisplacement | ( | Thyra::VectorBase< Scalar > & | dPred, |
const Thyra::VectorBase< Scalar > & | d, | ||
const Thyra::VectorBase< Scalar > & | v, | ||
const Thyra::VectorBase< Scalar > & | a, | ||
const Scalar | dt | ||
) | const |
Definition at line 42 of file Tempus_StepperHHTAlpha_impl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::predictDisplacement_alpha_f | ( | Thyra::VectorBase< Scalar > & | dPred, |
const Thyra::VectorBase< Scalar > & | d | ||
) | const |
Definition at line 76 of file Tempus_StepperHHTAlpha_impl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::predictVelocity | ( | Thyra::VectorBase< Scalar > & | vPred, |
const Thyra::VectorBase< Scalar > & | v, | ||
const Thyra::VectorBase< Scalar > & | a, | ||
const Scalar | dt | ||
) | const |
Definition at line 28 of file Tempus_StepperHHTAlpha_impl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::predictVelocity_alpha_f | ( | Thyra::VectorBase< Scalar > & | vPred, |
const Thyra::VectorBase< Scalar > & | v | ||
) | const |
Definition at line 63 of file Tempus_StepperHHTAlpha_impl.hpp.
|
inlinevirtual |
Set the initial conditions and make them consistent.
Reimplemented from Tempus::StepperImplicit< Scalar >.
Definition at line 74 of file Tempus_StepperHHTAlpha_decl.hpp.
|
virtual |
Reimplemented from Tempus::StepperImplicit< Scalar >.
Definition at line 166 of file Tempus_StepperHHTAlpha_impl.hpp.
|
inlinevirtual |
Set Observer.
Implements Tempus::Stepper< Scalar >.
Definition at line 67 of file Tempus_StepperHHTAlpha_decl.hpp.
void Tempus::StepperHHTAlpha< Scalar >::setParameterList | ( | const Teuchos::RCP< Teuchos::ParameterList > & | pl | ) |
Definition at line 356 of file Tempus_StepperHHTAlpha_impl.hpp.
|
virtual |
Take the specified timestep, dt, and return true if successful.
Implements Tempus::Stepper< Scalar >.
Definition at line 197 of file Tempus_StepperHHTAlpha_impl.hpp.
Teuchos::RCP< Teuchos::ParameterList > Tempus::StepperHHTAlpha< Scalar >::unsetParameterList | ( | ) |
Definition at line 517 of file Tempus_StepperHHTAlpha_impl.hpp.
|
private |
Definition at line 158 of file Tempus_StepperHHTAlpha_decl.hpp.
|
private |
Definition at line 159 of file Tempus_StepperHHTAlpha_decl.hpp.
|
private |
Definition at line 156 of file Tempus_StepperHHTAlpha_decl.hpp.
|
private |
Definition at line 157 of file Tempus_StepperHHTAlpha_decl.hpp.
|
private |
Definition at line 161 of file Tempus_StepperHHTAlpha_decl.hpp.