Tempus
Version of the Day
Time Integration
|
Tempus_Test::Basis | |
Describable | |
Tempus::Integrator< Scalar > | Thyra Base interface for time integrators. Time integrators are designed to advance the solution from an initial time, , to a final time, |
Tempus::IntegratorAdjointSensitivity< Scalar > | Time integrator suitable for adjoint sensitivity analysis |
Tempus::IntegratorBasic< Scalar > | Basic time integrator |
Tempus::IntegratorForwardSensitivity< Scalar > | Time integrator implementing forward sensitivity analysis |
Tempus::IntegratorPseudoTransientAdjointSensitivity< Scalar > | Time integrator suitable for pseudotransient adjoint sensitivity analysis |
Tempus::IntegratorPseudoTransientForwardSensitivity< Scalar > | Time integrator suitable for pseudotransient forward sensitivity analysis |
Tempus::Interpolator< Scalar > | Base strategy class for interpolation functionality |
Tempus::InterpolatorLagrange< Scalar > | Concrete implemenation of Interpolator that does simple lagrange interpolation |
Tempus::PhysicsState< Scalar > | PhysicsState is a simple class to hold information about the physics |
Tempus_Test::PhysicsStateCounter< Scalar > | PhysicsStateCounter is a simple PhysicsState that counts steps |
Tempus::RKButcherTableau< Scalar > | Runge-Kutta methods |
Tempus::BackwardEuler_RKBT< Scalar > | Backward Euler Runge-Kutta Butcher Tableau |
Tempus::EDIRK2Stage3rdOrder_RKBT< Scalar > | EDIRK 2 Stage 3rd order |
Tempus::EDIRK2StageTheta_RKBT< Scalar > | |
Tempus::Explicit2Stage2ndOrderRunge_RKBT< Scalar > | RK Explicit 2 Stage 2nd order by Runge |
Tempus::Explicit3_8Rule_RKBT< Scalar > | Explicit RK 3/8th Rule Butcher Tableau |
Tempus::Explicit3Stage3rdOrder_RKBT< Scalar > | RK Explicit 3 Stage 3rd order |
Tempus::Explicit3Stage3rdOrderHeun_RKBT< Scalar > | RK Explicit 3 Stage 3rd order by Heun |
Tempus::Explicit3Stage3rdOrderTVD_RKBT< Scalar > | RK Explicit 3 Stage 3rd order TVD |
Tempus::Explicit4Stage3rdOrderRunge_RKBT< Scalar > | RK Explicit 4 Stage 3rd order by Runge |
Tempus::Explicit4Stage4thOrder_RKBT< Scalar > | Runge-Kutta 4th order Butcher Tableau |
Tempus::Explicit5Stage3rdOrderKandG_RKBT< Scalar > | RK Explicit 5 Stage 3rd order by Kinnmark and Gray |
Tempus::ExplicitBogackiShampine32_RKBT< Scalar > | Explicit RK Bogacki-Shampine Butcher Tableau |
Tempus::ExplicitMerson45_RKBT< Scalar > | Explicit RK Merson Butcher Tableau |
Tempus::ExplicitTrapezoidal_RKBT< Scalar > | RK Explicit Trapezoidal |
Tempus::ForwardEuler_RKBT< Scalar > | Forward Euler Runge-Kutta Butcher Tableau |
Tempus::General_RKButcherTableau< Scalar > | |
Tempus::GeneralDIRK_RKBT< Scalar > | General Implicit Runge-Kutta Butcher Tableau |
Tempus::GeneralExplicit_RKBT< Scalar > | General Explicit Runge-Kutta Butcher Tableau |
Tempus::Implicit1Stage1stOrderRadauA_RKBT< Scalar > | |
Tempus::Implicit1Stage1stOrderRadauB_RKBT< Scalar > | |
Tempus::Implicit1Stage2ndOrderGauss_RKBT< Scalar > | |
Tempus::Implicit2Stage2ndOrderLobattoA_RKBT< Scalar > | |
Tempus::Implicit2Stage2ndOrderLobattoB_RKBT< Scalar > | |
Tempus::Implicit2Stage2ndOrderLobattoC_RKBT< Scalar > | |
Tempus::Implicit2Stage3rdOrderRadauA_RKBT< Scalar > | |
Tempus::Implicit2Stage3rdOrderRadauB_RKBT< Scalar > | |
Tempus::Implicit2Stage4thOrderGauss_RKBT< Scalar > | |
Tempus::Implicit2Stage4thOrderHammerHollingsworth_RKBT< Scalar > | |
Tempus::Implicit3Stage4thOrderLobattoA_RKBT< Scalar > | |
Tempus::Implicit3Stage4thOrderLobattoB_RKBT< Scalar > | |
Tempus::Implicit3Stage4thOrderLobattoC_RKBT< Scalar > | |
Tempus::Implicit3Stage5thOrderRadauA_RKBT< Scalar > | |
Tempus::Implicit3Stage5thOrderRadauB_RKBT< Scalar > | |
Tempus::Implicit3Stage6thOrderGauss_RKBT< Scalar > | |
Tempus::Implicit3Stage6thOrderKuntzmannButcher_RKBT< Scalar > | |
Tempus::Implicit4Stage6thOrderLobattoA_RKBT< Scalar > | |
Tempus::Implicit4Stage6thOrderLobattoB_RKBT< Scalar > | |
Tempus::Implicit4Stage6thOrderLobattoC_RKBT< Scalar > | |
Tempus::Implicit4Stage8thOrderKuntzmannButcher_RKBT< Scalar > | |
Tempus::IRK1StageTheta_RKBT< Scalar > | |
Tempus::SDIRK1Stage1stOrder_RKBT< Scalar > | SDIRK 1 Stage 1st order |
Tempus::SDIRK21_RKBT< Scalar > | SDIRK 2(1) pair |
Tempus::SDIRK2Stage2ndOrder_RKBT< Scalar > | SDIRK 2 Stage 2nd order |
Tempus::SDIRK2Stage3rdOrder_RKBT< Scalar > | SDIRK 2 Stage 3rd order |
Tempus::SDIRK3Stage4thOrder_RKBT< Scalar > | |
Tempus::SDIRK5Stage4thOrder_RKBT< Scalar > | |
Tempus::SDIRK5Stage5thOrder_RKBT< Scalar > | |
Tempus::SolutionHistory< Scalar > | SolutionHistory is basically a container of SolutionStates. SolutionHistory maintains a collection of SolutionStates for later retrival and reuse, such as checkpointing, restart, and undo operations |
Tempus::SolutionState< Scalar > | Solution state for integrators and steppers. SolutionState contains the metadata for solutions and the solutions themselves |
Tempus::SolutionStateMetaData< Scalar > | Solution state meta data |
Tempus::Stepper< Scalar > | Thyra Base interface for time steppers |
Tempus::StepperExplicit< Scalar > | Thyra Base interface for implicit time steppers |
Tempus::StepperExplicitRK< Scalar > | Explicit Runge-Kutta time stepper |
Tempus::StepperForwardEuler< Scalar > | Forward Euler time stepper |
Tempus_Test::PhysicsStateTest_StepperForwardEuler< Scalar > | This is a Forward Euler time stepper to test the PhysicsState |
Tempus::StepperLeapfrog< Scalar > | Leapfrog time stepper |
Tempus::StepperNewmarkExplicitAForm< Scalar > | Newmark Explicit time stepper |
Tempus::StepperImplicit< Scalar > | Thyra Base interface for implicit time steppers |
Tempus::StepperBackwardEuler< Scalar > | Backward Euler time stepper |
Tempus::StepperBDF2< Scalar > | BDF2 (Backward-Difference-Formula-2) time stepper |
Tempus::StepperDIRK< Scalar > | Diagonally Implicit Runge-Kutta (DIRK) time stepper |
Tempus::StepperHHTAlpha< Scalar > | HHT-Alpha time stepper |
Tempus::StepperIMEX_RK< Scalar > | Implicit-Explicit Runge-Kutta (IMEX-RK) time stepper |
Tempus::StepperIMEX_RK_Partition< Scalar > | Partitioned Implicit-Explicit Runge-Kutta (IMEX-RK) time stepper |
Tempus::StepperNewmarkImplicitAForm< Scalar > | Newmark time stepper in acceleration form (a-form) |
Tempus::StepperNewmarkImplicitDForm< Scalar > | Newmark time stepper |
Tempus::StepperTrapezoidal< Scalar > | Trapezoidal method time stepper |
Tempus::StepperOperatorSplit< Scalar > | OperatorSplit stepper loops through the Stepper list |
Tempus::StepperStaggeredForwardSensitivity< Scalar > | A stepper implementing staggered forward sensitivity analysis |
Tempus::StepperState< Scalar > | StepperState is a simple class to hold state information about the stepper |
Tempus::TimeStepControl< Scalar > | TimeStepControl manages the time step size. There several mechanicisms that effect the time step size and handled with this class: |
Tempus::ImplicitODEParameters< Scalar > | |
Tempus::IntegratorObserver< Scalar > | IntegratorObserver class for time integrators |
Tempus::IntegratorObserverBasic< Scalar > | IntegratorObserverBasic class for time integrators. This basic class has simple no-op functions, as all basic functionality should be handled through other methods |
Tempus::IntegratorObserverComposite< Scalar > | This observer is a composite observer, |
Tempus::IntegratorObserverLogging< Scalar > | This observer logs calls to observer functions. This observer simply logs and counts the calls to each of the observer functions. This is useful in monirtoring and debugging the time integration |
Tempus::InterpolatorFactory< Scalar > | Interpolator factory |
LinearOpWithSolveBase | |
Thyra::ScaledIdentityLinearOpWithSolve< Scalar > | Implicit concrete LinearOpBase subclass that takes a flattended out multi-vector and performs a multi-RHS apply with it |
LinearOpWithSolveFactoryBase | |
Thyra::AdjointLinearOpWithSolveFactory< Scalar > | Create a LinearOpWithSolveFactory for an adjoint linear op |
Thyra::BlockedTriangularLinearOpWithSolveFactory< Scalar > | Implicit subclass that takes a blocked triangular LOWB object and turns it into a LOWSB object |
Thyra::MultiVectorLinearOpWithSolveFactory< Scalar > | Create a LinearOpWithSolveFactory for a flattened-out multi-vector |
Thyra::ReuseLinearOpWithSolveFactory< Scalar > | A LinearOpWithSolveFactory that is designed to reuse an already created/initialized preconditioner |
Thyra::ScaledIdentityLinearOpWithSolveFactory< Scalar > | Create a LinearOpWithSolveFactory for a flattened-out multi-vector |
Tempus_Test::LinearRegression< Scalar > | Linear regression class. Copied and modified from Rythmos |
Tempus_Test::ModelEvaluator1DFEM< Scalar > | |
ModelEvaluatorDefaultBase | |
Tempus::SensitivityModelEvaluatorBase< Scalar > | A ModelEvaluator decorator for sensitivity analysis |
Tempus::CombinedForwardSensitivityModelEvaluator< Scalar > | Transform a ModelEvaluator's sensitivity equations to its residual |
Tempus::StaggeredForwardSensitivityModelEvaluator< Scalar > | Transform a ModelEvaluator's sensitivity equations to its residual |
Tempus::WrapperModelEvaluatorPairIMEX_CombinedFSA< Scalar > | Specialization of IMEX ME for "combined" FSA method |
Tempus::WrapperModelEvaluatorPairIMEX_StaggeredFSA< Scalar > | Specialization of IMEX ME for "staggered" FSA method |
Tempus::WrapperModelEvaluatorPairPartIMEX_CombinedFSA< Scalar > | Specialization of IMEX-Part ME for "combined" FSA method |
Tempus::WrapperModelEvaluatorPairPartIMEX_StaggeredFSA< Scalar > | Specialization of IMEX-Part ME for "combined" FSA method |
ParameterListAcceptor | |
Tempus::Integrator< Scalar > | Thyra Base interface for time integrators. Time integrators are designed to advance the solution from an initial time, , to a final time, |
Tempus::Interpolator< Scalar > | Base strategy class for interpolation functionality |
Tempus::RKButcherTableauBuilder< Scalar > | Runge-Kutta Builder class. This factory creates RKButcherTableau objects given the description string from the RKButcherTableau object |
Tempus::SolutionHistory< Scalar > | SolutionHistory is basically a container of SolutionStates. SolutionHistory maintains a collection of SolutionStates for later retrival and reuse, such as checkpointing, restart, and undo operations |
Tempus::Stepper< Scalar > | Thyra Base interface for time steppers |
Tempus::TimeStepControl< Scalar > | TimeStepControl manages the time step size. There several mechanicisms that effect the time step size and handled with this class: |
Tempus::TimeStepControlStrategy< Scalar > | StepControlStrategy class for TimeStepControl |
Tempus::TimeStepControlStrategyBasicVS< Scalar > | StepControlStrategy class for TimeStepControl |
Tempus::TimeStepControlStrategyComposite< Scalar > | StepControlStrategy class for TimeStepControl |
Tempus::TimeStepControlStrategyConstant< Scalar > | StepControlStrategy class for TimeStepControl |
Tempus::TimeStepControlStrategyIntegralController< Scalar > | StepControlStrategy class for TimeStepControl |
Tempus::TimeStepControlStrategyPID< Scalar > | StepControlStrategy class for TimeStepControl |
ParameterListAcceptorDefaultBase | |
Tempus::RKButcherTableau< Scalar > | Runge-Kutta methods |
Tempus_Test::HarmonicOscillatorModel< Scalar > | Consider the ODE:
where is a constant, is a constant damping parameter, is a constant forcing parameter, and is a constant mass parameter, with initial conditions are:
It is straight-forward to show that the exact solution to this ODE is:
where , and . While it is possible to derive the solution to this ODE for the case when and , we do not consider that case here. When , , and , our ODE simplies to a canonical differential equation model of a ball thrown up in the air, with a parabolic trajectory solution, namely
where . An EpetraExt version of this simplified version of the test is implemented in Piro::MockModelEval_B (see Trilinos/packages/piro/test), where it is used to test the Piro (EpetraExt) Newmark-Beta scheme (see input_Solver_NB.xml input file). When and , this test is equivalent to the SinCos model. |
Tempus_Test::SinCosModel< Scalar > | Sine-Cosine model problem from Rythmos. This is a canonical Sine-Cosine differential equation
with a few enhancements. We start with the exact solution to the differential equation
then the form of the model is
where the default parameter values are , , and , and the initial conditions
determine the remaining coefficients
|
Tempus_Test::SteadyQuadraticModel< Scalar > | Simple quadratic equation with a stable steady-state. This is a simple differential equation
which has steady state solutions . The solution is stable if and the solution is stable if . This model is used to test pseudo-transient sensitivity analysis methods |
Tempus_Test::VanDerPol_IMEX_ExplicitModel< Scalar > | Van der Pol model formulated for IMEX |
Tempus_Test::VanDerPol_IMEX_ImplicitModel< Scalar > | Van der Pol model formulated for IMEX-RK |
Tempus_Test::VanDerPol_IMEXPart_ImplicitModel< Scalar > | Van der Pol model formulated for the partitioned IMEX-RK |
Tempus_Test::VanDerPolModel< Scalar > | Van der Pol model problem for nonlinear electrical circuit |
PreconditionerBase | |
Thyra::AdjointPreconditioner< Scalar > | Concrete PreconditionerBase subclass that wraps a preconditioner operator in MultiVectorLinearOp |
Thyra::MultiVectorPreconditioner< Scalar > | Concrete PreconditionerBase subclass that wraps a preconditioner operator in MultiVectorLinearOp |
PreconditionerFactoryBase | |
Thyra::AdjointPreconditionerFactory< Scalar > | Concrete PreconditionerFactoryBase subclass that wraps a preconditioner in AdjointPreconditioner |
Thyra::MultiVectorPreconditionerFactory< Scalar > | Concrete PreconditionerFactoryBase subclass that wraps a preconditioner in MultiVectorPreconditioner |
Thyra::ReusePreconditionerFactory< Scalar > | Concrete PreconditionerFactoryBase subclass that just returns an already created/initialized preconditioner object |
RowStatLinearOpBase | |
Thyra::MultiVectorLinearOp< Scalar > | Implicit concrete LinearOpBase subclass that takes a flattended out multi-vector and performs a multi-RHS apply with it |
ScaledLinearOpBase | |
Thyra::MultiVectorLinearOp< Scalar > | Implicit concrete LinearOpBase subclass that takes a flattended out multi-vector and performs a multi-RHS apply with it |
StateFuncModelEvaluatorBase | |
Tempus::AdjointAuxSensitivityModelEvaluator< Scalar > | ModelEvaluator for forming adjoint sensitivity equations |
Tempus::AdjointSensitivityModelEvaluator< Scalar > | ModelEvaluator for forming adjoint sensitivity equations |
Tempus::AuxiliaryIntegralModelEvaluator< Scalar > | ModelEvaluator for integrating auxiliary equations |
Tempus::CombinedForwardSensitivityModelEvaluator< Scalar > | Transform a ModelEvaluator's sensitivity equations to its residual |
Tempus::StaggeredForwardSensitivityModelEvaluator< Scalar > | Transform a ModelEvaluator's sensitivity equations to its residual |
Tempus::WrapperModelEvaluator< Scalar > | A ModelEvaluator which wraps the application ModelEvaluator |
Tempus::WrapperModelEvaluatorBasic< Scalar > | A ModelEvaluator for residual evaluations given a state. This ModelEvaluator takes a state, x, and determines its residual, , which is suitable for a nonlinear solve. This is accomplished by computing the time derivative of the state, x_dot, (through Lambda functions), supplying the current time, and calling the application application ModelEvaluator, |
Tempus::WrapperModelEvaluatorPairIMEX< Scalar > | ModelEvaluator pair for implicit and explicit (IMEX) evaluations |
Tempus::WrapperModelEvaluatorPairIMEX_Basic< Scalar > | ModelEvaluator pair for implicit and explicit (IMEX) evaulations |
Tempus::WrapperModelEvaluatorPairIMEX_CombinedFSA< Scalar > | Specialization of IMEX ME for "combined" FSA method |
Tempus::WrapperModelEvaluatorPairIMEX_StaggeredFSA< Scalar > | Specialization of IMEX ME for "staggered" FSA method |
Tempus::WrapperModelEvaluatorPairPartIMEX_Basic< Scalar > | ModelEvaluator pair for implicit and explicit (IMEX) evaulations |
Tempus::WrapperModelEvaluatorPairPartIMEX_CombinedFSA< Scalar > | Specialization of IMEX-Part ME for "combined" FSA method |
Tempus::WrapperModelEvaluatorPairPartIMEX_StaggeredFSA< Scalar > | Specialization of IMEX-Part ME for "combined" FSA method |
Tempus::WrapperModelEvaluatorSecondOrder< Scalar > | A ModelEvaluator for residual evaluations given a state. This ModelEvaluator takes a state, x, and determines its residual, , which is suitable for a nonlinear solve. This is accomplished by computing the time derivative of the state, x_dot, (through Lambda functions), supplying the current time, and calling the application application ModelEvaluator, |
Tempus_Test::CDR_Model< Scalar > | 1D CGFEM model for convection/diffusion/reaction |
Tempus_Test::HarmonicOscillatorModel< Scalar > | Consider the ODE:
where is a constant, is a constant damping parameter, is a constant forcing parameter, and is a constant mass parameter, with initial conditions are:
It is straight-forward to show that the exact solution to this ODE is:
where , and . While it is possible to derive the solution to this ODE for the case when and , we do not consider that case here. When , , and , our ODE simplies to a canonical differential equation model of a ball thrown up in the air, with a parabolic trajectory solution, namely
where . An EpetraExt version of this simplified version of the test is implemented in Piro::MockModelEval_B (see Trilinos/packages/piro/test), where it is used to test the Piro (EpetraExt) Newmark-Beta scheme (see input_Solver_NB.xml input file). When and , this test is equivalent to the SinCos model. |
Tempus_Test::SinCosModel< Scalar > | Sine-Cosine model problem from Rythmos. This is a canonical Sine-Cosine differential equation
with a few enhancements. We start with the exact solution to the differential equation
then the form of the model is
where the default parameter values are , , and , and the initial conditions
determine the remaining coefficients
|
Tempus_Test::SteadyQuadraticModel< Scalar > | Simple quadratic equation with a stable steady-state. This is a simple differential equation
which has steady state solutions . The solution is stable if and the solution is stable if . This model is used to test pseudo-transient sensitivity analysis methods |
Tempus_Test::VanDerPol_IMEX_ExplicitModel< Scalar > | Van der Pol model formulated for IMEX |
Tempus_Test::VanDerPol_IMEX_ImplicitModel< Scalar > | Van der Pol model formulated for IMEX-RK |
Tempus_Test::VanDerPol_IMEXPart_ImplicitModel< Scalar > | Van der Pol model formulated for the partitioned IMEX-RK |
Tempus_Test::VanDerPolModel< Scalar > | Van der Pol model problem for nonlinear electrical circuit |
Tempus::StepperFactory< Scalar > | Stepper factory |
Tempus::StepperObserver< Scalar > | StepperObserver class for Stepper class |
Tempus::StepperBackwardEulerObserver< Scalar > | StepperBackwardEulerObserver class for StepperBackwardEuler |
Tempus::StepperBDF2Observer< Scalar > | StepperBDF2Observer class for StepperBDF2 |
Tempus::StepperDIRKObserver< Scalar > | StepperDIRKObserver class for StepperDIRK |
Tempus::StepperExplicitRKObserver< Scalar > | StepperExplicitRKObserver class for StepperExplicitRK |
Tempus::StepperForwardEulerObserver< Scalar > | StepperForwardEulerObserver class for StepperForwardEuler |
Tempus::StepperIMEX_RKObserver< Scalar > | StepperIMEX_RKObserver class for StepperIMEX_RK |
Tempus::StepperIMEX_RKPartObserver< Scalar > | StepperIMEX_RKPartObserver class for StepperIMEX_RK_Partition |
Tempus::StepperLeapfrogObserver< Scalar > | StepperLeapfrogObserver class for StepperLeapfrog |
Tempus::StepperObserverBasic< Scalar > | StepperObserverBasic class for Stepper class |
Tempus::StepperOperatorSplitObserver< Scalar > | StepperOperatorSplitObserver class for StepperOperatorSplit |
Tempus::StepperTrapezoidalObserver< Scalar > | StepperTrapezoidalObserver class for StepperTrapezoidal |
Tempus::StepperOptimizationInterface< Scalar > | Stepper interface to support full-space optimization |
Tempus::StepperBackwardEuler< Scalar > | Backward Euler time stepper |
Tempus::TimeDerivative< Scalar > | This interface defines the time derivative connection between an implicit Stepper and WrapperModelEvaluator |
Tempus::StepperBackwardEulerTimeDerivative< Scalar > | Time-derivative interface for Backward Euler |
Tempus::StepperBDF2TimeDerivative< Scalar > | Time-derivative interface for BDF2 |
Tempus::StepperDIRKTimeDerivative< Scalar > | Time-derivative interface for DIRK |
Tempus::StepperIMEX_RKPartTimeDerivative< Scalar > | Time-derivative interface for Partitioned IMEX RK |
Tempus::StepperIMEX_RKTimeDerivative< Scalar > | Time-derivative interface for IMEX RK |
Tempus::StepperTrapezoidalTimeDerivative< Scalar > | Time-derivative interface for Trapezoidal method |
VerboseObject | |
Tempus::Integrator< Scalar > | Thyra Base interface for time integrators. Time integrators are designed to advance the solution from an initial time, , to a final time, |
Tempus::Interpolator< Scalar > | Base strategy class for interpolation functionality |
Tempus::PhysicsState< Scalar > | PhysicsState is a simple class to hold information about the physics |
Tempus::RKButcherTableau< Scalar > | Runge-Kutta methods |
Tempus::SolutionHistory< Scalar > | SolutionHistory is basically a container of SolutionStates. SolutionHistory maintains a collection of SolutionStates for later retrival and reuse, such as checkpointing, restart, and undo operations |
Tempus::SolutionState< Scalar > | Solution state for integrators and steppers. SolutionState contains the metadata for solutions and the solutions themselves |
Tempus::SolutionStateMetaData< Scalar > | Solution state meta data |
Tempus::Stepper< Scalar > | Thyra Base interface for time steppers |
Tempus::StepperState< Scalar > | StepperState is a simple class to hold state information about the stepper |
Tempus::TimeStepControl< Scalar > | TimeStepControl manages the time step size. There several mechanicisms that effect the time step size and handled with this class: |