9 #ifndef Tempus_Stepper_ErrorNorm_impl_hpp
10 #define Tempus_Stepper_ErrorNorm_impl_hpp
13 #include "Thyra_DefaultSerialDenseLinearOpWithSolve_decl.hpp"
14 #include "Thyra_MultiVectorStdOps_decl.hpp"
15 #include "Thyra_VectorSpaceBase_decl.hpp"
16 #include "Thyra_VectorStdOps_decl.hpp"
23 template<
class Scalar>
27 template<
class Scalar>
29 relTol_(relTol), abssTol_(absTol)
32 template<
class Scalar>
38 if (errorWeightVector_ == Teuchos::null)
39 errorWeightVector_ = Thyra::createMember(x->space());
41 if (u_ == Teuchos::null)
42 u_ = Thyra::createMember(x->space());
44 if (uNext_ == Teuchos::null)
45 uNext_ = Thyra::createMember(x->space());
48 Thyra::abs(*x, u_.ptr());
49 Thyra::abs(*xNext, uNext_.ptr());
50 Thyra::pair_wise_max_update(relTol_, *u_, uNext_.ptr());
52 Thyra::add_scalar(abssTol_, uNext_.ptr());
54 Scalar absTol = Thyra::norm_2(*uNext_)*numericalTol<Scalar>();
55 if (
approxZero(absTol) ) absTol = numericalTol<Scalar>();
56 Thyra::add_scalar(absTol, uNext_.ptr());
60 Thyra::ele_wise_divide(Teuchos::as<Scalar>(1.0), *err, *uNext_, errorWeightVector_.ptr());
62 const auto space_dim = err->space()->dim();
63 Scalar err_norm = std::abs( Thyra::norm(*errorWeightVector_) / space_dim);
68 template<
class Scalar>
72 if (scratchVector_ == Teuchos::null)
73 scratchVector_ = Thyra::createMember(x->space());
75 Thyra::assign(scratchVector_.ptr(), *x);
76 Thyra::abs(*x, scratchVector_.ptr());
77 Thyra::Vt_S(scratchVector_.ptr(), relTol_);
79 Thyra::Vp_S(scratchVector_.ptr(), abssTol_);
81 Scalar absTol = Thyra::norm_2(*scratchVector_)*numericalTol<Scalar>();
82 if (
approxZero(absTol) ) absTol = numericalTol<Scalar>();
83 Thyra::add_scalar(absTol, scratchVector_.ptr());
85 Thyra::ele_wise_divide(Teuchos::as<Scalar>(1.0), *x, *scratchVector_, scratchVector_.ptr());
86 Scalar err = Thyra::norm_inf(*scratchVector_);
Stepper_ErrorNorm()
Default Constructor.
Scalar computeWRMSNorm(const Teuchos::RCP< const Thyra::VectorBase< Scalar >> &x, const Teuchos::RCP< const Thyra::VectorBase< Scalar >> &xNext, const Teuchos::RCP< const Thyra::VectorBase< Scalar >> &err)
Compute the weigthed root mean square norm.
bool approxZero(Scalar value, Scalar tol=Teuchos::ScalarTraits< Scalar >::sfmin())
Test if value is approximately zero within tolerance.
Scalar errorNorm(const Teuchos::RCP< const Thyra::VectorBase< Scalar >> &x)
Compute the error Norm.