Tempus  Version of the Day
Time Integration
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Macros Pages
Tempus_Test Namespace Reference

Classes

class  PhysicsStateCounter
 PhysicsStateCounter is a simple PhysicsState that counts steps. More...
 
class  StepperPhysicsStateTest
 This is a Forward Euler time stepper to test the PhysicsState. More...
 
class  ModelEvaluator1DFEM
 
class  CDR_Model
 1D CGFEM model for convection/diffusion/reaction More...
 
class  Basis
 
class  HarmonicOscillatorModel
 Consider the ODE:

\[ m\ddot{x} + c\dot{x} + kx=f \]

where $k \geq 0$ is a constant, $c$ is a constant damping parameter, $f$ is a constant forcing parameter, and $m>0$ is a constant mass parameter, with initial conditions are:

\begin{eqnarray*} x(0) & = & 0\\ \dot{x}(0) & = & 1 \end{eqnarray*}

It is straight-forward to show that the exact solution to this ODE is:

\begin{eqnarray*} x(t) & = & t(1+0.5\tilde{f}t), \hspace{3.6cm} if \hspace{0.2cm} k = c = 0 \\ & = & \frac{(\tilde{c}-\tilde{f})}{\tilde{c}^2}(1-e^{-\tilde{c}t}) + \frac{f}{c}t, \hspace{1.9cm} if \hspace{0.2cm} k = 0, c\neq 0 \\ & = & \frac{1}{\sqrt{\tilde{k}}}\sin(\sqrt{\tilde{k}}t) + \frac{f}{k}\left(1-\cos(\sqrt{\tilde{k}}t) \right), \hspace{0.2cm} if \hspace{0.2cm} k > 0, c = 0 \end{eqnarray*}

where $\tilde{c}\equiv c/m$, $\tilde{k}\equiv k/m$ and $\tilde{f}\equiv f/m$. While it is possible to derive the solution to this ODE for the case when $k > 0$ and $c \neq 0$, we do not consider that case here. When $c = k = 0$, $m=1$, and $f=-1$, our ODE simplies to a canonical differential equation model of a ball thrown up in the air, with a parabolic trajectory solution, namely

\[ x(t) = t(1-0.5t) \]

where $t\in [0,2]$. 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 $c = f = 0$ and $m=k = 1$, this test is equivalent to the SinCos model.. More...

 
class  SinCosModel
 Sine-Cosine model problem from Rythmos. This is a canonical Sine-Cosine differential equation

\[ \mathbf{\ddot{x}}=-\mathbf{x} \]

with a few enhancements. We start with the exact solution to the differential equation

\begin{eqnarray*} x_{0}(t) & = & a+b*\sin((f/L)*t+\phi)\\ x_{1}(t) & = & b*(f/L)*\cos((f/L)*t+\phi) \end{eqnarray*}

then the form of the model is

\begin{eqnarray*} \frac{d}{dt}x_{0}(t) & = & x_{1}(t)\\ \frac{d}{dt}x_{1}(t) & = & \left(\frac{f}{L}\right)^{2}(a-x_{0}(t)) \end{eqnarray*}

where the default parameter values are $a=0$, $f=1$, and $L=1$, and the initial conditions

\begin{eqnarray*} x_{0}(t_{0}=0) & = & \gamma_{0}[=0]\\ x_{1}(t_{0}=0) & = & \gamma_{1}[=1] \end{eqnarray*}

determine the remaining coefficients

\begin{eqnarray*} \phi & = & \arctan(((f/L)/\gamma_{1})*(\gamma_{0}-a))-(f/L)*t_{0}[=0]\\ b & = & \gamma_{1}/((f/L)*cos((f/L)*t_{0}+\phi))[=1] \end{eqnarray*}

. More...

 
class  SteadyQuadraticModel
 Simple quadratic equation with a stable steady-state. This is a simple differential equation

\[ \mathbf{\dot{x}}=\mathbf{x}^2 - b^2 \]

which has steady state solutions $\mathbf{x} = \pm b$. The solution $\mathbf{x} = b$ is stable if $b < 0$ and the solution $\mathbf{x} = -b$ is stable if $b > 0$. This model is used to test pseudo-transient sensitivity analysis methods. More...

 
class  VanDerPol_IMEX_ExplicitModel
 van der Pol model formulated for IMEX. More...
 
class  VanDerPol_IMEX_ImplicitModel
 van der Pol model formulated for IMEX-RK. More...
 
class  VanDerPol_IMEXPart_ImplicitModel
 van der Pol model formulated for the partitioned IMEX-RK. More...
 
class  VanDerPolModel
 van der Pol model problem for nonlinear electrical circuit. More...
 
class  LinearRegression
 Linear regression class. Copied and modified from Rythmos. More...
 

Functions

 TEUCHOS_UNIT_TEST (BackwardEuler, SinCos_ASA)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SinCos_Combined_FSA)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SinCos_Combined_FSA_Tangent)
 
void test_sincos_fsa (const bool use_combined_method, const bool use_dfdp_as_tangent, Teuchos::FancyOStream &out, bool &success)
 
void test_pseudotransient_fsa (const bool use_dfdp_as_tangent, Teuchos::FancyOStream &out, bool &success)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SteadyQuadratic_PseudoTransient_FSA)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SteadyQuadratic_PseudoTransient_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SteadyQuadratic_PseudoTransient_ASA)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SinCos_Staggered_FSA)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SinCos_Staggered_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, ParameterList)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, SinCos)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, CDR)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, VanDerPol)
 
 TEUCHOS_UNIT_TEST (BackwardEuler, OptInterface)
 
 TEUCHOS_UNIT_TEST (BDF2, SinCos_ASA)
 
 TEUCHOS_UNIT_TEST (BDF2, SinCos_Combined_FSA)
 
 TEUCHOS_UNIT_TEST (BDF2, SinCos_Combined_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (BDF2, SteadyQuadratic_PseudoTransient_FSA)
 
 TEUCHOS_UNIT_TEST (BDF2, SteadyQuadratic_PseudoTransient_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (BDF2, SteadyQuadratic_PseudoTransient_ASA)
 
 TEUCHOS_UNIT_TEST (BDF2, SinCos_Staggered_FSA)
 
 TEUCHOS_UNIT_TEST (BDF2, SinCos_Staggered_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (BDF2, ParameterList)
 
 TEUCHOS_UNIT_TEST (BDF2, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (BDF2, SinCos)
 
 TEUCHOS_UNIT_TEST (BDF2, SinCosAdapt)
 
 TEUCHOS_UNIT_TEST (BDF2, CDR)
 
 TEUCHOS_UNIT_TEST (BDF2, VanDerPol)
 
 TEUCHOS_UNIT_TEST (DIRK, SinCos_ASA)
 
 TEUCHOS_UNIT_TEST (DIRK, SinCos_Combined_FSA)
 
 TEUCHOS_UNIT_TEST (DIRK, SinCos_Combined_FSA_Tangent)
 
void test_sincos_fsa (const std::string &method_name, const bool use_combined_method, const bool use_dfdp_as_tangent, Teuchos::FancyOStream &out, bool &success)
 
 TEUCHOS_UNIT_TEST (DIRK, SteadyQuadratic_PseudoTransient_FSA)
 
 TEUCHOS_UNIT_TEST (DIRK, SteadyQuadratic_PseudoTransient_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (DIRK, SteadyQuadratic_PseudoTransient_ASA)
 
 TEUCHOS_UNIT_TEST (DIRK, SinCos_Staggered_FSA)
 
 TEUCHOS_UNIT_TEST (DIRK, SinCos_Staggered_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (DIRK, ParameterList)
 
 TEUCHOS_UNIT_TEST (DIRK, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (DIRK, SinCos)
 
 TEUCHOS_UNIT_TEST (DIRK, VanDerPol)
 
 TEUCHOS_UNIT_TEST (DIRK, EmbeddedVanDerPol)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SinCos_ASA)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SinCos_Combined_FSA)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SinCos_Combined_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SteadyQuadratic_PseudoTransient_FSA)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SteadyQuadratic_PseudoTransient_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SteadyQuadratic_PseudoTransient_ASA)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SinCos_Staggered_FSA)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SinCos_Staggered_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, ParameterList)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, SinCos)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, EmbeddedVanDerPol)
 
 TEUCHOS_UNIT_TEST (ExplicitRK, stage_number)
 
 TEUCHOS_UNIT_TEST (ForwardEuler, ParameterList)
 
 TEUCHOS_UNIT_TEST (ForwardEuler, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (ForwardEuler, SinCos)
 
 TEUCHOS_UNIT_TEST (ForwardEuler, VanDerPol)
 
 TEUCHOS_UNIT_TEST (ForwardEuler, NumberTimeSteps)
 
 TEUCHOS_UNIT_TEST (ForwardEuler, Variable_TimeSteps)
 
 TEUCHOS_UNIT_TEST (HHTAlpha, BallParabolic)
 
 TEUCHOS_UNIT_TEST (HHTAlpha, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (HHTAlpha, SinCos_SecondOrder)
 
 TEUCHOS_UNIT_TEST (HHTAlpha, SinCos_FirstOrder)
 
 TEUCHOS_UNIT_TEST (HHTAlpha, SinCos_CD)
 
 TEUCHOS_UNIT_TEST (IMEX_RK, VanDerPol_Combined_FSA)
 
 TEUCHOS_UNIT_TEST (IMEX_RK, VanDerPol_Combined_FSA_Tangent)
 
void test_vdp_fsa (const bool use_combined_method, const bool use_dfdp_as_tangent, Teuchos::FancyOStream &out, bool &success)
 
 TEUCHOS_UNIT_TEST (IMEX_RK, VanDerPol_Staggered_FSA)
 
 TEUCHOS_UNIT_TEST (IMEX_RK, VanDerPol_Staggered_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (IMEX_RK, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (IMEX_RK, VanDerPol)
 
 TEUCHOS_UNIT_TEST (IMEX_RK_Partitioned, VanDerPol_Combined_FSA)
 
 TEUCHOS_UNIT_TEST (IMEX_RK_Partitioned, VanDerPol_Combined_FSA_Tangent)
 
void test_vdp_fsa (const std::string &method_name, const bool use_combined_method, const bool use_dfdp_as_tangent, Teuchos::FancyOStream &out, bool &success)
 
 TEUCHOS_UNIT_TEST (IMEX_RK_Partitioned, VanDerPol_Staggered_FSA)
 
 TEUCHOS_UNIT_TEST (IMEX_RK_Partitioned, VanDerPol_Staggered_FSA_Tangent)
 
 TEUCHOS_UNIT_TEST (IMEX_RK_Partitioned, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (IMEX_RK_Partitioned, VanDerPol)
 
 TEUCHOS_UNIT_TEST (IntegratorBasic, PL_ME_Construction)
 
 TEUCHOS_UNIT_TEST (IntegratorBasic, Construction)
 
 TEUCHOS_UNIT_TEST (Leapfrog, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (Leapfrog, SinCos)
 
 TEUCHOS_UNIT_TEST (NewmarkExplicitAForm, BallParabolic)
 
 TEUCHOS_UNIT_TEST (NewmarkExplicitAForm, SinCos)
 
 TEUCHOS_UNIT_TEST (NewmarkExplicitAForm, HarmonicOscillatorDamped)
 
 TEUCHOS_UNIT_TEST (NewmarkImplicitAForm, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (NewmarkImplicitDForm, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (NewmarkImplicitAForm, HarmonicOscillatorDamped_SecondOrder)
 
 TEUCHOS_UNIT_TEST (NewmarkImplicitDForm, HarmonicOscillatorDamped_SecondOrder)
 
 TEUCHOS_UNIT_TEST (NewmarkImplicitAForm, HarmonicOscillatorDamped_FirstOrder)
 
 TEUCHOS_UNIT_TEST (Observer, IntegratorObserverLogging)
 
 TEUCHOS_UNIT_TEST (Observer, IntegratorObserverComposite)
 
 TEUCHOS_UNIT_TEST (OperatorSplit, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (OperatorSplit, VanDerPol)
 
 TEUCHOS_UNIT_TEST (PhysicsState, SinCos)
 
 TEUCHOS_UNIT_TEST (Subcycling, ParameterList)
 
 TEUCHOS_UNIT_TEST (Subcycling, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (Subcycling, SinCosAdapt)
 
 TEUCHOS_UNIT_TEST (Subcycling, VanDerPolOperatorSplit)
 
template<class Scalar >
Scalar computeLinearRegression (std::vector< Scalar > &x, std::vector< Scalar > &y)
 
template<class Scalar >
void computeLinearRegression (std::vector< Scalar > &x, std::vector< Scalar > &y, Scalar &slope, Scalar &yIntercept)
 
template<class Scalar >
Scalar computeLinearRegressionLogLog (std::vector< Scalar > &x, std::vector< Scalar > &y)
 
template<class Scalar >
Teuchos::RCP< LinearRegression
< Scalar > > 
linearRegression ()
 
template<class Scalar >
void writeOrderError (const std::string filename, Teuchos::RCP< Tempus::Stepper< Scalar > > stepper, std::vector< Scalar > &StepSize, std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &solutions, std::vector< Scalar > &xErrorNorm, Scalar &xSlope, std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &solutionsDot, std::vector< Scalar > &xDotErrorNorm, Scalar &xDotSlope, std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &solutionsDotDot, std::vector< Scalar > &xDotDotErrorNorm, Scalar &xDotDotSlope)
 
template<class Scalar >
void writeOrderError (const std::string filename, Teuchos::RCP< Tempus::Stepper< Scalar > > stepper, std::vector< Scalar > &StepSize, std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &solutions, std::vector< Scalar > &xErrorNorm, Scalar &xSlope, std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &solutionsDot, std::vector< Scalar > &xDotErrorNorm, Scalar &xDotSlope)
 
template<class Scalar >
void writeOrderError (const std::string filename, Teuchos::RCP< Tempus::Stepper< Scalar > > stepper, std::vector< Scalar > &StepSize, std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &solutions, std::vector< Scalar > &xErrorNorm, Scalar &xSlope)
 
template<class Scalar >
void writeSolution (const std::string filename, Teuchos::RCP< const Tempus::SolutionHistory< Scalar > > solutionHistory)
 
 TEUCHOS_UNIT_TEST (Trapezoidal, ParameterList)
 
 TEUCHOS_UNIT_TEST (Trapezoidal, ConstructingFromDefaults)
 
 TEUCHOS_UNIT_TEST (Trapezoidal, SinCos)
 
 TEUCHOS_UNIT_TEST (Trapezoidal, VanDerPol)
 
 TEUCHOS_UNIT_TEST (version, default)
 

Function Documentation

template<class Scalar >
Scalar Tempus_Test::computeLinearRegression ( std::vector< Scalar > &  x,
std::vector< Scalar > &  y 
)

Definition at line 136 of file Tempus_ConvergenceTestUtils.hpp.

template<class Scalar >
void Tempus_Test::computeLinearRegression ( std::vector< Scalar > &  x,
std::vector< Scalar > &  y,
Scalar &  slope,
Scalar &  yIntercept 
)

Definition at line 145 of file Tempus_ConvergenceTestUtils.hpp.

template<class Scalar >
Scalar Tempus_Test::computeLinearRegressionLogLog ( std::vector< Scalar > &  x,
std::vector< Scalar > &  y 
)

Definition at line 157 of file Tempus_ConvergenceTestUtils.hpp.

template<class Scalar >
Teuchos::RCP<LinearRegression<Scalar> > Tempus_Test::linearRegression ( )

Definition at line 176 of file Tempus_ConvergenceTestUtils.hpp.

void Tempus_Test::test_pseudotransient_fsa ( const bool  use_dfdp_as_tangent,
Teuchos::FancyOStream &  out,
bool &  success 
)

Definition at line 37 of file Tempus_BackwardEuler_PseudoTransient_SA.cpp.

void Tempus_Test::test_sincos_fsa ( const std::string &  method_name,
const bool  use_combined_method,
const bool  use_dfdp_as_tangent,
Teuchos::FancyOStream &  out,
bool &  success 
)

Definition at line 43 of file Tempus_DIRK_FSA.hpp.

void Tempus_Test::test_sincos_fsa ( const bool  use_combined_method,
const bool  use_dfdp_as_tangent,
Teuchos::FancyOStream &  out,
bool &  success 
)

Definition at line 48 of file Tempus_BackwardEuler_FSA.hpp.

void Tempus_Test::test_vdp_fsa ( const std::string &  method_name,
const bool  use_combined_method,
const bool  use_dfdp_as_tangent,
Teuchos::FancyOStream &  out,
bool &  success 
)

Definition at line 44 of file Tempus_IMEX_RK_Partitioned_FSA.hpp.

void Tempus_Test::test_vdp_fsa ( const bool  use_combined_method,
const bool  use_dfdp_as_tangent,
Teuchos::FancyOStream &  out,
bool &  success 
)

Definition at line 45 of file Tempus_IMEX_RK_FSA.hpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SinCos_Staggered_FSA   
)

Definition at line 13 of file Tempus_BackwardEuler_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK  ,
VanDerPol_Combined_FSA   
)

Definition at line 13 of file Tempus_IMEX_RK_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK  ,
VanDerPol_Staggered_FSA   
)

Definition at line 13 of file Tempus_IMEX_RK_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SinCos_Combined_FSA   
)

Definition at line 13 of file Tempus_BDF2_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SinCos_Combined_FSA   
)

Definition at line 13 of file Tempus_BackwardEuler_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SinCos_Staggered_FSA   
)

Definition at line 13 of file Tempus_BDF2_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( version  ,
default   
)

Definition at line 14 of file version.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK  ,
VanDerPol_Combined_FSA_Tangent   
)

Definition at line 18 of file Tempus_IMEX_RK_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK  ,
VanDerPol_Staggered_FSA_Tangent   
)

Definition at line 18 of file Tempus_IMEX_RK_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SinCos_Combined_FSA_Tangent   
)

Definition at line 18 of file Tempus_BDF2_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SinCos_Staggered_FSA_Tangent   
)

Definition at line 18 of file Tempus_BackwardEuler_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SinCos_Combined_FSA_Tangent   
)

Definition at line 18 of file Tempus_BackwardEuler_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SinCos_Staggered_FSA_Tangent   
)

Definition at line 18 of file Tempus_BDF2_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SinCos_Combined_FSA   
)

Definition at line 19 of file Tempus_DIRK_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SinCos_Staggered_FSA   
)

Definition at line 19 of file Tempus_DIRK_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK_Partitioned  ,
VanDerPol_Combined_FSA   
)

Definition at line 19 of file Tempus_IMEX_RK_Partitioned_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK_Partitioned  ,
VanDerPol_Staggered_FSA   
)

Definition at line 19 of file Tempus_IMEX_RK_Partitioned_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SinCos_Combined_FSA   
)

Definition at line 19 of file Tempus_ExplicitRK_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SinCos_Staggered_FSA   
)

Definition at line 19 of file Tempus_ExplicitRK_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SinCos_Combined_FSA_Tangent   
)

Definition at line 24 of file Tempus_DIRK_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK_Partitioned  ,
VanDerPol_Combined_FSA_Tangent   
)

Definition at line 24 of file Tempus_IMEX_RK_Partitioned_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SinCos_Staggered_FSA_Tangent   
)

Definition at line 24 of file Tempus_DIRK_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK_Partitioned  ,
VanDerPol_Staggered_FSA_Tangent   
)

Definition at line 24 of file Tempus_IMEX_RK_Partitioned_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SinCos_Combined_FSA_Tangent   
)

Definition at line 24 of file Tempus_ExplicitRK_Combined_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SinCos_Staggered_FSA_Tangent   
)

Definition at line 24 of file Tempus_ExplicitRK_Staggered_FSA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IntegratorBasic  ,
PL_ME_Construction   
)

Definition at line 31 of file Tempus_IntegratorTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( PhysicsState  ,
SinCos   
)

Definition at line 40 of file Tempus_PhysicsStateTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK  ,
ConstructingFromDefaults   
)

Definition at line 42 of file Tempus_IMEX_RKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SinCos_ASA   
)

Definition at line 42 of file Tempus_ExplicitRK_ASA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
ParameterList   
)

Definition at line 42 of file Tempus_ExplicitRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SinCos_ASA   
)

Definition at line 42 of file Tempus_DIRK_ASA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
ParameterList   
)

Definition at line 43 of file Tempus_DIRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK_Partitioned  ,
ConstructingFromDefaults   
)

Definition at line 43 of file Tempus_IMEX_RK_PartitionedTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ForwardEuler  ,
ParameterList   
)

Definition at line 43 of file Tempus_ForwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( OperatorSplit  ,
ConstructingFromDefaults   
)

Definition at line 44 of file Tempus_OperatorSplitTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SinCos_ASA   
)

Definition at line 46 of file Tempus_BDF2_ASA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Observer  ,
IntegratorObserverLogging   
)

Definition at line 46 of file Tempus_ObserverTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Subcycling  ,
ParameterList   
)

Definition at line 46 of file Tempus_SubcyclingTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SinCos_ASA   
)

Definition at line 47 of file Tempus_BackwardEuler_ASA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Leapfrog  ,
ConstructingFromDefaults   
)

Definition at line 51 of file Tempus_LeapfrogTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkExplicitAForm  ,
BallParabolic   
)

Definition at line 51 of file Tempus_NewmarkTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Trapezoidal  ,
ParameterList   
)

Definition at line 52 of file Tempus_TrapezoidalTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
ParameterList   
)

Definition at line 53 of file Tempus_BackwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
ParameterList   
)

Definition at line 53 of file Tempus_BDF2Test.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( HHTAlpha  ,
BallParabolic   
)

Definition at line 54 of file Tempus_HHTAlphaTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IntegratorBasic  ,
Construction   
)

Definition at line 65 of file Tempus_IntegratorTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SteadyQuadratic_PseudoTransient_FSA   
)

Definition at line 82 of file Tempus_ExplicitRK_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SteadyQuadratic_PseudoTransient_FSA   
)

Definition at line 84 of file Tempus_BDF2_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SteadyQuadratic_PseudoTransient_FSA   
)

Definition at line 84 of file Tempus_BackwardEuler_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SteadyQuadratic_PseudoTransient_FSA   
)

Definition at line 85 of file Tempus_DIRK_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SteadyQuadratic_PseudoTransient_FSA_Tangent   
)

Definition at line 87 of file Tempus_ExplicitRK_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SteadyQuadratic_PseudoTransient_FSA_Tangent   
)

Definition at line 89 of file Tempus_BDF2_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SteadyQuadratic_PseudoTransient_FSA_Tangent   
)

Definition at line 89 of file Tempus_BackwardEuler_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SteadyQuadratic_PseudoTransient_FSA_Tangent   
)

Definition at line 90 of file Tempus_DIRK_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SteadyQuadratic_PseudoTransient_ASA   
)

Definition at line 94 of file Tempus_ExplicitRK_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SteadyQuadratic_PseudoTransient_ASA   
)

Definition at line 96 of file Tempus_BackwardEuler_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SteadyQuadratic_PseudoTransient_ASA   
)

Definition at line 96 of file Tempus_BDF2_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SteadyQuadratic_PseudoTransient_ASA   
)

Definition at line 97 of file Tempus_DIRK_PseudoTransient_SA.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ForwardEuler  ,
ConstructingFromDefaults   
)

Definition at line 99 of file Tempus_ForwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Subcycling  ,
ConstructingFromDefaults   
)

Definition at line 102 of file Tempus_SubcyclingTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
ConstructingFromDefaults   
)

Definition at line 104 of file Tempus_BDF2Test.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Trapezoidal  ,
ConstructingFromDefaults   
)

Definition at line 104 of file Tempus_TrapezoidalTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
ConstructingFromDefaults   
)

Definition at line 107 of file Tempus_BackwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkExplicitAForm  ,
SinCos   
)

Definition at line 117 of file Tempus_NewmarkTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( HHTAlpha  ,
ConstructingFromDefaults   
)

Definition at line 119 of file Tempus_HHTAlphaTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK  ,
VanDerPol   
)

Definition at line 133 of file Tempus_IMEX_RKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
ConstructingFromDefaults   
)

Definition at line 135 of file Tempus_ExplicitRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( IMEX_RK_Partitioned  ,
VanDerPol   
)

Definition at line 139 of file Tempus_IMEX_RK_PartitionedTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Leapfrog  ,
SinCos   
)

Definition at line 143 of file Tempus_LeapfrogTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( OperatorSplit  ,
VanDerPol   
)

Definition at line 145 of file Tempus_OperatorSplitTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Observer  ,
IntegratorObserverComposite   
)

Definition at line 160 of file Tempus_ObserverTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
ConstructingFromDefaults   
)

Definition at line 180 of file Tempus_DIRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ForwardEuler  ,
SinCos   
)

Definition at line 193 of file Tempus_ForwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SinCos   
)

Definition at line 199 of file Tempus_BDF2Test.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Subcycling  ,
SinCosAdapt   
)

Definition at line 201 of file Tempus_SubcyclingTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
SinCos   
)

Definition at line 203 of file Tempus_BackwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( HHTAlpha  ,
SinCos_SecondOrder   
)

Definition at line 210 of file Tempus_HHTAlphaTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Trapezoidal  ,
SinCos   
)

Definition at line 214 of file Tempus_TrapezoidalTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkExplicitAForm  ,
HarmonicOscillatorDamped   
)

Definition at line 231 of file Tempus_NewmarkTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
SinCos   
)

Definition at line 233 of file Tempus_ExplicitRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
SinCos   
)

Definition at line 278 of file Tempus_DIRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
CDR   
)

Definition at line 316 of file Tempus_BackwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ForwardEuler  ,
VanDerPol   
)

Definition at line 317 of file Tempus_ForwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
SinCosAdapt   
)

Definition at line 322 of file Tempus_BDF2Test.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Trapezoidal  ,
VanDerPol   
)

Definition at line 330 of file Tempus_TrapezoidalTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkImplicitAForm  ,
ConstructingFromDefaults   
)

Definition at line 345 of file Tempus_NewmarkTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( HHTAlpha  ,
SinCos_FirstOrder   
)

Definition at line 355 of file Tempus_HHTAlphaTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( Subcycling  ,
VanDerPolOperatorSplit   
)

Definition at line 366 of file Tempus_SubcyclingTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ForwardEuler  ,
NumberTimeSteps   
)

Definition at line 400 of file Tempus_ForwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
EmbeddedVanDerPol   
)

Definition at line 415 of file Tempus_ExplicitRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkImplicitDForm  ,
ConstructingFromDefaults   
)

Definition at line 444 of file Tempus_NewmarkTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ForwardEuler  ,
Variable_TimeSteps   
)

Definition at line 446 of file Tempus_ForwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
VanDerPol   
)

Definition at line 455 of file Tempus_DIRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
CDR   
)

Definition at line 470 of file Tempus_BDF2Test.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
VanDerPol   
)

Definition at line 472 of file Tempus_BackwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( HHTAlpha  ,
SinCos_CD   
)

Definition at line 501 of file Tempus_HHTAlphaTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( ExplicitRK  ,
stage_number   
)

Definition at line 529 of file Tempus_ExplicitRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkImplicitAForm  ,
HarmonicOscillatorDamped_SecondOrder   
)

Definition at line 543 of file Tempus_NewmarkTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( DIRK  ,
EmbeddedVanDerPol   
)

Definition at line 551 of file Tempus_DIRKTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BackwardEuler  ,
OptInterface   
)

Definition at line 556 of file Tempus_BackwardEulerTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( BDF2  ,
VanDerPol   
)

Definition at line 633 of file Tempus_BDF2Test.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkImplicitDForm  ,
HarmonicOscillatorDamped_SecondOrder   
)

Definition at line 655 of file Tempus_NewmarkTest.cpp.

Tempus_Test::TEUCHOS_UNIT_TEST ( NewmarkImplicitAForm  ,
HarmonicOscillatorDamped_FirstOrder   
)

Definition at line 767 of file Tempus_NewmarkTest.cpp.

template<class Scalar >
void Tempus_Test::writeOrderError ( const std::string  filename,
Teuchos::RCP< Tempus::Stepper< Scalar > >  stepper,
std::vector< Scalar > &  StepSize,
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &  solutions,
std::vector< Scalar > &  xErrorNorm,
Scalar &  xSlope,
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &  solutionsDot,
std::vector< Scalar > &  xDotErrorNorm,
Scalar &  xDotSlope,
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &  solutionsDotDot,
std::vector< Scalar > &  xDotDotErrorNorm,
Scalar &  xDotDotSlope 
)

Definition at line 184 of file Tempus_ConvergenceTestUtils.hpp.

template<class Scalar >
void Tempus_Test::writeOrderError ( const std::string  filename,
Teuchos::RCP< Tempus::Stepper< Scalar > >  stepper,
std::vector< Scalar > &  StepSize,
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &  solutions,
std::vector< Scalar > &  xErrorNorm,
Scalar &  xSlope,
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &  solutionsDot,
std::vector< Scalar > &  xDotErrorNorm,
Scalar &  xDotSlope 
)

Definition at line 264 of file Tempus_ConvergenceTestUtils.hpp.

template<class Scalar >
void Tempus_Test::writeOrderError ( const std::string  filename,
Teuchos::RCP< Tempus::Stepper< Scalar > >  stepper,
std::vector< Scalar > &  StepSize,
std::vector< Teuchos::RCP< Thyra::VectorBase< Scalar >>> &  solutions,
std::vector< Scalar > &  xErrorNorm,
Scalar &  xSlope 
)

Definition at line 285 of file Tempus_ConvergenceTestUtils.hpp.

template<class Scalar >
void Tempus_Test::writeSolution ( const std::string  filename,
Teuchos::RCP< const Tempus::SolutionHistory< Scalar > >  solutionHistory 
)

Definition at line 306 of file Tempus_ConvergenceTestUtils.hpp.