From 5c55d000d62b6e50bd81424cd2669f8b772a1768 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Andr=C3=A9s=20Rueda-Ram=C3=ADrez?= Date: Thu, 19 Dec 2024 17:51:03 +0100 Subject: [PATCH 1/2] Added 3D multi-ion GLM-MHD equations for the TreeMesh solver --- .../tree_3d_dgsem/elixir_mhdmultiion_ec.jl | 61 + src/Trixi.jl | 2 +- src/equations/equations.jl | 1 + src/equations/ideal_glm_mhd_multiion.jl | 2 +- src/equations/ideal_glm_mhd_multiion_3d.jl | 1093 +++++++++++++++++ test/test_tree_3d_mhdmultiion.jl | 156 +++ test/test_tree_3d_part3.jl | 3 + test/test_type.jl | 52 + 8 files changed, 1368 insertions(+), 2 deletions(-) create mode 100644 examples/tree_3d_dgsem/elixir_mhdmultiion_ec.jl create mode 100644 src/equations/ideal_glm_mhd_multiion_3d.jl create mode 100644 test/test_tree_3d_mhdmultiion.jl diff --git a/examples/tree_3d_dgsem/elixir_mhdmultiion_ec.jl b/examples/tree_3d_dgsem/elixir_mhdmultiion_ec.jl new file mode 100644 index 00000000000..3d8d183a94b --- /dev/null +++ b/examples/tree_3d_dgsem/elixir_mhdmultiion_ec.jl @@ -0,0 +1,61 @@ + +using OrdinaryDiffEq +using Trixi + +############################################################################### +# semidiscretization of the ideal MHD equations +equations = IdealGlmMhdMultiIonEquations3D(gammas = (1.4, 1.667), + charge_to_mass = (1.0, 2.0)) + +initial_condition = initial_condition_weak_blast_wave + +volume_flux = (flux_ruedaramirez_etal, flux_nonconservative_ruedaramirez_etal) +surface_flux = (flux_ruedaramirez_etal, flux_nonconservative_ruedaramirez_etal) +solver = DGSEM(polydeg = 3, surface_flux = surface_flux, + volume_integral = VolumeIntegralFluxDifferencing(volume_flux)) + +coordinates_min = (-2.0, -2.0, -2.0) +coordinates_max = (2.0, 2.0, 2.0) +mesh = TreeMesh(coordinates_min, coordinates_max, + initial_refinement_level = 4, + n_cells_max = 10_000) + +semi = SemidiscretizationHyperbolic(mesh, equations, initial_condition, solver, + source_terms = source_terms_lorentz) + +############################################################################### +# ODE solvers, callbacks etc. + +tspan = (0.0, 0.4) +ode = semidiscretize(semi, tspan) + +summary_callback = SummaryCallback() + +analysis_interval = 10 +analysis_callback = AnalysisCallback(semi, interval = analysis_interval) +alive_callback = AliveCallback(analysis_interval = analysis_interval) + +save_solution = SaveSolutionCallback(dt = 0.1, # interval=100, + save_initial_solution = true, + save_final_solution = true, + solution_variables = cons2prim) + +cfl = 0.5 + +stepsize_callback = StepsizeCallback(cfl = cfl) + +glm_speed_callback = GlmSpeedCallback(glm_scale = 0.5, cfl = cfl) + +callbacks = CallbackSet(summary_callback, + analysis_callback, alive_callback, + save_solution, + stepsize_callback, + glm_speed_callback) + +############################################################################### +# run the simulation + +sol = solve(ode, CarpenterKennedy2N54(williamson_condition = false), + dt = 1.0, # solve needs some value here but it will be overwritten by the stepsize_callback + save_everystep = false, callback = callbacks); +summary_callback() # print the timer summary diff --git a/src/Trixi.jl b/src/Trixi.jl index f8cc3a1a4d3..9fe2ee12ab9 100644 --- a/src/Trixi.jl +++ b/src/Trixi.jl @@ -156,7 +156,7 @@ export AcousticPerturbationEquations2D, CompressibleEulerEquationsQuasi1D, IdealGlmMhdEquations1D, IdealGlmMhdEquations2D, IdealGlmMhdEquations3D, IdealGlmMhdMulticomponentEquations1D, IdealGlmMhdMulticomponentEquations2D, - IdealGlmMhdMultiIonEquations2D, + IdealGlmMhdMultiIonEquations2D, IdealGlmMhdMultiIonEquations3D, HyperbolicDiffusionEquations1D, HyperbolicDiffusionEquations2D, HyperbolicDiffusionEquations3D, LinearScalarAdvectionEquation1D, LinearScalarAdvectionEquation2D, diff --git a/src/equations/equations.jl b/src/equations/equations.jl index 0799a040bb6..411ebdbf893 100644 --- a/src/equations/equations.jl +++ b/src/equations/equations.jl @@ -496,6 +496,7 @@ abstract type AbstractIdealGlmMhdMultiIonEquations{NDIMS, NVARS, NCOMP} <: AbstractEquations{NDIMS, NVARS} end include("ideal_glm_mhd_multiion.jl") include("ideal_glm_mhd_multiion_2d.jl") +include("ideal_glm_mhd_multiion_3d.jl") # Retrieve number of components from equation instance for the multicomponent case @inline function ncomponents(::AbstractIdealGlmMhdMulticomponentEquations{NDIMS, NVARS, diff --git a/src/equations/ideal_glm_mhd_multiion.jl b/src/equations/ideal_glm_mhd_multiion.jl index 557cb8a12da..07a6db0aa3d 100644 --- a/src/equations/ideal_glm_mhd_multiion.jl +++ b/src/equations/ideal_glm_mhd_multiion.jl @@ -51,7 +51,7 @@ end Source terms due to the Lorentz' force for plasmas with more than one ion species. These source terms are a fundamental, inseparable part of the multi-ion GLM-MHD equations, and vanish for a single-species plasma. In particular, they have to be used for every -simulation of [`IdealGlmMhdMultiIonEquations2D`](@ref). +simulation of [`IdealGlmMhdMultiIonEquations2D`](@ref) and [`IdealGlmMhdMultiIonEquations3D`](@ref). """ function source_terms_lorentz(u, x, t, equations::AbstractIdealGlmMhdMultiIonEquations) @unpack charge_to_mass = equations diff --git a/src/equations/ideal_glm_mhd_multiion_3d.jl b/src/equations/ideal_glm_mhd_multiion_3d.jl new file mode 100644 index 00000000000..1d00ce3de8b --- /dev/null +++ b/src/equations/ideal_glm_mhd_multiion_3d.jl @@ -0,0 +1,1093 @@ +# By default, Julia/LLVM does not use fused multiply-add operations (FMAs). +# Since these FMAs can increase the performance of many numerical algorithms, +# we need to opt-in explicitly. +# See https://ranocha.de/blog/Optimizing_EC_Trixi for further details. +@muladd begin +#! format: noindent + +@doc raw""" + IdealGlmMhdMultiIonEquations3D(; gammas, charge_to_mass, + electron_pressure = electron_pressure_zero, + initial_c_h = NaN) + +The ideal compressible multi-ion MHD equations in three space dimensions augmented with a +generalized Langange multipliers (GLM) divergence-cleaning technique. This is a +multi-species variant of the ideal GLM-MHD equations for calorically perfect plasmas +with independent momentum and energy equations for each ion species. This implementation +assumes that the equations are non-dimensionalized such, that the vacuum permeability is ``\mu_0 = 1``. + +In case of more than one ion species, the specific heat capacity ratios `gammas` and the charge-to-mass +ratios `charge_to_mass` should be passed as tuples, e.g., `gammas=(1.4, 1.667)`. + +The argument `electron_pressure` can be used to pass a function that computes the electron +pressure as a function of the state `u` with the signature `electron_pressure(u, equations)`. +By default, the electron pressure is zero. + +The argument `initial_c_h` can be used to set the GLM divergence-cleaning speed. Note that +`initial_c_h = 0` deactivates the divergence cleaning. The callback [`GlmSpeedCallback`](@ref) +can be used to adjust the GLM divergence-cleaning speed according to the time-step size. + +References: +- G. Toth, A. Glocer, Y. Ma, D. Najib, Multi-Ion Magnetohydrodynamics 429 (2010). Numerical + Modeling of Space Plasma Flows, 213–218. +- A. Rueda-Ramírez, A. Sikstel, G. Gassner, An Entropy-Stable Discontinuous Galerkin Discretization + of the Ideal Multi-Ion Magnetohydrodynamics System (2024). Journal of Computational Physics. + [DOI: 10.1016/j.jcp.2024.113655](https://doi.org/10.1016/j.jcp.2024.113655). + +!!! info "The multi-ion GLM-MHD equations require source terms" + In case of more than one ion species, the multi-ion GLM-MHD equations should ALWAYS be used + with [`source_terms_lorentz`](@ref). +""" +mutable struct IdealGlmMhdMultiIonEquations3D{NVARS, NCOMP, RealT <: Real, + ElectronPressure} <: + AbstractIdealGlmMhdMultiIonEquations{3, NVARS, NCOMP} + gammas::SVector{NCOMP, RealT} # Heat capacity ratios + charge_to_mass::SVector{NCOMP, RealT} # Charge to mass ratios + electron_pressure::ElectronPressure # Function to compute the electron pressure + c_h::RealT # GLM cleaning speed + function IdealGlmMhdMultiIonEquations3D{NVARS, NCOMP, RealT, + ElectronPressure}(gammas + ::SVector{NCOMP, RealT}, + charge_to_mass + ::SVector{NCOMP, RealT}, + electron_pressure + ::ElectronPressure, + c_h::RealT) where + {NVARS, NCOMP, RealT <: Real, ElectronPressure} + NCOMP >= 1 || + throw(DimensionMismatch("`gammas` and `charge_to_mass` have to be filled with at least one value")) + + new(gammas, charge_to_mass, electron_pressure, c_h) + end +end + +function IdealGlmMhdMultiIonEquations3D(; gammas, charge_to_mass, + electron_pressure = electron_pressure_zero, + initial_c_h = convert(eltype(gammas), NaN)) + _gammas = promote(gammas...) + _charge_to_mass = promote(charge_to_mass...) + RealT = promote_type(eltype(_gammas), eltype(_charge_to_mass)) + __gammas = SVector(map(RealT, _gammas)) + __charge_to_mass = SVector(map(RealT, _charge_to_mass)) + + NVARS = length(_gammas) * 5 + 4 + NCOMP = length(_gammas) + + return IdealGlmMhdMultiIonEquations3D{NVARS, NCOMP, RealT, + typeof(electron_pressure)}(__gammas, + __charge_to_mass, + electron_pressure, + initial_c_h) +end + +# Outer constructor for `@reset` works correctly +function IdealGlmMhdMultiIonEquations3D(gammas, charge_to_mass, electron_pressure, c_h) + return IdealGlmMhdMultiIonEquations3D(gammas = gammas, + charge_to_mass = charge_to_mass, + electron_pressure = electron_pressure, + initial_c_h = c_h) +end + +@inline function Base.real(::IdealGlmMhdMultiIonEquations3D{NVARS, NCOMP, RealT}) where { + NVARS, + NCOMP, + RealT + } + RealT +end + +""" + initial_condition_weak_blast_wave(x, t, equations::IdealGlmMhdMultiIonEquations3D) + +A weak blast wave (adapted to multi-ion MHD) from +- Hennemann, S., Rueda-Ramírez, A. M., Hindenlang, F. J., & Gassner, G. J. (2021). A provably entropy + stable subcell shock capturing approach for high order split form DG for the compressible Euler equations. + Journal of Computational Physics, 426, 109935. [arXiv: 2008.12044](https://arxiv.org/abs/2008.12044). + [DOI: 10.1016/j.jcp.2020.109935](https://doi.org/10.1016/j.jcp.2020.109935) +""" +function initial_condition_weak_blast_wave(x, t, + equations::IdealGlmMhdMultiIonEquations3D) + # Adapted MHD version of the weak blast wave from Hennemann & Gassner JCP paper 2020 (Sec. 6.3) + # Same discontinuity in the velocities but with magnetic fields + RealT = eltype(x) + # Set up polar coordinates + inicenter = (0, 0, 0) + x_norm = x[1] - inicenter[1] + y_norm = x[2] - inicenter[2] + z_norm = x[3] - inicenter[3] + r = sqrt(x_norm^2 + y_norm^2 + z_norm^2) + phi = atan(y_norm, x_norm) + theta = iszero(r) ? zero(RealT) : acos(z_norm / r) + + # Calculate primitive variables + rho = r > 0.5f0 ? one(RealT) : convert(RealT, 1.1691) + v1 = r > 0.5f0 ? zero(RealT) : convert(RealT, 0.1882) * cos(phi) * sin(theta) + v2 = r > 0.5f0 ? zero(RealT) : convert(RealT, 0.1882) * sin(phi) * sin(theta) + v3 = r > 0.5f0 ? zero(RealT) : convert(RealT, 0.1882) * cos(theta) + p = r > 0.5f0 ? one(RealT) : convert(RealT, 1.245) + + prim = zero(MVector{nvariables(equations), real(equations)}) + prim[1] = 1 + prim[2] = 1 + prim[3] = 1 + for k in eachcomponent(equations) + set_component!(prim, k, + 2^(k - 1) * (1 - 2) / (1 - 2^ncomponents(equations)) * rho, v1, + v2, v3, p, equations) + end + + return prim2cons(SVector(prim), equations) +end + +# 3D flux of the multi-ion GLM-MHD equations in the direction `orientation` +@inline function flux(u, orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + B1, B2, B3 = magnetic_field(u, equations) + psi = divergence_cleaning_field(u, equations) + + v1_plus, v2_plus, v3_plus, vk1_plus, vk2_plus, vk3_plus = charge_averaged_velocities(u, + equations) + + mag_en = 0.5f0 * (B1^2 + B2^2 + B3^2) + div_clean_energy = 0.5f0 * psi^2 + + f = zero(MVector{nvariables(equations), eltype(u)}) + + if orientation == 1 + f[1] = equations.c_h * psi + f[2] = v1_plus * B2 - v2_plus * B1 + f[3] = v1_plus * B3 - v3_plus * B1 + + for k in eachcomponent(equations) + rho, rho_v1, rho_v2, rho_v3, rho_e = get_component(k, u, equations) + rho_inv = 1 / rho + v1 = rho_v1 * rho_inv + v2 = rho_v2 * rho_inv + v3 = rho_v3 * rho_inv + kin_en = 0.5f0 * rho * (v1^2 + v2^2 + v3^2) + + gamma = equations.gammas[k] + p = (gamma - 1) * (rho_e - kin_en - mag_en - div_clean_energy) + + f1 = rho_v1 + f2 = rho_v1 * v1 + p + f3 = rho_v1 * v2 + f4 = rho_v1 * v3 + f5 = (kin_en + gamma * p / (gamma - 1)) * v1 + 2 * mag_en * vk1_plus[k] - + B1 * (vk1_plus[k] * B1 + vk2_plus[k] * B2 + vk3_plus[k] * B3) + + equations.c_h * psi * B1 + + set_component!(f, k, f1, f2, f3, f4, f5, equations) + end + f[end] = equations.c_h * B1 + elseif orientation == 2 + f[1] = v2_plus * B1 - v1_plus * B2 + f[2] = equations.c_h * psi + f[3] = v2_plus * B3 - v3_plus * B2 + + for k in eachcomponent(equations) + rho, rho_v1, rho_v2, rho_v3, rho_e = get_component(k, u, equations) + rho_inv = 1 / rho + v1 = rho_v1 * rho_inv + v2 = rho_v2 * rho_inv + v3 = rho_v3 * rho_inv + kin_en = 0.5f0 * rho * (v1^2 + v2^2 + v3^2) + + gamma = equations.gammas[k] + p = (gamma - 1) * (rho_e - kin_en - mag_en - div_clean_energy) + + f1 = rho_v2 + f2 = rho_v2 * v1 + f3 = rho_v2 * v2 + p + f4 = rho_v2 * v3 + f5 = (kin_en + gamma * p / (gamma - 1)) * v2 + 2 * mag_en * vk2_plus[k] - + B2 * (vk1_plus[k] * B1 + vk2_plus[k] * B2 + vk3_plus[k] * B3) + + equations.c_h * psi * B2 + + set_component!(f, k, f1, f2, f3, f4, f5, equations) + end + f[end] = equations.c_h * B2 + else #if orientation == 3 + f[1] = v3_plus * B1 - v1_plus * B3 + f[2] = v3_plus * B2 - v2_plus * B3 + f[3] = equations.c_h * psi + + for k in eachcomponent(equations) + rho, rho_v1, rho_v2, rho_v3, rho_e = get_component(k, u, equations) + rho_inv = 1 / rho + v1 = rho_v1 * rho_inv + v2 = rho_v2 * rho_inv + v3 = rho_v3 * rho_inv + kin_en = 0.5f0 * rho * (v1^2 + v2^2 + v3^2) + + gamma = equations.gammas[k] + p = (gamma - 1) * (rho_e - kin_en - mag_en - div_clean_energy) + + f1 = rho_v3 + f2 = rho_v3 * v1 + f3 = rho_v3 * v2 + f4 = rho_v3 * v3 + p + f5 = (kin_en + gamma * p / (gamma - 1)) * v3 + 2 * mag_en * vk3_plus[k] - + B3 * (vk1_plus[k] * B1 + vk2_plus[k] * B2 + vk3_plus[k] * B3) + + equations.c_h * psi * B3 + + set_component!(f, k, f1, f2, f3, f4, f5, equations) + end + f[end] = equations.c_h * B3 + end + + return SVector(f) +end + +""" + flux_nonconservative_ruedaramirez_etal(u_ll, u_rr, + orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + +Entropy-conserving non-conservative two-point "flux" as described in +- A. Rueda-Ramírez, A. Sikstel, G. Gassner, An Entropy-Stable Discontinuous Galerkin Discretization + of the Ideal Multi-Ion Magnetohydrodynamics System (2024). Journal of Computational Physics. + [DOI: 10.1016/j.jcp.2024.113655](https://doi.org/10.1016/j.jcp.2024.113655). + +!!! info "Usage and Scaling of Non-Conservative Fluxes in Trixi.jl" + The non-conservative fluxes derived in the reference above are written as the product + of local and symmetric parts and are meant to be used in the same way as the conservative + fluxes (i.e., flux + flux_noncons in both volume and surface integrals). In this routine, + the fluxes are multiplied by 2 because the non-conservative fluxes are always multiplied + by 0.5 whenever they are used in the Trixi code. + +The term is composed of four individual non-conservative terms: +1. The Godunov-Powell term, which arises for plasmas with non-vanishing magnetic field divergence, and + is evaluated as a function of the charge-averaged velocity. +2. The Lorentz-force term, which becomes a conservative term in the limit of one ion species for vanishing + electron pressure gradients. +3. The "multi-ion" term, which vanishes in the limit of one ion species. +4. The GLM term, which is needed for Galilean invariance. +""" +@inline function flux_nonconservative_ruedaramirez_etal(u_ll, u_rr, + orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + @unpack charge_to_mass = equations + # Unpack left and right states to get the magnetic field + B1_ll, B2_ll, B3_ll = magnetic_field(u_ll, equations) + B1_rr, B2_rr, B3_rr = magnetic_field(u_rr, equations) + psi_ll = divergence_cleaning_field(u_ll, equations) + psi_rr = divergence_cleaning_field(u_rr, equations) + + # Compute important averages + B1_avg = 0.5f0 * (B1_ll + B1_rr) + B2_avg = 0.5f0 * (B2_ll + B2_rr) + B3_avg = 0.5f0 * (B3_ll + B3_rr) + mag_norm_ll = B1_ll^2 + B2_ll^2 + B3_ll^2 + mag_norm_rr = B1_rr^2 + B2_rr^2 + B3_rr^2 + mag_norm_avg = 0.5f0 * (mag_norm_ll + mag_norm_rr) + psi_avg = 0.5f0 * (psi_ll + psi_rr) + + # Mean electron pressure + pe_ll = equations.electron_pressure(u_ll, equations) + pe_rr = equations.electron_pressure(u_rr, equations) + pe_mean = 0.5f0 * (pe_ll + pe_rr) + + # Compute charge ratio of u_ll + charge_ratio_ll = zero(MVector{ncomponents(equations), eltype(u_ll)}) + total_electron_charge = zero(eltype(u_ll)) + for k in eachcomponent(equations) + rho_k = u_ll[3 + (k - 1) * 5 + 1] + charge_ratio_ll[k] = rho_k * charge_to_mass[k] + total_electron_charge += charge_ratio_ll[k] + end + charge_ratio_ll ./= total_electron_charge + + # Compute auxiliary variables + v1_plus_ll, v2_plus_ll, v3_plus_ll, vk1_plus_ll, vk2_plus_ll, vk3_plus_ll = charge_averaged_velocities(u_ll, + equations) + v1_plus_rr, v2_plus_rr, v3_plus_rr, vk1_plus_rr, vk2_plus_rr, vk3_plus_rr = charge_averaged_velocities(u_rr, + equations) + + f = zero(MVector{nvariables(equations), eltype(u_ll)}) + + if orientation == 1 + # Entries of Godunov-Powell term for induction equation (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + f[1] = 2 * v1_plus_ll * B1_avg + f[2] = 2 * v2_plus_ll * B1_avg + f[3] = 2 * v3_plus_ll * B1_avg + + for k in eachcomponent(equations) + # Compute term Lorentz term + f2 = charge_ratio_ll[k] * (0.5f0 * mag_norm_avg - B1_avg * B1_avg + pe_mean) + f3 = charge_ratio_ll[k] * (-B1_avg * B2_avg) + f4 = charge_ratio_ll[k] * (-B1_avg * B3_avg) + f5 = vk1_plus_ll[k] * pe_mean + + # Compute multi-ion term (vanishes for NCOMP==1) + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + vk1_minus_avg = 0.5f0 * (vk1_minus_ll + vk1_minus_rr) + vk2_minus_avg = 0.5f0 * (vk2_minus_ll + vk2_minus_rr) + vk3_minus_avg = 0.5f0 * (vk3_minus_ll + vk3_minus_rr) + f5 += (B2_ll * (vk1_minus_avg * B2_avg - vk2_minus_avg * B1_avg) + + B3_ll * (vk1_minus_avg * B3_avg - vk3_minus_avg * B1_avg)) + + # Compute Godunov-Powell term + f2 += charge_ratio_ll[k] * B1_ll * B1_avg + f3 += charge_ratio_ll[k] * B2_ll * B1_avg + f4 += charge_ratio_ll[k] * B3_ll * B1_avg + f5 += (v1_plus_ll * B1_ll + v2_plus_ll * B2_ll + v3_plus_ll * B3_ll) * + B1_avg + + # Compute GLM term for the energy + f5 += v1_plus_ll * psi_ll * psi_avg + + # Add to the flux vector (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + set_component!(f, k, 0, 2 * f2, 2 * f3, 2 * f4, 2 * f5, + equations) + end + # Compute GLM term for psi (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + f[end] = 2 * v1_plus_ll * psi_avg + + elseif orientation == 2 + # Entries of Godunov-Powell term for induction equation (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + f[1] = 2 * v1_plus_ll * B2_avg + f[2] = 2 * v2_plus_ll * B2_avg + f[3] = 2 * v3_plus_ll * B2_avg + + for k in eachcomponent(equations) + # Compute term Lorentz term + f2 = charge_ratio_ll[k] * (-B2_avg * B1_avg) + f3 = charge_ratio_ll[k] * + (-B2_avg * B2_avg + 0.5f0 * mag_norm_avg + pe_mean) + f4 = charge_ratio_ll[k] * (-B2_avg * B3_avg) + f5 = vk2_plus_ll[k] * pe_mean + + # Compute multi-ion term (vanishes for NCOMP==1) + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + vk1_minus_avg = 0.5f0 * (vk1_minus_ll + vk1_minus_rr) + vk2_minus_avg = 0.5f0 * (vk2_minus_ll + vk2_minus_rr) + vk3_minus_avg = 0.5f0 * (vk3_minus_ll + vk3_minus_rr) + f5 += (B1_ll * (vk2_minus_avg * B1_avg - vk1_minus_avg * B2_avg) + + B3_ll * (vk2_minus_avg * B3_avg - vk3_minus_avg * B2_avg)) + + # Compute Godunov-Powell term + f2 += charge_ratio_ll[k] * B1_ll * B2_avg + f3 += charge_ratio_ll[k] * B2_ll * B2_avg + f4 += charge_ratio_ll[k] * B3_ll * B2_avg + f5 += (v1_plus_ll * B1_ll + v2_plus_ll * B2_ll + v3_plus_ll * B3_ll) * + B2_avg + + # Compute GLM term for the energy + f5 += v2_plus_ll * psi_ll * psi_avg + + # Add to the flux vector (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + set_component!(f, k, 0, 2 * f2, 2 * f3, 2 * f4, 2 * f5, + equations) + end + # Compute GLM term for psi (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + f[end] = 2 * v2_plus_ll * psi_avg + else #if orientation == 3 + # Entries of Godunov-Powell term for induction equation (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + f[1] = 2 * v1_plus_ll * B3_avg + f[2] = 2 * v2_plus_ll * B3_avg + f[3] = 2 * v3_plus_ll * B3_avg + + for k in eachcomponent(equations) + # Compute term Lorentz term + f2 = charge_ratio_ll[k] * (-B3_avg * B1_avg) + f3 = charge_ratio_ll[k] * (-B3_avg * B2_avg) + f4 = charge_ratio_ll[k] * + (-B3_avg * B3_avg + 0.5f0 * mag_norm_avg + pe_mean) + f5 = vk3_plus_ll[k] * pe_mean + + # Compute multi-ion term (vanishes for NCOMP==1) + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + vk1_minus_avg = 0.5f0 * (vk1_minus_ll + vk1_minus_rr) + vk2_minus_avg = 0.5f0 * (vk2_minus_ll + vk2_minus_rr) + vk3_minus_avg = 0.5f0 * (vk3_minus_ll + vk3_minus_rr) + f5 += (B1_ll * (vk3_minus_avg * B1_avg - vk1_minus_avg * B3_avg) + + B2_ll * (vk3_minus_avg * B2_avg - vk2_minus_avg * B3_avg)) + + # Compute Godunov-Powell term + f2 += charge_ratio_ll[k] * B1_ll * B3_avg + f3 += charge_ratio_ll[k] * B2_ll * B3_avg + f4 += charge_ratio_ll[k] * B3_ll * B3_avg + f5 += (v1_plus_ll * B1_ll + v2_plus_ll * B2_ll + v3_plus_ll * B3_ll) * + B3_avg + + # Compute GLM term for the energy + f5 += v3_plus_ll * psi_ll * psi_avg + + # Add to the flux vector (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + set_component!(f, k, 0, 2 * f2, 2 * f3, 2 * f4, 2 * f5, + equations) + end + # Compute GLM term for psi (multiply by 2 because the non-conservative flux is + # multiplied by 0.5 whenever it's used in the Trixi code) + f[end] = 2 * v3_plus_ll * psi_avg + end + + return SVector(f) +end + +""" + flux_nonconservative_central(u_ll, u_rr, orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + +Central non-conservative two-point "flux", where the symmetric parts are computed with standard averages. +The use of this term together with [`flux_central`](@ref) +with [`VolumeIntegralFluxDifferencing`](@ref) yields a "standard" +(weak-form) DGSEM discretization of the multi-ion GLM-MHD system. This flux can also be used to construct a +standard local Lax-Friedrichs flux using `surface_flux = (flux_lax_friedrichs, flux_nonconservative_central)`. + +!!! info "Usage and Scaling of Non-Conservative Fluxes in Trixi" + The central non-conservative fluxes implemented in this function are written as the product + of local and symmetric parts, where the symmetric part is a standard average. These fluxes + are meant to be used in the same way as the conservative fluxes (i.e., flux + flux_noncons + in both volume and surface integrals). In this routine, the fluxes are multiplied by 2 because + the non-conservative fluxes are always multiplied by 0.5 whenever they are used in the Trixi code. + +The term is composed of four individual non-conservative terms: +1. The Godunov-Powell term, which arises for plasmas with non-vanishing magnetic field divergence, and + is evaluated as a function of the charge-averaged velocity. +2. The Lorentz-force term, which becomes a conservative term in the limit of one ion species for vanishing + electron pressure gradients. +3. The "multi-ion" term, which vanishes in the limit of one ion species. +4. The GLM term, which is needed for Galilean invariance. +""" +@inline function flux_nonconservative_central(u_ll, u_rr, orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + @unpack charge_to_mass = equations + # Unpack left and right states to get the magnetic field + B1_ll, B2_ll, B3_ll = magnetic_field(u_ll, equations) + B1_rr, B2_rr, B3_rr = magnetic_field(u_rr, equations) + psi_ll = divergence_cleaning_field(u_ll, equations) + psi_rr = divergence_cleaning_field(u_rr, equations) + + # Compute important averages + mag_norm_ll = B1_ll^2 + B2_ll^2 + B3_ll^2 + mag_norm_rr = B1_rr^2 + B2_rr^2 + B3_rr^2 + + # Electron pressure + pe_ll = equations.electron_pressure(u_ll, equations) + pe_rr = equations.electron_pressure(u_rr, equations) + + # Compute charge ratio of u_ll + charge_ratio_ll = zero(MVector{ncomponents(equations), eltype(u_ll)}) + total_electron_charge = zero(real(equations)) + for k in eachcomponent(equations) + rho_k = u_ll[3 + (k - 1) * 5 + 1] + charge_ratio_ll[k] = rho_k * charge_to_mass[k] + total_electron_charge += charge_ratio_ll[k] + end + charge_ratio_ll ./= total_electron_charge + + # Compute auxiliary variables + v1_plus_ll, v2_plus_ll, v3_plus_ll, vk1_plus_ll, vk2_plus_ll, vk3_plus_ll = charge_averaged_velocities(u_ll, + equations) + v1_plus_rr, v2_plus_rr, v3_plus_rr, vk1_plus_rr, vk2_plus_rr, vk3_plus_rr = charge_averaged_velocities(u_rr, + equations) + + f = zero(MVector{nvariables(equations), eltype(u_ll)}) + + if orientation == 1 + # Entries of Godunov-Powell term for induction equation + f[1] = v1_plus_ll * (B1_ll + B1_rr) + f[2] = v2_plus_ll * (B1_ll + B1_rr) + f[3] = v3_plus_ll * (B1_ll + B1_rr) + for k in eachcomponent(equations) + # Compute Lorentz term + f2 = charge_ratio_ll[k] * ((0.5f0 * mag_norm_ll - B1_ll * B1_ll + pe_ll) + + (0.5f0 * mag_norm_rr - B1_rr * B1_rr + pe_rr)) + f3 = charge_ratio_ll[k] * ((-B1_ll * B2_ll) + (-B1_rr * B2_rr)) + f4 = charge_ratio_ll[k] * ((-B1_ll * B3_ll) + (-B1_rr * B3_rr)) + f5 = vk1_plus_ll[k] * (pe_ll + pe_rr) + + # Compute multi-ion term, which vanishes for NCOMP==1 + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + f5 += (B2_ll * ((vk1_minus_ll * B2_ll - vk2_minus_ll * B1_ll) + + (vk1_minus_rr * B2_rr - vk2_minus_rr * B1_rr)) + + B3_ll * ((vk1_minus_ll * B3_ll - vk3_minus_ll * B1_ll) + + (vk1_minus_rr * B3_rr - vk3_minus_rr * B1_rr))) + + # Compute Godunov-Powell term + f2 += charge_ratio_ll[k] * B1_ll * (B1_ll + B1_rr) + f3 += charge_ratio_ll[k] * B2_ll * (B1_ll + B1_rr) + f4 += charge_ratio_ll[k] * B3_ll * (B1_ll + B1_rr) + f5 += (v1_plus_ll * B1_ll + v2_plus_ll * B2_ll + v3_plus_ll * B3_ll) * + (B1_ll + B1_rr) + + # Compute GLM term for the energy + f5 += v1_plus_ll * psi_ll * (psi_ll + psi_rr) + + # Append to the flux vector + set_component!(f, k, 0, f2, f3, f4, f5, equations) + end + # Compute GLM term for psi + f[end] = v1_plus_ll * (psi_ll + psi_rr) + + elseif orientation == 2 + # Entries of Godunov-Powell term for induction equation + f[1] = v1_plus_ll * (B2_ll + B2_rr) + f[2] = v2_plus_ll * (B2_ll + B2_rr) + f[3] = v3_plus_ll * (B2_ll + B2_rr) + + for k in eachcomponent(equations) + # Compute Lorentz term + f2 = charge_ratio_ll[k] * ((-B2_ll * B1_ll) + (-B2_rr * B1_rr)) + f3 = charge_ratio_ll[k] * ((-B2_ll * B2_ll + 0.5f0 * mag_norm_ll + pe_ll) + + (-B2_rr * B2_rr + 0.5f0 * mag_norm_rr + pe_rr)) + f4 = charge_ratio_ll[k] * ((-B2_ll * B3_ll) + (-B2_rr * B3_rr)) + f5 = vk2_plus_ll[k] * (pe_ll + pe_rr) + + # Compute multi-ion term (vanishes for NCOMP==1) + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + f5 += (B1_ll * ((vk2_minus_ll * B1_ll - vk1_minus_ll * B2_ll) + + (vk2_minus_rr * B1_rr - vk1_minus_rr * B2_rr)) + + B3_ll * ((vk2_minus_ll * B3_ll - vk3_minus_ll * B2_ll) + + (vk2_minus_rr * B3_rr - vk3_minus_rr * B2_rr))) + + # Compute Godunov-Powell term + f2 += charge_ratio_ll[k] * B1_ll * (B2_ll + B2_rr) + f3 += charge_ratio_ll[k] * B2_ll * (B2_ll + B2_rr) + f4 += charge_ratio_ll[k] * B3_ll * (B2_ll + B2_rr) + f5 += (v1_plus_ll * B1_ll + v2_plus_ll * B2_ll + v3_plus_ll * B3_ll) * + (B2_ll + B2_rr) + + # Compute GLM term for the energy + f5 += v2_plus_ll * psi_ll * (psi_ll + psi_rr) + + # Append to the flux vector + set_component!(f, k, 0, f2, f3, f4, f5, equations) + end + # Compute GLM term for psi + f[end] = v2_plus_ll * (psi_ll + psi_rr) + else #if orientation == 3 + # Entries of Godunov-Powell term for induction equation + f[1] = v1_plus_ll * (B3_ll + B3_rr) + f[2] = v2_plus_ll * (B3_ll + B3_rr) + f[3] = v3_plus_ll * (B3_ll + B3_rr) + + for k in eachcomponent(equations) + # Compute Lorentz term + f2 = charge_ratio_ll[k] * ((-B3_ll * B1_ll) + (-B3_rr * B1_rr)) + f3 = charge_ratio_ll[k] * ((-B3_ll * B2_ll) + (-B3_rr * B2_rr)) + f4 = charge_ratio_ll[k] * ((-B3_ll * B3_ll + 0.5f0 * mag_norm_ll + pe_ll) + + (-B3_rr * B3_rr + 0.5f0 * mag_norm_rr + pe_rr)) + f5 = vk3_plus_ll[k] * (pe_ll + pe_rr) + + # Compute multi-ion term (vanishes for NCOMP==1) + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + f5 += (B1_ll * ((vk3_minus_ll * B1_ll - vk1_minus_ll * B3_ll) + + (vk3_minus_rr * B1_rr - vk1_minus_rr * B3_rr)) + + B2_ll * ((vk3_minus_ll * B2_ll - vk2_minus_ll * B3_ll) + + (vk3_minus_rr * B2_rr - vk2_minus_rr * B3_rr))) + + # Compute Godunov-Powell term + f2 += charge_ratio_ll[k] * B1_ll * (B3_ll + B3_rr) + f3 += charge_ratio_ll[k] * B2_ll * (B3_ll + B3_rr) + f4 += charge_ratio_ll[k] * B3_ll * (B3_ll + B3_rr) + f5 += (v1_plus_ll * B1_ll + v2_plus_ll * B2_ll + v3_plus_ll * B3_ll) * + (B3_ll + B3_rr) + + # Compute GLM term for the energy + f5 += v3_plus_ll * psi_ll * (psi_ll + psi_rr) + + # Append to the flux vector + set_component!(f, k, 0, f2, f3, f4, f5, equations) + end + # Compute GLM term for psi + f[end] = v3_plus_ll * (psi_ll + psi_rr) + end + + return SVector(f) +end + +""" + flux_ruedaramirez_etal(u_ll, u_rr, orientation, equations::IdealGlmMhdMultiIonEquations3D) + +Entropy conserving two-point flux for the multi-ion GLM-MHD equations from +- A. Rueda-Ramírez, A. Sikstel, G. Gassner, An Entropy-Stable Discontinuous Galerkin Discretization + of the Ideal Multi-Ion Magnetohydrodynamics System (2024). Journal of Computational Physics. + [DOI: 10.1016/j.jcp.2024.113655](https://doi.org/10.1016/j.jcp.2024.113655). + +This flux (together with the MHD non-conservative term) is consistent in the case of one ion species with the flux of: +- Derigs et al. (2018). Ideal GLM-MHD: About the entropy consistent nine-wave magnetic field + divergence diminishing ideal magnetohydrodynamics equations for multi-ion + [DOI: 10.1016/j.jcp.2018.03.002](https://doi.org/10.1016/j.jcp.2018.03.002) +""" +function flux_ruedaramirez_etal(u_ll, u_rr, orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + @unpack gammas = equations + # Unpack left and right states to get the magnetic field + B1_ll, B2_ll, B3_ll = magnetic_field(u_ll, equations) + B1_rr, B2_rr, B3_rr = magnetic_field(u_rr, equations) + psi_ll = divergence_cleaning_field(u_ll, equations) + psi_rr = divergence_cleaning_field(u_rr, equations) + + v1_plus_ll, v2_plus_ll, v3_plus_ll, vk1_plus_ll, vk2_plus_ll, vk3_plus_ll = charge_averaged_velocities(u_ll, + equations) + v1_plus_rr, v2_plus_rr, v3_plus_rr, vk1_plus_rr, vk2_plus_rr, vk3_plus_rr = charge_averaged_velocities(u_rr, + equations) + + f = zero(MVector{nvariables(equations), eltype(u_ll)}) + + # Compute averages for global variables + v1_plus_avg = 0.5f0 * (v1_plus_ll + v1_plus_rr) + v2_plus_avg = 0.5f0 * (v2_plus_ll + v2_plus_rr) + v3_plus_avg = 0.5f0 * (v3_plus_ll + v3_plus_rr) + B1_avg = 0.5f0 * (B1_ll + B1_rr) + B2_avg = 0.5f0 * (B2_ll + B2_rr) + B3_avg = 0.5f0 * (B3_ll + B3_rr) + mag_norm_ll = B1_ll^2 + B2_ll^2 + B3_ll^2 + mag_norm_rr = B1_rr^2 + B2_rr^2 + B3_rr^2 + mag_norm_avg = 0.5f0 * (mag_norm_ll + mag_norm_rr) + psi_avg = 0.5f0 * (psi_ll + psi_rr) + + if orientation == 1 + psi_B1_avg = 0.5f0 * (B1_ll * psi_ll + B1_rr * psi_rr) + + # Magnetic field components from f^MHD + f6 = equations.c_h * psi_avg + f7 = v1_plus_avg * B2_avg - v2_plus_avg * B1_avg + f8 = v1_plus_avg * B3_avg - v3_plus_avg * B1_avg + f9 = equations.c_h * B1_avg + + # Start building the flux + f[1] = f6 + f[2] = f7 + f[3] = f8 + f[end] = f9 + + # Iterate over all components + for k in eachcomponent(equations) + # Unpack left and right states + rho_ll, rho_v1_ll, rho_v2_ll, rho_v3_ll, rho_e_ll = get_component(k, u_ll, + equations) + rho_rr, rho_v1_rr, rho_v2_rr, rho_v3_rr, rho_e_rr = get_component(k, u_rr, + equations) + + rho_inv_ll = 1 / rho_ll + v1_ll = rho_v1_ll * rho_inv_ll + v2_ll = rho_v2_ll * rho_inv_ll + v3_ll = rho_v3_ll * rho_inv_ll + rho_inv_rr = 1 / rho_rr + v1_rr = rho_v1_rr * rho_inv_rr + v2_rr = rho_v2_rr * rho_inv_rr + v3_rr = rho_v3_rr * rho_inv_rr + vel_norm_ll = v1_ll^2 + v2_ll^2 + v3_ll^2 + vel_norm_rr = v1_rr^2 + v2_rr^2 + v3_rr^2 + + p_ll = (gammas[k] - 1) * + (rho_e_ll - 0.5f0 * rho_ll * vel_norm_ll - 0.5f0 * mag_norm_ll - + 0.5f0 * psi_ll^2) + p_rr = (gammas[k] - 1) * + (rho_e_rr - 0.5f0 * rho_rr * vel_norm_rr - 0.5f0 * mag_norm_rr - + 0.5f0 * psi_rr^2) + beta_ll = 0.5f0 * rho_ll / p_ll + beta_rr = 0.5f0 * rho_rr / p_rr + # for convenience store vk_plus⋅B + vel_dot_mag_ll = vk1_plus_ll[k] * B1_ll + vk2_plus_ll[k] * B2_ll + + vk3_plus_ll[k] * B3_ll + vel_dot_mag_rr = vk1_plus_rr[k] * B1_rr + vk2_plus_rr[k] * B2_rr + + vk3_plus_rr[k] * B3_rr + + # Compute the necessary mean values needed for either direction + rho_avg = 0.5f0 * (rho_ll + rho_rr) + rho_mean = ln_mean(rho_ll, rho_rr) + beta_mean = ln_mean(beta_ll, beta_rr) + beta_avg = 0.5f0 * (beta_ll + beta_rr) + p_mean = 0.5f0 * rho_avg / beta_avg + v1_avg = 0.5f0 * (v1_ll + v1_rr) + v2_avg = 0.5f0 * (v2_ll + v2_rr) + v3_avg = 0.5f0 * (v3_ll + v3_rr) + vel_norm_avg = 0.5f0 * (vel_norm_ll + vel_norm_rr) + vel_dot_mag_avg = 0.5f0 * (vel_dot_mag_ll + vel_dot_mag_rr) + vk1_plus_avg = 0.5f0 * (vk1_plus_ll[k] + vk1_plus_rr[k]) + vk2_plus_avg = 0.5f0 * (vk2_plus_ll[k] + vk2_plus_rr[k]) + vk3_plus_avg = 0.5f0 * (vk3_plus_ll[k] + vk3_plus_rr[k]) + # v_minus + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + vk1_minus_avg = 0.5f0 * (vk1_minus_ll + vk1_minus_rr) + vk2_minus_avg = 0.5f0 * (vk2_minus_ll + vk2_minus_rr) + vk3_minus_avg = 0.5f0 * (vk3_minus_ll + vk3_minus_rr) + + # Fill the fluxes for the mass and momentum equations + f1 = rho_mean * v1_avg + f2 = f1 * v1_avg + p_mean + f3 = f1 * v2_avg + f4 = f1 * v3_avg + + # total energy flux is complicated and involves the previous eight components + v1_plus_mag_avg = 0.5f0 * (vk1_plus_ll[k] * mag_norm_ll + + vk1_plus_rr[k] * mag_norm_rr) + # Euler part + f5 = f1 * 0.5f0 * (1 / (gammas[k] - 1) / beta_mean - vel_norm_avg) + + f2 * v1_avg + f3 * v2_avg + f4 * v3_avg + # MHD part + f5 += (f6 * B1_avg + f7 * B2_avg + f8 * B3_avg - 0.5f0 * v1_plus_mag_avg + + B1_avg * vel_dot_mag_avg # Same terms as in Derigs (but with v_plus) + + f9 * psi_avg - equations.c_h * psi_B1_avg # GLM term + + + 0.5f0 * vk1_plus_avg * mag_norm_avg - + vk1_plus_avg * B1_avg * B1_avg - vk2_plus_avg * B1_avg * B2_avg - + vk3_plus_avg * B1_avg * B3_avg # Additional terms related to the Lorentz non-conservative term (momentum eqs) + - + B2_avg * (vk1_minus_avg * B2_avg - vk2_minus_avg * B1_avg) - + B3_avg * (vk1_minus_avg * B3_avg - vk3_minus_avg * B1_avg)) # Terms related to the multi-ion non-conservative term (induction equation!) + + set_component!(f, k, f1, f2, f3, f4, f5, equations) + end + elseif orientation == 2 + psi_B2_avg = 0.5f0 * (B2_ll * psi_ll + B2_rr * psi_rr) + + # Magnetic field components from f^MHD + f6 = v2_plus_avg * B1_avg - v1_plus_avg * B2_avg + f7 = equations.c_h * psi_avg + f8 = v2_plus_avg * B3_avg - v3_plus_avg * B2_avg + f9 = equations.c_h * B2_avg + + # Start building the flux + f[1] = f6 + f[2] = f7 + f[3] = f8 + f[end] = f9 + + # Iterate over all components + for k in eachcomponent(equations) + # Unpack left and right states + rho_ll, rho_v1_ll, rho_v2_ll, rho_v3_ll, rho_e_ll = get_component(k, u_ll, + equations) + rho_rr, rho_v1_rr, rho_v2_rr, rho_v3_rr, rho_e_rr = get_component(k, u_rr, + equations) + + rho_inv_ll = 1 / rho_ll + v1_ll = rho_v1_ll * rho_inv_ll + v2_ll = rho_v2_ll * rho_inv_ll + v3_ll = rho_v3_ll * rho_inv_ll + rho_inv_rr = 1 / rho_rr + v1_rr = rho_v1_rr * rho_inv_rr + v2_rr = rho_v2_rr * rho_inv_rr + v3_rr = rho_v3_rr * rho_inv_rr + vel_norm_ll = v1_ll^2 + v2_ll^2 + v3_ll^2 + vel_norm_rr = v1_rr^2 + v2_rr^2 + v3_rr^2 + + p_ll = (gammas[k] - 1) * + (rho_e_ll - 0.5f0 * rho_ll * vel_norm_ll - 0.5f0 * mag_norm_ll - + 0.5f0 * psi_ll^2) + p_rr = (gammas[k] - 1) * + (rho_e_rr - 0.5f0 * rho_rr * vel_norm_rr - 0.5f0 * mag_norm_rr - + 0.5f0 * psi_rr^2) + beta_ll = 0.5f0 * rho_ll / p_ll + beta_rr = 0.5f0 * rho_rr / p_rr + # for convenience store vk_plus⋅B + vel_dot_mag_ll = vk1_plus_ll[k] * B1_ll + vk2_plus_ll[k] * B2_ll + + vk3_plus_ll[k] * B3_ll + vel_dot_mag_rr = vk1_plus_rr[k] * B1_rr + vk2_plus_rr[k] * B2_rr + + vk3_plus_rr[k] * B3_rr + + # Compute the necessary mean values needed for either direction + rho_avg = 0.5f0 * (rho_ll + rho_rr) + rho_mean = ln_mean(rho_ll, rho_rr) + beta_mean = ln_mean(beta_ll, beta_rr) + beta_avg = 0.5f0 * (beta_ll + beta_rr) + p_mean = 0.5f0 * rho_avg / beta_avg + v1_avg = 0.5f0 * (v1_ll + v1_rr) + v2_avg = 0.5f0 * (v2_ll + v2_rr) + v3_avg = 0.5f0 * (v3_ll + v3_rr) + vel_norm_avg = 0.5f0 * (vel_norm_ll + vel_norm_rr) + vel_dot_mag_avg = 0.5f0 * (vel_dot_mag_ll + vel_dot_mag_rr) + vk1_plus_avg = 0.5f0 * (vk1_plus_ll[k] + vk1_plus_rr[k]) + vk2_plus_avg = 0.5f0 * (vk2_plus_ll[k] + vk2_plus_rr[k]) + vk3_plus_avg = 0.5f0 * (vk3_plus_ll[k] + vk3_plus_rr[k]) + # v_minus + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + vk1_minus_avg = 0.5f0 * (vk1_minus_ll + vk1_minus_rr) + vk2_minus_avg = 0.5f0 * (vk2_minus_ll + vk2_minus_rr) + vk3_minus_avg = 0.5f0 * (vk3_minus_ll + vk3_minus_rr) + + # Fill the fluxes for the mass and momentum equations + f1 = rho_mean * v2_avg + f2 = f1 * v1_avg + f3 = f1 * v2_avg + p_mean + f4 = f1 * v3_avg + + # total energy flux is complicated and involves the previous eight components + v2_plus_mag_avg = 0.5f0 * (vk2_plus_ll[k] * mag_norm_ll + + vk2_plus_rr[k] * mag_norm_rr) + # Euler part + f5 = f1 * 0.5f0 * (1 / (gammas[k] - 1) / beta_mean - vel_norm_avg) + + f2 * v1_avg + f3 * v2_avg + f4 * v3_avg + # MHD part + f5 += (f6 * B1_avg + f7 * B2_avg + f8 * B3_avg - 0.5f0 * v2_plus_mag_avg + + B2_avg * vel_dot_mag_avg # Same terms as in Derigs (but with v_plus) + + f9 * psi_avg - equations.c_h * psi_B2_avg # GLM term + + + 0.5f0 * vk2_plus_avg * mag_norm_avg - + vk1_plus_avg * B2_avg * B1_avg - vk2_plus_avg * B2_avg * B2_avg - + vk3_plus_avg * B2_avg * B3_avg # Additional terms related to the Lorentz non-conservative term (momentum eqs) + - + B1_avg * (vk2_minus_avg * B1_avg - vk1_minus_avg * B2_avg) - + B3_avg * (vk2_minus_avg * B3_avg - vk3_minus_avg * B2_avg)) # Terms related to the multi-ion non-conservative term (induction equation!) + + set_component!(f, k, f1, f2, f3, f4, f5, equations) + end + else #if orientation == 3 + psi_B3_avg = 0.5f0 * (B3_ll * psi_ll + B3_rr * psi_rr) + + # Magnetic field components from f^MHD + f6 = v3_plus_avg * B1_avg - v1_plus_avg * B3_avg + f7 = v3_plus_avg * B2_avg - v2_plus_avg * B3_avg + f8 = equations.c_h * psi_avg + f9 = equations.c_h * B3_avg + + # Start building the flux + f[1] = f6 + f[2] = f7 + f[3] = f8 + f[end] = f9 + + # Iterate over all components + for k in eachcomponent(equations) + # Unpack left and right states + rho_ll, rho_v1_ll, rho_v2_ll, rho_v3_ll, rho_e_ll = get_component(k, u_ll, + equations) + rho_rr, rho_v1_rr, rho_v2_rr, rho_v3_rr, rho_e_rr = get_component(k, u_rr, + equations) + + rho_inv_ll = 1 / rho_ll + v1_ll = rho_v1_ll * rho_inv_ll + v2_ll = rho_v2_ll * rho_inv_ll + v3_ll = rho_v3_ll * rho_inv_ll + rho_inv_rr = 1 / rho_rr + v1_rr = rho_v1_rr * rho_inv_rr + v2_rr = rho_v2_rr * rho_inv_rr + v3_rr = rho_v3_rr * rho_inv_rr + vel_norm_ll = v1_ll^2 + v2_ll^2 + v3_ll^2 + vel_norm_rr = v1_rr^2 + v2_rr^2 + v3_rr^2 + + p_ll = (gammas[k] - 1) * + (rho_e_ll - 0.5f0 * rho_ll * vel_norm_ll - 0.5f0 * mag_norm_ll - + 0.5f0 * psi_ll^2) + p_rr = (gammas[k] - 1) * + (rho_e_rr - 0.5f0 * rho_rr * vel_norm_rr - 0.5f0 * mag_norm_rr - + 0.5f0 * psi_rr^2) + beta_ll = 0.5f0 * rho_ll / p_ll + beta_rr = 0.5f0 * rho_rr / p_rr + # for convenience store vk_plus⋅B + vel_dot_mag_ll = vk1_plus_ll[k] * B1_ll + vk2_plus_ll[k] * B2_ll + + vk3_plus_ll[k] * B3_ll + vel_dot_mag_rr = vk1_plus_rr[k] * B1_rr + vk2_plus_rr[k] * B2_rr + + vk3_plus_rr[k] * B3_rr + + # Compute the necessary mean values needed for either direction + rho_avg = 0.5f0 * (rho_ll + rho_rr) + rho_mean = ln_mean(rho_ll, rho_rr) + beta_mean = ln_mean(beta_ll, beta_rr) + beta_avg = 0.5f0 * (beta_ll + beta_rr) + p_mean = 0.5f0 * rho_avg / beta_avg + v1_avg = 0.5f0 * (v1_ll + v1_rr) + v2_avg = 0.5f0 * (v2_ll + v2_rr) + v3_avg = 0.5f0 * (v3_ll + v3_rr) + vel_norm_avg = 0.5f0 * (vel_norm_ll + vel_norm_rr) + vel_dot_mag_avg = 0.5f0 * (vel_dot_mag_ll + vel_dot_mag_rr) + vk1_plus_avg = 0.5f0 * (vk1_plus_ll[k] + vk1_plus_rr[k]) + vk2_plus_avg = 0.5f0 * (vk2_plus_ll[k] + vk2_plus_rr[k]) + vk3_plus_avg = 0.5f0 * (vk3_plus_ll[k] + vk3_plus_rr[k]) + # v_minus + vk1_minus_ll = v1_plus_ll - vk1_plus_ll[k] + vk2_minus_ll = v2_plus_ll - vk2_plus_ll[k] + vk3_minus_ll = v3_plus_ll - vk3_plus_ll[k] + vk1_minus_rr = v1_plus_rr - vk1_plus_rr[k] + vk2_minus_rr = v2_plus_rr - vk2_plus_rr[k] + vk3_minus_rr = v3_plus_rr - vk3_plus_rr[k] + vk1_minus_avg = 0.5f0 * (vk1_minus_ll + vk1_minus_rr) + vk2_minus_avg = 0.5f0 * (vk2_minus_ll + vk2_minus_rr) + vk3_minus_avg = 0.5f0 * (vk3_minus_ll + vk3_minus_rr) + + # Fill the fluxes for the mass and momentum equations + f1 = rho_mean * v3_avg + f2 = f1 * v1_avg + f3 = f1 * v2_avg + f4 = f1 * v3_avg + p_mean + + # total energy flux is complicated and involves the previous eight components + v3_plus_mag_avg = 0.5f0 * (vk3_plus_ll[k] * mag_norm_ll + + vk3_plus_rr[k] * mag_norm_rr) + # Euler part + f5 = f1 * 0.5f0 * (1 / (gammas[k] - 1) / beta_mean - vel_norm_avg) + + f2 * v1_avg + f3 * v2_avg + f4 * v3_avg + # MHD part + f5 += (f6 * B1_avg + f7 * B2_avg + f8 * B3_avg - 0.5f0 * v3_plus_mag_avg + + B3_avg * vel_dot_mag_avg # Same terms as in Derigs (but with v_plus) + + f9 * psi_avg - equations.c_h * psi_B3_avg # GLM term + + + 0.5f0 * vk3_plus_avg * mag_norm_avg - + vk1_plus_avg * B3_avg * B1_avg - vk2_plus_avg * B3_avg * B2_avg - + vk3_plus_avg * B3_avg * B3_avg # Additional terms related to the Lorentz non-conservative term (momentum eqs) + - + B1_avg * (vk3_minus_avg * B1_avg - vk1_minus_avg * B3_avg) - + B2_avg * (vk3_minus_avg * B2_avg - vk2_minus_avg * B3_avg)) # Terms related to the multi-ion non-conservative term (induction equation!) + + set_component!(f, k, f1, f2, f3, f4, f5, equations) + end + end + + return SVector(f) +end + +# Calculate maximum wave speed for local Lax-Friedrichs-type dissipation +# This routine approximates the maximum wave speed as sum of the maximum ion velocity +# for all species and the maximum magnetosonic speed. +@inline function max_abs_speed_naive(u_ll, u_rr, orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + # Calculate fast magnetoacoustic wave speeds + # left + cf_ll = calc_fast_wavespeed(u_ll, orientation, equations) + # right + cf_rr = calc_fast_wavespeed(u_rr, orientation, equations) + + # Calculate velocities + v_ll = zero(eltype(u_ll)) + v_rr = zero(eltype(u_rr)) + if orientation == 1 + for k in eachcomponent(equations) + rho, rho_v1, _ = get_component(k, u_ll, equations) + v_ll = max(v_ll, abs(rho_v1 / rho)) + rho, rho_v1, _ = get_component(k, u_rr, equations) + v_rr = max(v_rr, abs(rho_v1 / rho)) + end + elseif orientation == 2 + for k in eachcomponent(equations) + rho, rho_v1, rho_v2, _ = get_component(k, u_ll, equations) + v_ll = max(v_ll, abs(rho_v2 / rho)) + rho, rho_v1, rho_v2, _ = get_component(k, u_rr, equations) + v_rr = max(v_rr, abs(rho_v2 / rho)) + end + else #if orientation == 3 + for k in eachcomponent(equations) + rho, rho_v1, rho_v2, rho_v3, _ = get_component(k, u_ll, equations) + v_ll = max(v_ll, abs(rho_v3 / rho)) + rho, rho_v1, rho_v2, rho_v3, _ = get_component(k, u_rr, equations) + v_rr = max(v_rr, abs(rho_v3 / rho)) + end + end + + λ_max = max(abs(v_ll), abs(v_rr)) + max(cf_ll, cf_rr) +end + +@inline function max_abs_speeds(u, equations::IdealGlmMhdMultiIonEquations3D) + v1 = zero(real(equations)) + v2 = zero(real(equations)) + v3 = zero(real(equations)) + for k in eachcomponent(equations) + rho, rho_v1, rho_v2, rho_v3, _ = get_component(k, u, equations) + rho_inv = 1 / rho + v1 = max(v1, abs(rho_v1 * rho_inv)) + v2 = max(v2, abs(rho_v2 * rho_inv)) + v3 = max(v3, abs(rho_v3 * rho_inv)) + end + + cf_x_direction = calc_fast_wavespeed(u, 1, equations) + cf_y_direction = calc_fast_wavespeed(u, 2, equations) + cf_z_direction = calc_fast_wavespeed(u, 3, equations) + + return (abs(v1) + cf_x_direction, abs(v2) + cf_y_direction, + abs(v3) + cf_z_direction) +end + +# Compute the fastest wave speed for ideal multi-ion GLM-MHD equations: c_f, the fast +# magnetoacoustic eigenvalue. This routine computes the fast magnetosonic speed for each ion +# species using the single-fluid MHD expressions and approximates the multi-ion c_f as +# the maximum of these individual magnetosonic speeds. +@inline function calc_fast_wavespeed(cons, orientation::Integer, + equations::IdealGlmMhdMultiIonEquations3D) + B1, B2, B3 = magnetic_field(cons, equations) + psi = divergence_cleaning_field(cons, equations) + + c_f = zero(real(equations)) + for k in eachcomponent(equations) + rho, rho_v1, rho_v2, rho_v3, rho_e = get_component(k, cons, equations) + + rho_inv = 1 / rho + v1 = rho_v1 * rho_inv + v2 = rho_v2 * rho_inv + v3 = rho_v3 * rho_inv + v_mag = sqrt(v1^2 + v2^2 + v3^2) + gamma = equations.gammas[k] + p = (gamma - 1) * + (rho_e - 0.5f0 * rho * v_mag^2 - 0.5f0 * (B1^2 + B2^2 + B3^2) - + 0.5f0 * psi^2) + a_square = gamma * p * rho_inv + inv_sqrt_rho = 1 / sqrt(rho) + + b1 = B1 * inv_sqrt_rho + b2 = B2 * inv_sqrt_rho + b3 = B3 * inv_sqrt_rho + b_square = b1^2 + b2^2 + b3^2 + + if orientation == 1 + c_f = max(c_f, + sqrt(0.5f0 * (a_square + b_square) + + 0.5f0 * + sqrt((a_square + b_square)^2 - 2 * a_square * b1^2))) + elseif orientation == 2 + c_f = max(c_f, + sqrt(0.5f0 * (a_square + b_square) + + 0.5f0 * + sqrt((a_square + b_square)^2 - 2 * a_square * b2^2))) + else #if orientation == 3 + c_f = max(c_f, + sqrt(0.5f0 * (a_square + b_square) + + 0.5f0 * + sqrt((a_square + b_square)^2 - 2 * a_square * b3^2))) + end + end + + return c_f +end +end # @muladd diff --git a/test/test_tree_3d_mhdmultiion.jl b/test/test_tree_3d_mhdmultiion.jl new file mode 100644 index 00000000000..f661e0be77e --- /dev/null +++ b/test/test_tree_3d_mhdmultiion.jl @@ -0,0 +1,156 @@ +module TestExamples3DIdealGlmMhdMultiIon + +using Test +using Trixi + +include("test_trixi.jl") + +# pathof(Trixi) returns /path/to/Trixi/src/Trixi.jl, dirname gives the parent directory +EXAMPLES_DIR = joinpath(examples_dir(), "tree_3d_dgsem") + +@testset "MHD Multi-ion" begin +#! format: noindent + +@trixi_testset "elixir_mhdmultiion_ec.jl" begin + @test_trixi_include(joinpath(EXAMPLES_DIR, "elixir_mhdmultiion_ec.jl"), + l2=[ + 0.005515090292575059, + 0.005515093229701533, + 0.0055155968594217, + 0.0034090002245163614, + 0.003709807395174228, + 0.003709808917203165, + 0.003709945123475921, + 0.04983943937107913, + 0.005484133454336887, + 0.00528293290439966, + 0.005282930490865487, + 0.005283547806305909, + 0.03352789135708704, + 3.749645231098896e-5 + ], + linf=[ + 0.21024185596950629, + 0.21025151478760273, + 0.21024912618268798, + 0.076395739096276, + 0.1563223611743002, + 0.15632884538092198, + 0.15634105391848113, + 1.0388823226534836, + 0.22150908356656462, + 0.2513262952807552, + 0.2513408613352427, + 0.25131982443776496, + 0.8504449549199755, + 0.00745904702407851 + ], tspan=(0.0, 0.05)) + # Ensure that we do not have excessive memory allocations + # (e.g., from type instabilities) + let + t = sol.t[end] + u_ode = sol.u[end] + du_ode = similar(u_ode) + # Slightly larger values for allowed allocations due to the size of the multi-ion MHD system + @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 2000 + end +end + +@trixi_testset "Provably entropy-stable LLF-type fluxes for multi-ion GLM-MHD" begin + @test_trixi_include(joinpath(EXAMPLES_DIR, "elixir_mhdmultiion_ec.jl"), + l2=[ + 0.005461797766886852, + 0.0054617979185473935, + 0.005461911963493437, + 0.0034019650432160183, + 0.0036214136925153332, + 0.003621413755863293, + 0.0036214256331343125, + 0.04989956402093448, + 0.005418917526099802, + 0.005131066757973498, + 0.005131067607695321, + 0.005131172274784049, + 0.03343666846482734, + 0.0003007804111764196 + ], + linf=[ + 0.12234892772192096, + 0.1223171830655686, + 0.1278258253016613, + 0.07205879616765087, + 0.1290061932668167, + 0.12899478253220256, + 0.12899463311942488, + 1.084354847523644, + 0.17599973652527756, + 0.1673024753470816, + 0.16729366599933276, + 0.1672749128649947, + 0.9610489935515938, + 0.04894654146236637 + ], + surface_flux=(FluxPlusDissipation(flux_ruedaramirez_etal, + DissipationLaxFriedrichsEntropyVariables()), + flux_nonconservative_ruedaramirez_etal), + tspan=(0.0, 0.05)) + # Ensure that we do not have excessive memory allocations + # (e.g., from type instabilities) + let + t = sol.t[end] + u_ode = sol.u[end] + du_ode = similar(u_ode) + # Slightly larger values for allowed allocations due to the size of the multi-ion MHD system + @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 2000 + end +end + +@trixi_testset "elixir_mhdmultiion_ec.jl with local Lax-Friedrichs at the surface" begin + @test_trixi_include(joinpath(EXAMPLES_DIR, "elixir_mhdmultiion_ec.jl"), + l2=[ + 0.0054618017243060245, + 0.005461801874647487, + 0.005461916115692502, + 0.0034019533360683516, + 0.0036214103139306027, + 0.003621410378506676, + 0.0036214220691497454, + 0.04989948890811091, + 0.005418894551414051, + 0.005131075328225897, + 0.005131076176988492, + 0.005131180975100698, + 0.033436687541996704, + 0.00030074542007975337 + ], + linf=[ + 0.12239622025605945, + 0.12236446866852024, + 0.12789210451104582, + 0.07208147196589526, + 0.12903267474777533, + 0.12902126950883053, + 0.12902139991772607, + 1.0843706600615892, + 0.1760697478878981, + 0.16728192094436928, + 0.16727303109462638, + 0.1672542060574919, + 0.9611095787397885, + 0.04895673952280341 + ], + surface_flux=(flux_lax_friedrichs, flux_nonconservative_central), + tspan=(0.0, 0.05)) + # Ensure that we do not have excessive memory allocations + # (e.g., from type instabilities) + let + t = sol.t[end] + u_ode = sol.u[end] + du_ode = similar(u_ode) + # Slightly larger values for allowed allocations due to the size of the multi-ion MHD system + @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 2000 + end +end +end + +end # module diff --git a/test/test_tree_3d_part3.jl b/test/test_tree_3d_part3.jl index 9e1e8bc4dc9..fd91a106d9c 100644 --- a/test/test_tree_3d_part3.jl +++ b/test/test_tree_3d_part3.jl @@ -17,6 +17,9 @@ isdir(outdir) && rm(outdir, recursive = true) # MHD include("test_tree_3d_mhd.jl") + # Multi-ion MHD + include("test_tree_3d_mhdmultiion.jl") + # Lattice-Boltzmann include("test_tree_3d_lbm.jl") diff --git a/test/test_type.jl b/test/test_type.jl index 6f42b7600a4..6d76c7e1431 100644 --- a/test/test_type.jl +++ b/test/test_type.jl @@ -1575,6 +1575,58 @@ isdir(outdir) && rm(outdir, recursive = true) end end + @timed_testset "Ideal Glm Mhd MultiIon 3D" begin + for RealT in (Float32, Float64) + gammas = (RealT(2), RealT(2)) + charge_to_mass = (RealT(2), RealT(2)) + equations = @inferred IdealGlmMhdMultiIonEquations3D(gammas = gammas, + charge_to_mass = charge_to_mass) + + x = SVector(zero(RealT), zero(RealT), zero(RealT)) + t = zero(RealT) + u = u_ll = u_rr = cons = SVector(one(RealT), one(RealT), one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT), + one(RealT)) + dissipation_es = DissipationLaxFriedrichsEntropyVariables() + orientations = [1, 2, 3] + + @test eltype(@inferred initial_condition_weak_blast_wave(x, t, equations)) == + RealT + + for orientation in orientations + @test eltype(@inferred flux(u, orientation, equations)) == RealT + @test eltype(@inferred flux_nonconservative_ruedaramirez_etal(u_ll, u_rr, + orientation, + equations)) == + RealT + @test eltype(@inferred flux_nonconservative_central(u_ll, u_rr, orientation, + equations)) == + RealT + @test eltype(@inferred flux_ruedaramirez_etal(u_ll, u_rr, orientation, + equations)) == RealT + + @test typeof(@inferred max_abs_speed_naive(u_ll, u_rr, orientation, + equations)) == + RealT + end + + @test eltype(@inferred Trixi.max_abs_speeds(u, equations)) == RealT + + for direction in orientations + @test typeof(Trixi.calc_fast_wavespeed(cons, direction, equations)) == RealT + end + end + end + @timed_testset "Inviscid Burgers 1D" begin for RealT in (Float32, Float64) equations = @inferred InviscidBurgersEquation1D() From 0d72a485b87d6fa9b34c2f565ca584b02ab653ca Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?Andr=C3=A9s=20Rueda-Ram=C3=ADrez?= Date: Thu, 19 Dec 2024 18:25:37 +0100 Subject: [PATCH 2/2] Larger threshold for allocations is not really needed --- test/test_tree_3d_mhdmultiion.jl | 9 +++------ 1 file changed, 3 insertions(+), 6 deletions(-) diff --git a/test/test_tree_3d_mhdmultiion.jl b/test/test_tree_3d_mhdmultiion.jl index f661e0be77e..6e110f62fbd 100644 --- a/test/test_tree_3d_mhdmultiion.jl +++ b/test/test_tree_3d_mhdmultiion.jl @@ -51,8 +51,7 @@ EXAMPLES_DIR = joinpath(examples_dir(), "tree_3d_dgsem") t = sol.t[end] u_ode = sol.u[end] du_ode = similar(u_ode) - # Slightly larger values for allowed allocations due to the size of the multi-ion MHD system - @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 2000 + @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 1000 end end @@ -100,8 +99,7 @@ end t = sol.t[end] u_ode = sol.u[end] du_ode = similar(u_ode) - # Slightly larger values for allowed allocations due to the size of the multi-ion MHD system - @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 2000 + @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 1000 end end @@ -147,8 +145,7 @@ end t = sol.t[end] u_ode = sol.u[end] du_ode = similar(u_ode) - # Slightly larger values for allowed allocations due to the size of the multi-ion MHD system - @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 2000 + @test (@allocated Trixi.rhs!(du_ode, u_ode, semi, t)) < 1000 end end end