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 {
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++) {
51 getParametersFromXmlFile(
"Tempus_PhysicsState_SinCos.xml");
68 .
sublist(
"Time Step Control").
set(
"Initial Time Step", dt);
70 Tempus::createIntegratorBasic<double>(pl, model);
76 integrator->setStepper(physicsStepper);
77 order = integrator->getStepper()->getOrder();
84 model->getNominalValues().get_x()->clone_v();
85 integrator->initializeSolutionHistory(0.0, x0);
92 integrator->getSolutionHistory()->getCurrentState()->setPhysicsState(pSC);
95 bool integratorStatus = integrator->advanceTime();
100 integrator->getSolutionHistory()->getCurrentState()->getPhysicsState();
108 double time = integrator->getTime();
109 double timeFinal = pl->sublist(
"Demo Integrator")
110 .sublist(
"Time Step Control").
get<
double>(
"Final Time");
116 model->getExactSolution(time).get_x();
120 std::ofstream ftmp(
"Tempus_ForwardEuler_SinCos.dat");
122 integrator->getSolutionHistory();
124 for (
int i=0; i<solutionHistory->getNumStates(); i++) {
126 double time_i = solutionState->getTime();
128 x_exact_plot = model->getExactSolution(time_i).get_x();
129 ftmp << time_i <<
" "
130 << Thyra::get_ele(*(x_plot), 0) <<
" "
131 << Thyra::get_ele(*(x_plot), 1) <<
" "
132 << Thyra::get_ele(*(x_exact_plot), 0) <<
" "
133 << Thyra::get_ele(*(x_exact_plot), 1) << std::endl;
140 Thyra::V_StVpStV(xdiff.
ptr(), 1.0, *x_exact, -1.0, *(x));
141 StepSize.push_back(dt);
142 const double L2norm = Thyra::norm_2(*xdiff);
143 ErrorNorm.push_back(L2norm);
147 double slope = computeLinearRegressionLogLog<double>(StepSize, ErrorNorm);
148 std::cout <<
" Stepper = ForwardEuler" << std::endl;
149 std::cout <<
" =========================" << std::endl;
150 std::cout <<
" Expected order: " << order << std::endl;
151 std::cout <<
" Observed order: " << slope << std::endl;
152 std::cout <<
" =========================" << std::endl;
156 std::ofstream ftmp(
"Tempus_ForwardEuler_SinCos-Error.dat");
157 double error0 = 0.8*ErrorNorm[0];
158 for (
int n=0; n<nTimeStepSizes; n++) {
159 ftmp << StepSize[n] <<
" " << ErrorNorm[n] <<
" "
160 << error0*(pow(StepSize[n]/StepSize[0],order)) << std::endl;
This is a Forward Euler time stepper to test the PhysicsState.
ParameterList & set(std::string const &name, T const &value, std::string const &docString="", RCP< const ParameterEntryValidator > const &validator=null)
#define TEST_FLOATING_EQUALITY(v1, v2, tol)
Sine-Cosine model problem from Rythmos. This is a canonical Sine-Cosine differential equation with a...
TEUCHOS_UNIT_TEST(BackwardEuler, SinCos_ASA)
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
static void summarize(Ptr< const Comm< int > > comm, std::ostream &out=std::cout, const bool alwaysWriteLocal=false, const bool writeGlobalStats=true, const bool writeZeroTimers=true, const ECounterSetOp setOp=Intersection, const std::string &filter="", const bool ignoreZeroTimers=false)
SolutionHistory is basically a container of SolutionStates. SolutionHistory maintains a collection of...
PhysicsStateCounter is a simple PhysicsState that counts steps.
ParameterList & sublist(const std::string &name, bool mustAlreadyExist=false, const std::string &docString="")
#define TEST_EQUALITY(v1, v2)
Solution state for integrators and steppers. SolutionState contains the metadata for solutions and th...