13 #include "Teuchos_DefaultComm.hpp"
15 #include "Thyra_VectorStdOps.hpp"
16 #include "Thyra_MultiVectorStdOps.hpp"
18 #include "Tempus_IntegratorBasic.hpp"
19 #include "Tempus_IntegratorAdjointSensitivity.hpp"
21 #include "Thyra_DefaultMultiVectorProductVector.hpp"
22 #include "Thyra_DefaultProductVector.hpp"
24 #include "../TestModels/SinCosModel.hpp"
25 #include "../TestUtils/Tempus_ConvergenceTestUtils.hpp"
30 namespace Tempus_Test {
32 using Teuchos::getParametersFromXmlFile;
35 using Teuchos::sublist;
45 std::vector<std::string> RKMethods;
46 RKMethods.push_back(
"General DIRK");
47 RKMethods.push_back(
"RK Backward Euler");
48 RKMethods.push_back(
"DIRK 1 Stage Theta Method");
49 RKMethods.push_back(
"RK Implicit 1 Stage 1st order Radau IA");
50 RKMethods.push_back(
"SDIRK 2 Stage 2nd order");
51 RKMethods.push_back(
"RK Implicit 2 Stage 2nd order Lobatto IIIB");
52 RKMethods.push_back(
"SDIRK 2 Stage 3rd order");
53 RKMethods.push_back(
"EDIRK 2 Stage 3rd order");
54 RKMethods.push_back(
"EDIRK 2 Stage Theta Method");
55 RKMethods.push_back(
"SDIRK 3 Stage 4th order");
56 RKMethods.push_back(
"SDIRK 5 Stage 4th order");
57 RKMethods.push_back(
"SDIRK 5 Stage 5th order");
59 std::vector<double> RKMethodErrors;
60 RKMethodErrors.push_back(8.48235e-05);
61 RKMethodErrors.push_back(0.0383339);
62 RKMethodErrors.push_back(0.000221028);
63 RKMethodErrors.push_back(0.0428449);
64 RKMethodErrors.push_back(8.48235e-05);
65 RKMethodErrors.push_back(0.000297933);
66 RKMethodErrors.push_back(4.87848e-06);
67 RKMethodErrors.push_back(7.30827e-07);
68 RKMethodErrors.push_back(0.000272997);
69 RKMethodErrors.push_back(3.10132e-07);
70 RKMethodErrors.push_back(7.56838e-10);
71 RKMethodErrors.push_back(1.32374e-10);
76 for (std::vector<std::string>::size_type m = 0; m != RKMethods.size(); m++) {
77 std::string RKMethod_ = RKMethods[m];
78 std::replace(RKMethod_.begin(), RKMethod_.end(),
' ',
'_');
79 std::replace(RKMethod_.begin(), RKMethod_.end(),
'/',
'.');
80 std::vector<double> StepSize;
81 std::vector<double> ErrorNorm;
82 const int nTimeStepSizes = 2;
85 for (
int n = 0; n < nTimeStepSizes; n++) {
88 getParametersFromXmlFile(
"Tempus_DIRK_SinCos.xml");
97 pl->
sublist(
"Default Stepper").
set(
"Stepper Type", RKMethods[m]);
98 if (RKMethods[m] ==
"DIRK 1 Stage Theta Method" ||
99 RKMethods[m] ==
"EDIRK 2 Stage Theta Method") {
100 pl->
sublist(
"Default Stepper").
set<
double>(
"theta", 0.5);
102 else if (RKMethods[m] ==
"SDIRK 2 Stage 2nd order") {
103 pl->
sublist(
"Default Stepper").
set(
"gamma", 0.2928932188134524);
105 else if (RKMethods[m] ==
"SDIRK 2 Stage 3rd order") {
107 .
set<std::string>(
"Gamma Type",
"3rd Order A-stable");
114 sens_pl.
set(
"Mass Matrix Is Identity",
true);
118 interp_pl.
set(
"Interpolator Type",
"Lagrange");
119 interp_pl.
set(
"Order", 4);
122 pl->
sublist(
"Default Integrator")
124 .
set(
"Initial Time Step", dt);
126 Tempus::createIntegratorAdjointSensitivity<double>(pl, model);
127 order = integrator->getStepper()->getOrder();
135 model->getNominalValues().get_x()->clone_v();
136 const int num_param = model->get_p_space(0)->dim();
138 Thyra::createMembers(model->get_x_space(), num_param);
139 for (
int i = 0; i < num_param; ++i)
140 Thyra::assign(DxDp0->col(i).
ptr(),
141 *(model->getExactSensSolution(i, 0.0).get_x()));
142 integrator->initializeSolutionHistory(0.0, x0, Teuchos::null,
143 Teuchos::null, DxDp0, Teuchos::null,
147 bool integratorStatus = integrator->advanceTime();
151 double time = integrator->getTime();
152 double timeFinal = pl->sublist(
"Default Integrator")
153 .sublist(
"Time Step Control")
154 .
get<
double>(
"Final Time");
155 double tol = 100.0 * std::numeric_limits<double>::epsilon();
164 Thyra::createMembers(model->get_x_space(), num_param);
168 const int num_g = DgDp->domain()->dim();
169 for (
int i = 0; i < num_g; ++i)
170 for (
int j = 0; j < num_param; ++j) dxdp_view(i, j) = dgdp_view(j, i);
173 model->getExactSolution(time).get_x();
175 Thyra::createMembers(model->get_x_space(), num_param);
176 for (
int i = 0; i < num_param; ++i)
177 Thyra::assign(DxDp_exact->col(i).
ptr(),
178 *(model->getExactSensSolution(i, time).get_x()));
181 if (comm->getRank() == 0 && n == nTimeStepSizes - 1) {
185 std::ofstream ftmp(
"Tempus_" + RKMethod_ +
"_SinCos_AdjSens.dat");
187 integrator->getSolutionHistory();
188 for (
int i = 0; i < solutionHistory->getNumStates(); i++) {
190 (*solutionHistory)[i];
191 const double time_i = solutionState->getTime();
193 Teuchos::rcp_dynamic_cast<
const DPV>(solutionState->getX());
195 x_prod_plot->getVectorBlock(0);
197 Teuchos::rcp_dynamic_cast<
const DMVPV>(
198 x_prod_plot->getVectorBlock(1));
200 adjoint_prod_plot->getMultiVector();
202 model->getExactSolution(time_i).get_x();
203 ftmp << std::fixed << std::setprecision(7) << time_i << std::setw(11)
204 << get_ele(*(x_plot), 0) << std::setw(11)
205 << get_ele(*(x_plot), 1) << std::setw(11)
206 << get_ele(*(adjoint_plot->col(0)), 0) << std::setw(11)
207 << get_ele(*(adjoint_plot->col(0)), 1) << std::setw(11)
208 << get_ele(*(adjoint_plot->col(1)), 0) << std::setw(11)
209 << get_ele(*(adjoint_plot->col(1)), 1) << std::setw(11)
210 << get_ele(*(x_exact_plot), 0) << std::setw(11)
211 << get_ele(*(x_exact_plot), 1) << std::endl;
219 Thyra::V_StVpStV(xdiff.
ptr(), 1.0, *x_exact, -1.0, *(x));
220 Thyra::V_VmV(DxDpdiff.
ptr(), *DxDp_exact, *DxDp);
221 StepSize.push_back(dt);
222 double L2norm = Thyra::norm_2(*xdiff);
225 Thyra::norms_2(*DxDpdiff, L2norm_DxDp());
226 for (
int i = 0; i < num_param; ++i)
227 L2norm += L2norm_DxDp[i] * L2norm_DxDp[i];
228 L2norm = std::sqrt(L2norm);
229 ErrorNorm.push_back(L2norm);
235 if (comm->getRank() == 0) {
236 std::ofstream ftmp(
"Tempus_" + RKMethod_ +
"_SinCos_AdjSens-Error.dat");
237 double error0 = 0.8 * ErrorNorm[0];
238 for (
int n = 0; n < (int)StepSize.size(); n++) {
239 ftmp << StepSize[n] <<
" " << ErrorNorm[n] <<
" "
240 << error0 * (pow(StepSize[n] / StepSize[0], order)) << std::endl;
254 double slope = computeLinearRegressionLogLog<double>(StepSize, ErrorNorm);
255 out <<
" Stepper = " << RKMethods[m] << std::endl;
256 out <<
" =========================" << std::endl;
257 out <<
" Expected order: " << order << std::endl;
258 out <<
" Observed order: " << slope << std::endl;
259 out <<
" =========================" << std::endl;
#define TEST_FLOATING_EQUALITY(v1, v2, tol)
Sine-Cosine model problem from Rythmos. This is a canonical Sine-Cosine differential equation with a...
ParameterList & set(std::string const &name, T &&value, std::string const &docString="", RCP< const ParameterEntryValidator > const &validator=null)
static Teuchos::RCP< const Comm< OrdinalType > > getComm()
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...
ParameterList & sublist(const std::string &name, bool mustAlreadyExist=false, const std::string &docString="")
Solution state for integrators and steppers.