10#include <compile_time_options.h>
11#include <deal.II/base/config.h>
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).");
58 unsigned int iterations_;
59 ScalarNumber newton_tolerance_;
60 unsigned int newton_max_iterations_;
61 ScalarNumber relaxation_factor_;
95 template <
int dim,
typename Number =
double>
134 using Bounds = std::array<Number, n_bounds>;
142 : hyperbolic_system(hyperbolic_system)
143 , parameters(parameters)
144 , precomputed_values(precomputed_values)
161 const Bounds &bounds_right)
const;
186 void reset(
const unsigned int i,
197 const dealii::Tensor<1, dim, Number> &scaled_c_ij,
226 const Number t_min = Number(0.),
227 const Number t_max = Number(1.));
242 Number rho_relaxation_numerator;
243 Number rho_relaxation_denominator;
257 template <
int dim,
typename Number>
258 DEAL_II_ALWAYS_INLINE
inline auto
262 const auto view = hyperbolic_system.view<dim, Number>();
263 const auto rho_i = view.density(U_i);
264 const auto &[s_i, eta_i] =
265 precomputed_values.template get_tensor<Number, precomputed_type>(i);
267 return { rho_i, rho_i, s_i};
271 template <
int dim,
typename Number>
275 const auto &[rho_min_l, rho_max_l, s_min_l] = bounds_left;
276 const auto &[rho_min_r, rho_max_r, s_min_r] = bounds_right;
278 return {std::min(rho_min_l, rho_min_r),
279 std::max(rho_max_l, rho_max_r),
280 std::min(s_min_l, s_min_r)};
284 template <
int dim,
typename Number>
285 DEAL_II_ALWAYS_INLINE
inline void
294 auto &[rho_min, rho_max, s_min] = bounds_;
296 rho_min = Number(std::numeric_limits<ScalarNumber>::max());
297 rho_max = Number(0.);
298 s_min = Number(std::numeric_limits<ScalarNumber>::max());
302 rho_relaxation_numerator = Number(0.);
303 rho_relaxation_denominator = Number(0.);
304 s_interp_max = Number(0.);
308 template <
int dim,
typename Number>
310 const unsigned int *js,
313 const dealii::Tensor<1, dim, Number> &scaled_c_ij,
320 Assert(std::max(affine_shift.norm(), Number(0.)) == Number(0.),
321 dealii::ExcNotImplemented());
323 const auto view = hyperbolic_system.view<dim, Number>();
326 auto &[rho_min, rho_max, s_min] = bounds_;
328 const auto rho_i = view.density(U_i);
329 const auto m_i = view.momentum(U_i);
330 const auto rho_j = view.density(U_j);
331 const auto m_j = view.momentum(U_j);
332 const auto rho_affine_shift = view.density(affine_shift);
335 const auto rho_ij_bar =
336 ScalarNumber(0.5) * (rho_i + rho_j + (m_i - m_j) * scaled_c_ij) +
339 rho_min = std::min(rho_min, rho_ij_bar);
340 rho_max = std::max(rho_max, rho_ij_bar);
342 const auto &[s_j, eta_j] =
343 precomputed_values.template get_tensor<Number, precomputed_type>(js);
344 s_min = std::min(s_min, s_j);
349 const auto beta_ij = Number(1.);
350 rho_relaxation_numerator += beta_ij * (rho_i + rho_j);
351 rho_relaxation_denominator += std::abs(beta_ij);
353 const Number s_interp =
355 s_interp_max = std::max(s_interp_max, s_interp);
359 template <
int dim,
typename Number>
360 DEAL_II_ALWAYS_INLINE
inline auto
363 auto relaxed_bounds = bounds_;
364 auto &[rho_min, rho_max, s_min] = relaxed_bounds;
368 Number r_i = std::sqrt(hd_i);
369 if constexpr (dim == 2)
370 r_i = dealii::Utilities::fixed_power<3>(std::sqrt(r_i));
371 else if constexpr (dim == 1)
372 r_i = dealii::Utilities::fixed_power<3>(r_i);
373 r_i *= parameters.relaxation_factor();
375 constexpr ScalarNumber eps = std::numeric_limits<ScalarNumber>::epsilon();
376 const Number rho_relaxation =
377 std::abs(rho_relaxation_numerator) /
378 (std::abs(rho_relaxation_denominator) + Number(eps));
380 const auto relaxation =
381 ScalarNumber(2. * parameters.relaxation_factor()) * rho_relaxation;
383 rho_min = std::max((Number(1.) - r_i) * rho_min, rho_min - relaxation);
384 rho_max = std::min((Number(1.) + r_i) * rho_max, rho_max + relaxation);
386 const auto entropy_relaxation =
387 parameters.relaxation_factor() * (s_interp_max - s_min);
389 s_min = std::max((Number(1.) - r_i) * s_min, s_min - entropy_relaxation);
391 return relaxed_bounds;
typename get_value_type< Number >::type ScalarNumber
Vectors::MultiComponentVector< ScalarNumber, n_precomputed_values > PrecomputedVector
static constexpr unsigned int problem_dimension
dealii::Tensor< 1, problem_dimension, Number > state_type
std::array< Number, n_precomputed_values > precomputed_type
flux_type flux_contribution_type
ACCESSOR_READ_ONLY(iterations)
ACCESSOR_READ_ONLY(newton_max_iterations)
ACCESSOR_READ_ONLY(newton_tolerance)
ACCESSOR_READ_ONLY(relaxation_factor)
LimiterParameters(const std::string &subsection="/Limiter")
Limiter(const HyperbolicSystem &hyperbolic_system, const Parameters ¶meters, const PrecomputedVector &precomputed_values)
void reset(const unsigned int i, const state_type &U_i, const flux_contribution_type &flux_i)
typename View::PrecomputedVector PrecomputedVector
static constexpr auto problem_dimension
void accumulate(const unsigned int *js, const state_type &U_j, const flux_contribution_type &flux_j, const dealii::Tensor< 1, dim, Number > &scaled_c_ij, const state_type &affine_shift)
typename View::precomputed_type precomputed_type
typename View::ScalarNumber ScalarNumber
typename View::state_type state_type
LimiterParameters< ScalarNumber > Parameters
Bounds bounds(const Number hd_i) const
static constexpr unsigned int n_bounds
std::array< Number, n_bounds > Bounds
typename View::flux_contribution_type flux_contribution_type
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.))
Bounds combine_bounds(const Bounds &bounds_left, const Bounds &bounds_right) const
Bounds projection_bounds_from_state(const unsigned int i, const state_type &U_i) const