9 #include "Teuchos_UnitTestHarness.hpp"
10 #include "Teuchos_XMLParameterListHelpers.hpp"
11 #include "Teuchos_TimeMonitor.hpp"
13 #include "Thyra_VectorStdOps.hpp"
15 #include "Tempus_IntegratorBasic.hpp"
19 #include "../TestModels/SinCosModel.hpp"
20 #include "../TestModels/VanDerPolModel.hpp"
21 #include "../TestUtils/Tempus_ConvergenceTestUtils.hpp"
26 namespace Tempus_Test {
29 using Teuchos::ParameterList;
30 using Teuchos::sublist;
31 using Teuchos::getParametersFromXmlFile;
42 std::vector<double> StepSize;
43 std::vector<double> ErrorNorm;
44 const int nTimeStepSizes = 7;
47 for (
int n=0; n<nTimeStepSizes; n++) {
50 RCP<ParameterList> pList =
51 getParametersFromXmlFile(
"Tempus_PhysicsState_SinCos.xml");
58 RCP<ParameterList> scm_pl = sublist(pList,
"SinCosModel",
true);
60 RCP<SinCosModel<double> > model =
66 RCP<ParameterList> pl = sublist(pList,
"Tempus",
true);
67 pl->sublist(
"Demo Integrator")
68 .sublist(
"Time Step Control").set(
"Initial Time Step", dt);
69 RCP<Tempus::IntegratorBasic<double> > integrator =
70 Tempus::integratorBasic<double>(pl, model);
74 RCP<ParameterList> stepperPL =
75 integrator->getStepper()->getNonconstParameterList();
76 Teuchos::RCP<Tempus::Stepper<double> > physicsStepper = Teuchos::rcp(
78 integrator->setStepperWStepper(physicsStepper);
79 order = integrator->getStepper()->getOrder();
85 RCP<Thyra::VectorBase<double> > x0 =
86 model->getNominalValues().get_x()->clone_v();
87 integrator->initializeSolutionHistory(0.0, x0);
92 RCP<PhysicsStateCounter<double> > pSC = Teuchos::rcp(
94 integrator->getSolutionHistory()->getCurrentState()->setPhysicsState(pSC);
97 bool integratorStatus = integrator->advanceTime();
98 TEST_ASSERT(integratorStatus)
101 Teuchos::RCP<Tempus::PhysicsState<double> > pS =
102 integrator->getSolutionHistory()->getCurrentState()->getPhysicsState();
103 TEST_EQUALITY(pS->getName(),
"PhysicsStateTest");
106 TEST_EQUALITY(pSC->getCounter(), (int)(1.0/dt));
110 double time = integrator->getTime();
111 double timeFinal = pl->sublist(
"Demo Integrator")
112 .sublist(
"Time Step Control").get<
double>(
"Final Time");
113 TEST_FLOATING_EQUALITY(time, timeFinal, 1.0e-14);
116 RCP<Thyra::VectorBase<double> > x = integrator->getX();
117 RCP<const Thyra::VectorBase<double> > x_exact =
118 model->getExactSolution(time).get_x();
122 std::ofstream ftmp(
"Tempus_ForwardEuler_SinCos.dat");
124 integrator->getSolutionHistory();
125 RCP<const Thyra::VectorBase<double> > x_exact_plot;
126 for (
int i=0; i<solutionHistory->getNumStates(); i++) {
127 RCP<const SolutionState<double> > solutionState = (*solutionHistory)[i];
128 double time_i = solutionState->getTime();
129 RCP<const Thyra::VectorBase<double> > x_plot = solutionState->getX();
130 x_exact_plot = model->getExactSolution(time_i).get_x();
131 ftmp << time_i <<
" "
132 << Thyra::get_ele(*(x_plot), 0) <<
" "
133 << Thyra::get_ele(*(x_plot), 1) <<
" "
134 << Thyra::get_ele(*(x_exact_plot), 0) <<
" "
135 << Thyra::get_ele(*(x_exact_plot), 1) << std::endl;
141 RCP<Thyra::VectorBase<double> > xdiff = x->clone_v();
142 Thyra::V_StVpStV(xdiff.ptr(), 1.0, *x_exact, -1.0, *(x));
143 StepSize.push_back(dt);
144 const double L2norm = Thyra::norm_2(*xdiff);
145 ErrorNorm.push_back(L2norm);
149 double slope = computeLinearRegressionLogLog<double>(StepSize, ErrorNorm);
150 std::cout <<
" Stepper = ForwardEuler" << std::endl;
151 std::cout <<
" =========================" << std::endl;
152 std::cout <<
" Expected order: " << order << std::endl;
153 std::cout <<
" Observed order: " << slope << std::endl;
154 std::cout <<
" =========================" << std::endl;
155 TEST_FLOATING_EQUALITY( slope, order, 0.01 );
156 TEST_FLOATING_EQUALITY( ErrorNorm[0], 0.051123, 1.0e-4 );
158 std::ofstream ftmp(
"Tempus_ForwardEuler_SinCos-Error.dat");
159 double error0 = 0.8*ErrorNorm[0];
160 for (
int n=0; n<nTimeStepSizes; n++) {
161 ftmp << StepSize[n] <<
" " << ErrorNorm[n] <<
" "
162 << error0*(pow(StepSize[n]/StepSize[0],order)) << std::endl;
166 Teuchos::TimeMonitor::summarize();
This is a Forward Euler time stepper to test the PhysicsState.
Sine-Cosine model problem from Rythmos. This is a canonical Sine-Cosine differential equation with a...
TEUCHOS_UNIT_TEST(BackwardEuler, SinCos_ASA)
Teuchos::RCP< SolutionHistory< Scalar > > solutionHistory(Teuchos::RCP< Teuchos::ParameterList > pList=Teuchos::null)
Nonmember constructor.
SolutionHistory is basically a container of SolutionStates. SolutionHistory maintains a collection of...
PhysicsStateCounter is a simple PhysicsState that counts steps.
Solution state for integrators and steppers. SolutionState contains the metadata for solutions and th...