Tempus
Version of the Day
Time Integration
|
Anasazi | |
MultiVector > | |
AbstractStrategy > | |
LOCA | |
Bifurcation | |
PitchforkBord | |
TPBord | |
Continuation | |
Epetra | |
AnasaziOperator | |
Hopf | |
Pitchfork | |
TurningPoint | |
BorderedSystem | |
Homotopy | |
Parameter | |
TimeDependent | |
Tpetra | |
nox | |
NOX | |
Direction | |
Utils | |
Epetra | |
LineSearch | |
Utils | |
Multiphysics | |
DataExchange | |
Exceptions | |
MeritFunction | |
RTOpPack | |
Tempus | |
AdjointAuxSensitivityModelEvaluator | ModelEvaluator for forming adjoint sensitivity equations |
AdjointSensitivityModelEvaluator | ModelEvaluator for forming adjoint sensitivity equations |
AuxiliaryIntegralModelEvaluator | ModelEvaluator for integrating auxiliary equations |
CombinedForwardSensitivityModelEvaluator | Transform a ModelEvaluator's sensitivity equations to its residual |
Stepper | Thyra Base interface for time steppers |
SolutionHistory | 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 |
TimeStepControl | TimeStepControl manages the time step size. There several mechanisms that effect the time step size and handled with this class: |
Integrator | Thyra Base interface for time integrators. Time integrators are designed to advance the solution from an initial time, , to a final time, |
IntegratorAdjointSensitivity | Time integrator suitable for adjoint sensitivity analysis |
IntegratorBasic | Basic time integrator |
IntegratorForwardSensitivity | Time integrator implementing forward sensitivity analysis |
IntegratorObserver | IntegratorObserver class for time integrators |
IntegratorObserverBasic | IntegratorObserverBasic class for time integrators. This basic class has simple no-op functions, as all basic functionality should be handled through other methods |
IntegratorObserverComposite | This observer is a composite observer, |
IntegratorObserverLogging | 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 |
IntegratorObserverNoOp | IntegratorObserverNoOp class for time integrators. This basic class has simple no-op functions, as all basic functionality should be handled through other methods |
IntegratorObserverSubcycling | IntegratorObserverSubcycling class for time integrators. This basic class has simple no-op functions, as all basic functionality should be handled through other methods |
IntegratorPseudoTransientAdjointSensitivity | Time integrator suitable for pseudotransient adjoint sensitivity analysis |
IntegratorPseudoTransientForwardSensitivity | Time integrator suitable for pseudotransient forward sensitivity analysis |
Interpolator | Base strategy class for interpolation functionality |
InterpolatorFactory | Interpolator factory |
InterpolatorLagrange | Concrete implemenation of Interpolator that does simple lagrange interpolation |
PhysicsState | PhysicsState is a simple class to hold information about the physics |
RKButcherTableau | Runge-Kutta methods |
SensitivityModelEvaluatorBase | A ModelEvaluator decorator for sensitivity analysis |
SolutionState | Solution state for integrators and steppers |
SolutionStateMetaData | Solution state meta data |
StaggeredForwardSensitivityModelEvaluator | Transform a ModelEvaluator's sensitivity equations to its residual |
Stepper_ErrorNorm | Stepper_ErrorNorm provides error norm calcualtions for variable time stepping |
StepperBackwardEuler | Backward Euler time stepper |
StepperBackwardEulerTimeDerivative | Time-derivative interface for Backward Euler |
StepperBackwardEulerAppAction | Application Action for StepperBackwardEuler |
StepperBackwardEulerAppActionComposite | This composite AppAction loops over added AppActions |
StepperBackwardEulerModifierBase | Base modifier for StepperBackwardEuler |
StepperBackwardEulerModifierDefault | Default modifier for StepperBackwardEuler |
StepperBackwardEulerModifierXBase | Base ModifierX for StepperBackwardEuler |
StepperBackwardEulerModifierXDefault | Default ModifierX for StepperBackwardEuler |
StepperBackwardEulerObserverBase | Base observer for StepperBackwardEuler |
StepperBackwardEulerObserverDefault | Default observer for StepperBackwardEuler |
StepperBDF2 | BDF2 (Backward-Difference-Formula-2) time stepper |
StepperBDF2TimeDerivative | Time-derivative interface for BDF2 |
StepperBDF2AppAction | Application Action for StepperBDF2 |
StepperBDF2AppActionComposite | This composite AppAction loops over added AppActions |
StepperBDF2ModifierBase | Base modifier for StepperBDF2 |
StepperBDF2ModifierDefault | Default modifier for StepperBDF2 |
StepperBDF2ModifierXBase | Base ModifierX for StepperBDF2 |
StepperBDF2ModifierXDefault | Default ModifierX for StepperBDF2 |
StepperBDF2ObserverBase | Base observer for StepperBDF2 |
StepperBDF2ObserverDefault | Default observer for StepperBDF2 |
StepperDIRK | Diagonally Implicit Runge-Kutta (DIRK) time stepper |
StepperDIRKTimeDerivative | Time-derivative interface for DIRK |
StepperExplicit | Thyra Base interface for implicit time steppers |
StepperExplicitRK | Explicit Runge-Kutta time stepper |
StepperFactory | Stepper factory |
StepperForwardEuler | Forward Euler time stepper |
StepperForwardEulerAppAction | Application Action for StepperForwardEuler |
StepperForwardEulerAppActionComposite | This composite AppAction loops over added AppActions |
StepperForwardEulerModifierBase | Base modifier for StepperBackwardEuler |
StepperForwardEulerModifierDefault | Default modifier for StepperForwardEuler |
StepperForwardEulerModifierXBase | Base ModifierX for StepperForwardEuler |
StepperForwardEulerModifierXDefault | Default ModifierX for StepperForwardEuler |
StepperForwardEulerObserverBase | Base observer for StepperForwardEuler |
StepperForwardEulerObserverDefault | Default observer for StepperForwardEuler |
StepperHHTAlpha | HHT-Alpha time stepper |
StepperHHTAlphaAppAction | Application Action for HHT Alpha |
StepperHHTAlphaAppActionComposite | This composite AppAction loops over added AppActions |
StepperHHTAlphaModifierBase | Base modifier for StepperHHTAlpha |
StepperHHTAlphaModifierDefault | Default modifier for StepperHHTAlpha |
StepperHHTAlphaModifierXBase | Base ModifierX for StepperHHTAlpha |
StepperHHTAlphaModifierXDefault | Default ModifierX for StepperHHTAlpha |
StepperHHTAlphaObserverBase | Base observer for StepperHHTAlpha |
StepperHHTAlphaObserverDefault | Default observer for StepperHHTAlpha |
StepperIMEX_RK | Implicit-Explicit Runge-Kutta (IMEX-RK) time stepper |
StepperIMEX_RKTimeDerivative | Time-derivative interface for IMEX RK |
StepperIMEX_RK_Partition | Partitioned Implicit-Explicit Runge-Kutta (IMEX-RK) time stepper |
StepperIMEX_RKPartTimeDerivative | Time-derivative interface for Partitioned IMEX RK |
StepperImplicit | Thyra Base interface for implicit time steppers |
StepperLeapfrog | Leapfrog time stepper |
StepperLeapfrogAppAction | Application Action for StepperLeapfrog |
StepperLeapfrogAppActionComposite | This composite AppAction loops over added AppActions |
StepperLeapfrogModifierBase | Base modifier for StepperLeapfrog |
StepperLeapfrogModifierDefault | Default modifier for StepperLeapfrog |
StepperLeapfrogModifierXBase | Base ModifierX for StepperLeapfrog |
StepperLeapfrogModifierXDefault | Default ModifierX for StepperLeapfrog |
StepperLeapfrogObserverBase | Base observer for StepperLeapfrog |
StepperLeapfrogObserverDefault | Default observer for StepperLeapfrog |
StepperNewmarkExplicitAForm | Newmark Explicit time stepper |
StepperNewmarkExplicitAFormAppAction | Application Action for StepperNewmarkExplicitAForm |
StepperNewmarkExplicitAFormAppActionComposite | This composite AppAction loops over added AppActions |
StepperNewmarkExplicitAFormModifierBase | Base modifier for StepperNewmarkExplicitAForm |
StepperNewmarkExplicitAFormModifierDefault | Default modifier for StepperNewmarkExplicitAForm |
StepperNewmarkExplicitAFormModifierXBase | Base ModifierX for StepperNewmarkExplicitAForm |
StepperNewmarkExplicitAFormModifierXDefault | Default ModifierX for StepperNewmarkExplicitAForm |
StepperNewmarkImplicitAForm | Newmark time stepper in acceleration form (a-form) |
StepperNewmarkImplicitAFormAppAction | Application Action for StepperNewmarkImplicitAForm |
StepperNewmarkImplicitAFormAppActionComposite | This composite AppAction loops over added AppActions |
StepperNewmarkImplicitAFormModifierBase | Base modifier for StepperNewmarkImplicitAForm |
StepperNewmarkImplicitAFormModifierDefault | Default modifier for StepperNewmarkImplicitAForm |
StepperNewmarkImplicitAFormModifierXBase | Base ModifierX for StepperNewmarkImplicitAForm |
StepperNewmarkImplicitAFormModifierXDefault | Default ModifierX for StepperNewmarkImplicitAForm |
StepperNewmarkImplicitDForm | Newmark time stepper |
StepperNewmarkImplicitDFormAppAction | Application Action for StepperNewmarkImplicitDForm |
StepperNewmarkImplicitDFormAppActionComposite | This composite AppAction loops over added AppActions |
StepperNewmarkImplicitDFormModifierBase | Base modifier for StepperNewmarkImplicitDForm |
StepperNewmarkImplicitDFormModifierDefault | Default modifier for StepperNewmarkImplicitDForm |
StepperNewmarkImplicitDFormModifierXBase | Base ModifierX for StepperNewmarkImplicitDForm |
StepperNewmarkImplicitDFormModifierXDefault | Default ModifierX for StepperNewmarkImplicitDForm |
StepperOperatorSplit | OperatorSplit stepper loops through the Stepper list |
StepperOperatorSplitAppAction | StepperOperatorSplitAppAction class for StepperOperatorSplit |
StepperOperatorSplitAppActionComposite | This composite AppAction loops over added AppActions |
StepperOperatorSplitModifierBase | Base modifier for OperatorSplit |
StepperOperatorSplitModifierDefault | Default modifier for StepperOperatorSplit |
StepperOperatorSplitModifierXBase | Base ModifierX for StepperOperatorSplit |
StepperOperatorSplitModifierXDefault | Default ModifierX for StepperOperatorSplit |
StepperOperatorSplitObserverBase | Base observer for StepperOperatorSplit |
StepperOperatorSplitObserverDefault | Default observer for StepperOperatorSplit |
StepperOptimizationInterface | Stepper interface to support full-space optimization |
StepperRKBase | Base class for Runge-Kutta methods, ExplicitRK, DIRK and IMEX |
StepperRKAppAction | Application Action for StepperRKBase |
StepperRKAppActionComposite | This composite AppAction loops over added AppActions |
StepperERK_ForwardEuler | Forward Euler Runge-Kutta Butcher Tableau |
StepperERK_4Stage4thOrder | Runge-Kutta 4th order Butcher Tableau |
StepperERK_BogackiShampine32 | Explicit RK Bogacki-Shampine Butcher Tableau |
StepperERK_Merson45 | Explicit RK Merson Butcher Tableau |
StepperERK_3_8Rule | Explicit RK 3/8th Rule Butcher Tableau |
StepperERK_4Stage3rdOrderRunge | RK Explicit 4 Stage 3rd order by Runge |
StepperERK_5Stage3rdOrderKandG | RK Explicit 5 Stage 3rd order by Kinnmark and Gray |
StepperERK_3Stage3rdOrder | RK Explicit 3 Stage 3rd order |
StepperERK_3Stage3rdOrderTVD | RK Explicit 3 Stage 3rd order TVD |
StepperERK_3Stage3rdOrderHeun | RK Explicit 3 Stage 3rd order by Heun |
StepperERK_Midpoint | RK Explicit Midpoint |
StepperERK_Ralston | RK Explicit Ralston |
StepperERK_Trapezoidal | RK Explicit Trapezoidal |
StepperERK_SSPERK54 | Strong Stability Preserving Explicit RK Butcher Tableau |
StepperERK_General | General Explicit Runge-Kutta Butcher Tableau |
StepperDIRK_BackwardEuler | Backward Euler Runge-Kutta Butcher Tableau |
StepperSDIRK_2Stage2ndOrder | SDIRK 2 Stage 2nd order |
StepperSDIRK_3Stage2ndOrder | SDIRK 3 Stage 2nd order |
StepperSDIRK_2Stage3rdOrder | SDIRK 2 Stage 3rd order |
StepperEDIRK_2Stage3rdOrder | EDIRK 2 Stage 3rd order |
StepperDIRK_1StageTheta | DIRK 1 Stage Theta |
StepperEDIRK_2StageTheta | EDIRK 2 Stage Theta Method |
StepperEDIRK_TrapezoidalRule | RK Trapezoidal Rule (A.K.A. RK Crank-Nicolson) |
StepperSDIRK_ImplicitMidpoint | SDIRK Implicit Midpoint |
StepperSDIRK_SSPDIRK22 | Strong Stability Preserving Diagonally-Implicit RK Butcher Tableau |
StepperSDIRK_SSPDIRK32 | Strong Stability Preserving Diagonally-Implicit RK Butcher Tableau |
StepperSDIRK_SSPDIRK23 | Strong Stability Preserving Diagonally-Implicit RK Butcher Tableau |
StepperSDIRK_SSPDIRK33 | Strong Stability Preserving Diagonally-Implicit RK Butcher Tableau |
StepperDIRK_1Stage1stOrderRadauIA | RK Implicit 1 Stage 1st order Radau IA |
StepperDIRK_2Stage2ndOrderLobattoIIIB | RK Implicit 2 Stage 2nd order Lobatto IIIB |
StepperSDIRK_5Stage4thOrder | SDIRK 5 Stage 4th order |
StepperSDIRK_3Stage4thOrder | SDIRK 3 Stage 4th order |
StepperSDIRK_5Stage5thOrder | SDIRK 5 Stage 5th order |
StepperSDIRK_21Pair | SDIRK 2(1) pair |
StepperDIRK_General | General Implicit Runge-Kutta Butcher Tableau |
StepperRKModifierBase | Base modifier for StepperRK |
StepperRKModifierDefault | Default modifier for StepperRK |
StepperRKModifierXBase | Base ModifierX for StepperRK |
StepperRKModifierXDefault | Default ModifierX for StepperRK |
StepperRKObserverBase | Base observer for StepperRK |
StepperRKObserverDefault | Default observer for StepperRK |
StepperStaggeredForwardSensitivity | A stepper implementing staggered forward sensitivity analysis |
StepperState | StepperState is a simple class to hold state information about the stepper |
StepperSubcycling | Subcycling time stepper |
StepperSubcyclingAppAction | Application Action for StepperSubcycling |
StepperSubcyclingAppActionComposite | This composite AppAction loops over added AppActions |
StepperSubcyclingModifierBase | Base modifier for StepperSubcycling |
StepperSubcyclingModifierDefault | Default modifier for StepperSubcycling |
StepperSubcyclingModifierXBase | Base ModifierX for StepperSubcycling |
StepperSubcyclingModifierXDefault | Default ModifierX for StepperSubcycling |
StepperSubcyclingObserverBase | Base observer for StepperSubcycling |
StepperSubcyclingObserverDefault | Default observer for StepperSubcycling |
StepperTrapezoidal | Trapezoidal method time stepper |
StepperTrapezoidalTimeDerivative | Time-derivative interface for Trapezoidal method |
StepperTrapezoidalAppAction | Application Action for StepperTrapezoidal |
StepperTrapezoidalAppActionComposite | This composite AppAction loops over added AppActions |
StepperTrapezoidalModifierBase | Base modifier for StepperTrapezoidal |
StepperTrapezoidalModifierDefault | Default modifier for StepperTrapezoidal |
StepperTrapezoidalModifierXBase | Base ModifierX for StepperTrapezoidal |
StepperTrapezoidalModifierXDefault | Default ModifierX for StepperTrapezoidal |
StepperTrapezoidalObserverBase | Base observer for StepperTrapezoidal |
StepperTrapezoidalObserverDefault | Default observer for StepperTrapezoidal |
TimeDerivative | This interface defines the time derivative connection between an implicit Stepper and WrapperModelEvaluator |
TimeEventBase | This class defines time events which can be used to "trigger" an action |
TimeEventComposite | This composite TimeEvent loops over added TimeEvents |
TimeEventList | TimeEventList specifies a list of time events |
TimeEventListIndex | TimeEventListIndex specifies a list of index events |
TimeEventRange | TimeEventRange specifies a start, stop and stride time |
TimeEventRangeIndex | TimeEventRangeIndex specifies a start, stop and stride index |
TimeStepControlStrategy | TimeStepControlStrategy class for TimeStepControl |
TimeStepControlStrategyBasicVS | StepControlStrategy class for TimeStepControl |
TimeStepControlStrategyComposite | TimeStepControlStrategyComposite loops over a vector of TimeStepControlStrategies |
TimeStepControlStrategyConstant | StepControlStrategy class for TimeStepControl |
TimeStepControlStrategyIntegralController | StepControlStrategy class for TimeStepControl |
ImplicitODEParameters | |
WrapperModelEvaluator | A ModelEvaluator which wraps the application ModelEvaluator |
WrapperModelEvaluatorBasic | 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, |
WrapperModelEvaluatorPairIMEX | ModelEvaluator pair for implicit and explicit (IMEX) evaluations |
WrapperModelEvaluatorPairIMEX_Basic | ModelEvaluator pair for implicit and explicit (IMEX) evaulations |
WrapperModelEvaluatorPairIMEX_CombinedFSA | Specialization of IMEX ME for "combined" FSA method |
WrapperModelEvaluatorPairIMEX_StaggeredFSA | Specialization of IMEX ME for "staggered" FSA method |
WrapperModelEvaluatorPairPartIMEX_Basic | ModelEvaluator pair for implicit and explicit (IMEX) evaulations |
WrapperModelEvaluatorPairPartIMEX_CombinedFSA | Specialization of IMEX-Part ME for "combined" FSA method |
WrapperModelEvaluatorPairPartIMEX_StaggeredFSA | Specialization of IMEX-Part ME for "combined" FSA method |
WrapperModelEvaluatorSecondOrder | 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 | |
PhysicsStateCounter | PhysicsStateCounter is a simple PhysicsState that counts steps |
StepperPhysicsStateTest | This is a Forward Euler time stepper to test the PhysicsState |
ModelEvaluator1DFEM | |
CDR_Model | 1D CGFEM model for convection/diffusion/reaction |
Basis | |
CoordFiller | |
TBasis | |
JacobianEvaluatorFunctor | |
PreconditionerEvaluatorFunctor | |
DfDp2EvaluatorFunctor | |
CDR_Model_Tpetra | 1D CGFEM model for convection/diffusion/reaction |
DahlquistTestModel | The classic Dahlquist Test Problem |
HarmonicOscillatorModel | 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. |
SinCosModel | 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
|
SinCosModelAdjoint | Non-member constructor |
SteadyQuadraticModel | Simple quadratic equation with a stable steady-state |
VanDerPol_IMEX_ExplicitModel | Van der Pol model formulated for IMEX |
VanDerPol_IMEX_ImplicitModel | Van der Pol model formulated for IMEX-RK |
VanDerPol_IMEXPart_ImplicitModel | Van der Pol model formulated for the partitioned IMEX-RK |
VanDerPolModel | Van der Pol model problem for nonlinear electrical circuit |
LinearRegression | Linear regression class. Copied and modified from Rythmos |
Tempus_Unit_Test | |
StepperRKModifierTest | Unit test class for RK Stepper Modifier AppAction |
StepperRKObserverTest | Unit test class for RK Stepper Observer AppAction |
StepperRKModifierXTest | |
Teuchos | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string > | |
string, char[N]> | |
reverse_iterator< Iter > > | |
string > | |
pair< T1, T2 > > | |
DefaultSerializerType > | |
DefaultSerializerType > | |
DefaultSerializerType > | |
DefaultSerializerType > | |
DefaultSerializerType > | |
Details | |
Exceptions | |
MatrixMarket | |
details | |
Raw | |
VectorBase< Scalar > > | |
Thyra | |
DirectionalFiniteDiffCalculatorTypes | |
Exceptions | |
AdjointLinearOpWithSolveFactory | Create a LinearOpWithSolveFactory for an adjoint linear op |
AdjointPreconditioner | Concrete PreconditionerBase subclass that wraps a preconditioner operator in MultiVectorLinearOp |
AdjointPreconditionerFactory | Concrete PreconditionerFactoryBase subclass that wraps a preconditioner in AdjointPreconditioner |
BlockedTriangularLinearOpWithSolveFactory | Implicit subclass that takes a blocked triangular LOWB object and turns it into a LOWSB object |
ImplicitAdjointModelEvaluator | An implementation of AdjointModelEvaluatorBase that creates an implicit adjoint from the supplied model evaluator |
MultiVectorLinearOp | Implicit concrete LinearOpBase subclass that takes a flattended out multi-vector and performs a multi-RHS apply with it |
MultiVectorLinearOpWithSolveFactory | Create a LinearOpWithSolveFactory for a flattened-out multi-vector |
MultiVectorPreconditioner | Concrete PreconditionerBase subclass that wraps a preconditioner operator in MultiVectorLinearOp |
MultiVectorPreconditionerFactory | Concrete PreconditionerFactoryBase subclass that wraps a preconditioner in MultiVectorPreconditioner |
ReuseLinearOpWithSolveFactory | A LinearOpWithSolveFactory that is designed to reuse an already created/initialized preconditioner |
ReusePreconditionerFactory | Concrete PreconditionerFactoryBase subclass that just returns an already created/initialized preconditioner object |
ScaledIdentityLinearOpWithSolve | Implicit concrete LinearOpBase subclass that takes a flattended out multi-vector and performs a multi-RHS apply with it |
ScaledIdentityLinearOpWithSolveFactory | Create a LinearOpWithSolveFactory for a flattened-out multi-vector |
Trilinos | |
Details | |
ExplicitODEParameters | |
VanDerPol_ModelEvaluator_02 | ModelEvaluator implementation for the example van der Pol Problem |