203int main(
int argc,
char *argv[])
206 bool success =
false;
209 Teuchos::RCP<const Thyra::ModelEvaluator<double> >
216 RCP<Thyra::VectorBase<double> > x_n =
217 model->getNominalValues().get_x()->clone_v();
218 RCP<Thyra::VectorBase<double> > xDot_n =
219 model->getNominalValues().get_x_dot()->clone_v();
222 double finalTime = 2.0;
223 int nTimeSteps = 2001;
224 const double constDT = finalTime/(nTimeSteps-1);
227 cout << n <<
" " << time <<
" " << get_ele(*(x_n), 0)
228 <<
" " << get_ele(*(x_n), 1) << endl;
229 while (passed && time < finalTime && n < nTimeSteps) {
232 RCP<Thyra::VectorBase<double> > x_np1 = x_n->clone_v();
240 auto inArgs = model->createInArgs();
241 auto outArgs = model->createOutArgs();
244 inArgs.set_x_dot(Teuchos::null);
245 outArgs.set_f(xDot_n);
248 model->evalModel(inArgs, outArgs);
251 Thyra::V_VpStV(x_np1.ptr(), *x_n, dt, *xDot_n);
254 if ( std::isnan(Thyra::norm(*x_np1)) ) {
258 Thyra::V_V(x_n.ptr(), *x_np1);
264 cout << n <<
" " << time <<
" " << get_ele(*(x_n), 0)
265 <<
" " << get_ele(*(x_n), 1) << endl;
269 RCP<Thyra::VectorBase<double> > x_regress = x_n->clone_v();
271 Thyra::DetachedVectorView<double> x_regress_view(*x_regress);
272 x_regress_view[0] = -1.59496108218721311;
273 x_regress_view[1] = 0.96359412806611255;
276 RCP<Thyra::VectorBase<double> > x_error = x_n->clone_v();
277 Thyra::V_VmV(x_error.ptr(), *x_n, *x_regress);
278 double x_L2norm_error = Thyra::norm_2(*x_error );
279 double x_L2norm_regress = Thyra::norm_2(*x_regress);
281 cout <<
"Relative L2 Norm of the error (regression) = "
282 << x_L2norm_error/x_L2norm_regress << endl;
283 if ( x_L2norm_error > 1.0e-08*x_L2norm_regress) {
285 cout <<
"FAILED regression constraint!" << endl;
288 RCP<Thyra::VectorBase<double> > x_best = x_n->clone_v();
290 Thyra::DetachedVectorView<double> x_best_view(*x_best);
291 x_best_view[0] = -1.59496108218721311;
292 x_best_view[1] = 0.96359412806611255;
295 Thyra::V_VmV(x_error.ptr(), *x_n, *x_best);
296 x_L2norm_error = Thyra::norm_2(*x_error);
297 double x_L2norm_best = Thyra::norm_2(*x_best );
299 cout <<
"Relative L2 Norm of the error (best) = "
300 << x_L2norm_error/x_L2norm_best << endl;
301 if ( x_L2norm_error > 0.02*x_L2norm_best) {
303 cout <<
"FAILED best constraint!" << endl;
305 if (passed) success =
true;
307 TEUCHOS_STANDARD_CATCH_STATEMENTS(verbose, std::cerr, success);
310 cout <<
"\nEnd Result: Test Passed!" << std::endl;
312 return ( success ? EXIT_SUCCESS : EXIT_FAILURE );