12#include <compile_time_options.h>
18 namespace ShallowWater
20 template <
typename ScalarNumber =
double>
25 : ParameterAcceptor(subsection)
29 "iterations", iterations_,
"Number of limiter iterations");
31 if constexpr (std::is_same<ScalarNumber, double>::value)
32 newton_tolerance_ = 1.e-10;
34 newton_tolerance_ = 1.e-4;
35 add_parameter(
"newton tolerance",
37 "Tolerance for the quadratic newton stopping criterion");
39 newton_max_iterations_ = 2;
40 add_parameter(
"newton max iterations",
41 newton_max_iterations_,
42 "Maximal number of quadratic newton iterations performed "
45 relaxation_factor_ = ScalarNumber(1.);
46 add_parameter(
"relaxation factor",
48 "Factor for scaling the relaxation window with r_i = "
49 "factor * (m_i/|Omega|)^(1.5/d).");
51 limit_on_kinetic_energy_ =
false;
52 add_parameter(
"limit on kinetic energy",
53 limit_on_kinetic_energy_,
54 "Limit on kinetic energy");
56 limit_on_square_velocity_ =
true;
57 add_parameter(
"limit on square velocity",
58 limit_on_square_velocity_,
59 "Limit on square velocity");
71 unsigned int iterations_;
72 ScalarNumber newton_tolerance_;
73 unsigned int newton_max_iterations_;
74 ScalarNumber relaxation_factor_;
76 bool limit_on_kinetic_energy_;
77 bool limit_on_square_velocity_;
86 template <
int dim,
typename Number =
double>
139 using Bounds = std::array<Number, n_bounds>;
147 : hyperbolic_system(hyperbolic_system)
148 , parameters(parameters)
149 , precomputed_values(precomputed_values)
156 void reset(
const unsigned int i,
167 const dealii::Tensor<1, dim, Number> &scaled_c_ij,
181 const Bounds &bounds_right);
196 const Number t_min = Number(0.),
197 const Number t_max = Number(1.));
231 Number h_relaxation_numerator;
232 Number kin_relaxation_numerator;
233 Number v2_relaxation_numerator;
234 Number relaxation_denominator;
247 template <
int dim,
typename Number>
248 DEAL_II_ALWAYS_INLINE
inline void
255 auto &[h_min, h_max, h_small, kin_max, v2_max] = bounds_;
257 h_min = Number(std::numeric_limits<ScalarNumber>::max());
259 h_small = Number(0.);
260 kin_max = Number(0.);
263 h_relaxation_numerator = Number(0.);
264 kin_relaxation_numerator = Number(0.);
265 v2_relaxation_numerator = Number(0.);
266 relaxation_denominator = Number(0.);
270 template <
int dim,
typename Number>
275 const dealii::Tensor<1, dim, Number> &scaled_c_ij,
278 const auto view = hyperbolic_system.view<dim, Number>();
282 const auto f_star_ij = view.f(U_star_ij);
283 const auto f_star_ji = view.f(U_star_ji);
286 const auto U_ij_bar =
288 (U_star_ij + U_star_ji +
289 contract(
add(f_star_ij, -f_star_ji), scaled_c_ij)) +
294 auto &[h_min, h_max, h_small, kin_max, v2_max] = bounds_;
296 const auto h_bar_ij = view.water_depth(U_ij_bar);
297 h_min = std::min(h_min, h_bar_ij);
298 h_max = std::max(h_max, h_bar_ij);
300 const auto kin_bar_ij = view.kinetic_energy(U_ij_bar);
301 kin_max = std::max(kin_max, kin_bar_ij);
303 const auto v_bar_ij = view.momentum(U_ij_bar) *
304 view.inverse_water_depth_mollified(U_ij_bar);
305 const auto v2_bar_ij = v_bar_ij.norm_square();
306 v2_max = std::max(v2_max, v2_bar_ij);
311 const auto beta_ij = Number(1.);
313 relaxation_denominator += std::abs(beta_ij);
315 const auto h_i = view.water_depth(U_i);
316 const auto h_j = view.water_depth(U_j);
317 h_relaxation_numerator += beta_ij * (h_i + h_j);
319 const auto kin_i = view.kinetic_energy(U_i);
320 const auto kin_j = view.kinetic_energy(U_j);
321 kin_relaxation_numerator += beta_ij * (kin_i + kin_j);
324 view.momentum(U_i) * view.inverse_water_depth_mollified(U_i);
326 view.momentum(U_j) * view.inverse_water_depth_mollified(U_j);
327 v2_relaxation_numerator +=
328 beta_ij * (-vel_i.norm_square() + vel_j.norm_square());
332 template <
int dim,
typename Number>
333 DEAL_II_ALWAYS_INLINE
inline auto
336 const auto view = hyperbolic_system.view<dim, Number>();
338 auto relaxed_bounds = bounds_;
339 auto &[h_min, h_max, h_small, kin_max, v2_max] = relaxed_bounds;
343 Number r_i = std::sqrt(hd_i);
344 if constexpr (dim == 2)
345 r_i = dealii::Utilities::fixed_power<3>(std::sqrt(r_i));
346 else if constexpr (dim == 1)
347 r_i = dealii::Utilities::fixed_power<3>(r_i);
348 r_i *= parameters.relaxation_factor();
350 constexpr ScalarNumber eps = std::numeric_limits<ScalarNumber>::epsilon();
353 std::abs(h_relaxation_numerator) /
354 (relaxation_denominator + Number(eps));
356 h_min = std::max((Number(1.) - r_i) * h_min, h_min - h_relaxed);
357 h_max = std::min((Number(1.) + r_i) * h_max, h_max + h_relaxed);
360 std::abs(kin_relaxation_numerator) /
361 (relaxation_denominator + Number(eps));
363 kin_max = std::min((Number(1.) + r_i) * kin_max, kin_max + kin_relaxed);
366 std::abs(v2_relaxation_numerator) /
367 (relaxation_denominator + Number(eps));
369 v2_max = std::min((Number(1.) + r_i) * v2_max, v2_max + v2_relaxed);
374 if constexpr (dim == 2)
375 r_i = std::sqrt(hd_i);
376 r_i *= view.dry_state_relaxation_factor();
378 h_small = view.reference_water_depth() * r_i;
380 return relaxed_bounds;
384 template <
int dim,
typename Number>
385 DEAL_II_ALWAYS_INLINE
inline auto
389 const auto &[h_min_l, h_max_l, h_small_l, k_max_l, v2_max_l] = bounds_l;
390 const auto &[h_min_r, h_max_r, h_small_r, k_max_r, v2_max_r] = bounds_r;
392 return {std::min(h_min_l, h_min_r),
393 std::max(h_max_l, h_max_r),
394 std::min(h_small_l, h_small_r),
395 std::max(k_max_l, h_max_r),
396 std::max(v2_max_l, v2_max_r)};
400 template <
int dim,
typename Number>
401 DEAL_II_ALWAYS_INLINE
inline bool
407 AssertThrow(
false, dealii::ExcNotImplemented());
typename get_value_type< Number >::type ScalarNumber
Vectors::MultiComponentVector< ScalarNumber, n_precomputed_values > PrecomputedVector
dealii::Tensor< 1, problem_dimension, Number > state_type
std::array< Number, n_precomputed_values > precomputed_type
static constexpr unsigned int problem_dimension
std::tuple< state_type, Number > flux_contribution_type
ACCESSOR_READ_ONLY(limit_on_square_velocity)
ACCESSOR_READ_ONLY(iterations)
ACCESSOR_READ_ONLY(relaxation_factor)
ACCESSOR_READ_ONLY(newton_tolerance)
ACCESSOR_READ_ONLY(newton_max_iterations)
LimiterParameters(const std::string &subsection="/Limiter")
ACCESSOR_READ_ONLY(limit_on_kinetic_energy)
std::tuple< Number, bool > limit(const Bounds &bounds, const state_type &U, const state_type &P, const Number t_min=Number(0.), const Number t_max=Number(1.))
typename View::ScalarNumber ScalarNumber
typename View::flux_contribution_type flux_contribution_type
std::array< Number, n_bounds > Bounds
typename View::PrecomputedVector PrecomputedVector
void accumulate(const state_type &U_j, const state_type &U_star_ij, const state_type &U_star_ji, const dealii::Tensor< 1, dim, Number > &scaled_c_ij, const state_type &affine_shift)
Bounds bounds(const Number hd_i) const
Limiter(const HyperbolicSystem &hyperbolic_system, const Parameters ¶meters, const PrecomputedVector &precomputed_values)
typename View::precomputed_type precomputed_type
void reset(const unsigned int i, const state_type &U_i, const flux_contribution_type &flux_i)
typename View::state_type state_type
static Bounds combine_bounds(const Bounds &bounds_left, const Bounds &bounds_right)
static bool is_in_invariant_domain(const HyperbolicSystem &, const Bounds &, const state_type &)
static constexpr auto problem_dimension
static constexpr unsigned int n_bounds
LimiterParameters< ScalarNumber > Parameters
DEAL_II_ALWAYS_INLINE FT add(const FT &flux_left_ij, const FT &flux_right_ij)
DEAL_II_ALWAYS_INLINE dealii::Tensor< 1, problem_dim, T > contract(const FT &flux_ij, const TT &c_ij)