Skip to content

Commit

Permalink
Parabolic Mortar for AMR P4estMesh{3} (#1765)
Browse files Browse the repository at this point in the history
* Clean branch

* Un-Comment

* un-comment

* test coarsen

* remove redundancy

* Remove support for passive terms

* expand resize

* comments

* format

* Avoid code duplication

* Update src/callbacks_step/amr_dg1d.jl

Co-authored-by: Michael Schlottke-Lakemper <michael@sloede.com>

* comment

* comment & format

* Try to increase coverage

* Slightly more expressive names

* Apply suggestions from code review

* add specifier for 1d

* Structs for resizing parabolic helpers

* check if mortars are present

* reuse `reinitialize_containers!`

* resize calls for parabolic helpers

* update analysis callbacks

* Velocities for compr euler

* Init container

* correct copy-paste error

* resize each dim

* add dispatch

* Add AMR for shear layer

* USe only amr shear layer

* first steps towards p4est parabolic amr

* Add tests

* remove plots

* Format

* remove redundant line

* platform independent tests

* No need for different flux_viscous comps after adding container_viscous to p4est

* Laplace 3d

* Longer times to allow converage to hit coarsen!

* Increase testing of Laplace 3D

* Add tests for velocities

* remove comment

* add elixir for amr testing

* adding commented out mortar routines in 2D

* Adding Mortar to 2d dg parabolic term

* remove testing snippet

* fix comments

* add more arguments for dispatch

* add some temporary todo notes

* some updates for AP and KS

* specialize mortar_fluxes_to_elements

* BUGFIX: apply_jacobian_parabolic! was incorrect for P4estMesh

* fixed rhs_parabolic! for mortars

* more changes to elixir

* indexing bug

* comments

* Adding the example for nonperiodic BCs with amr

* hopefully this fixes AMR boundaries for parabolic terms

* add elixir

* Example with non periodic bopundary conditions

* remove cruft

* 3D parabolic amr

* TGV elixir

* Creating test for AMR 3D parabolic

* Formatting

* test formatting

* Update src/Trixi.jl

* Update src/equations/compressible_euler_1d.jl

* Update src/equations/compressible_euler_2d.jl

* Update src/equations/compressible_euler_3d.jl

* Update src/solvers/dgsem_tree/container_viscous_2d.jl

* Update src/solvers/dgsem_tree/container_viscous_2d.jl

* Update src/solvers/dgsem_tree/container_viscous_2d.jl

* Update src/solvers/dgsem_tree/container_viscous_3d.jl

* Update src/solvers/dgsem_tree/container_viscous_3d.jl

* Update src/solvers/dgsem_tree/container_viscous_3d.jl

* Update src/solvers/dgsem_p4est/dg_2d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_2d_parabolic.jl

* Update test/test_parabolic_3d.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_tree/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_2d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_2d.jl

* Update src/solvers/dgsem_p4est/dg_2d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_2d_parabolic.jl

* Update test/test_parabolic_3d.jl

* Update test/test_parabolic_3d.jl

* Update test/test_parabolic_3d.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_taylor_green_vortex_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_taylor_green_vortex_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_taylor_green_vortex_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_taylor_green_vortex_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_taylor_green_vortex_amr.jl

* Update dg_3d_parabolic.jl

* Update test_parabolic_3d.jl

* Update elixir_navierstokes_3d_blast_wave_amr.jl

* Update elixir_navierstokes_taylor_green_vortex_amr.jl

* Update dg_3d_parabolic.jl

* Update test_parabolic_3d.jl

* Update test_parabolic_3d.jl

* Update examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Update elixir_navierstokes_3d_blast_wave_amr.jl

* Update elixir_navierstokes_taylor_green_vortex_amr.jl

* Update dg_3d_parabolic.jl

* Update test_parabolic_3d.jl

* Delete examples/p4est_3d_dgsem/elixir_navierstokes_3d_blast_wave_amr.jl

* Create elixir_navierstokes_blast_wave_amr.jl

* Update test_parabolic_3d.jl

* Update NEWS.md

* Update NEWS.md

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

* Update src/solvers/dgsem_p4est/dg_3d_parabolic.jl

---------

Co-authored-by: Daniel_Doehring <daniel.doehring@rwth-aachen.de>
Co-authored-by: Daniel Doehring <doehringd2@gmail.com>
Co-authored-by: Michael Schlottke-Lakemper <michael@sloede.com>
Co-authored-by: Jesse Chan <1156048+jlchan@users.noreply.github.com>
Co-authored-by: Jesse Chan <jesse.lee.chan@gmail.com>
  • Loading branch information
6 people authored Dec 23, 2023
1 parent 24a365d commit 96c5bef
Show file tree
Hide file tree
Showing 7 changed files with 637 additions and 6 deletions.
5 changes: 5 additions & 0 deletions NEWS.md
Original file line number Diff line number Diff line change
Expand Up @@ -4,6 +4,11 @@ Trixi.jl follows the interpretation of [semantic versioning (semver)](https://ju
used in the Julia ecosystem. Notable changes will be documented in this file
for human readability.

## Changes in the v0.6 lifecycle

#### Added
- AMR for hyperbolic-parabolic equations on 3D `P4estMesh`

## Changes when updating to v0.6 from v0.5.x

#### Added
Expand Down
113 changes: 113 additions & 0 deletions examples/p4est_3d_dgsem/elixir_navierstokes_blast_wave_amr.jl
Original file line number Diff line number Diff line change
@@ -0,0 +1,113 @@

using OrdinaryDiffEq
using Trixi

###############################################################################
# semidiscretization of the compressible Navier-Stokes equations

# TODO: parabolic; unify names of these accessor functions
prandtl_number() = 0.72
mu() = 6.25e-4 # equivalent to Re = 1600

equations = CompressibleEulerEquations3D(1.4)
equations_parabolic = CompressibleNavierStokesDiffusion3D(equations, mu = mu(),
Prandtl = prandtl_number())

function initial_condition_3d_blast_wave(x, t, equations::CompressibleEulerEquations3D)
rho_c = 1.0
p_c = 1.0
u_c = 0.0

rho_o = 0.125
p_o = 0.1
u_o = 0.0

rc = 0.5
r = sqrt(x[1]^2 + x[2]^2 + x[3]^2)
if r < rc
rho = rho_c
v1 = u_c
v2 = u_c
v3 = u_c
p = p_c
else
rho = rho_o
v1 = u_o
v2 = u_o
v3 = u_o
p = p_o
end

return prim2cons(SVector(rho, v1, v2, v3, p), equations)
end
initial_condition = initial_condition_3d_blast_wave

surface_flux = flux_lax_friedrichs
volume_flux = flux_ranocha
polydeg = 3
basis = LobattoLegendreBasis(polydeg)
indicator_sc = IndicatorHennemannGassner(equations, basis,
alpha_max = 1.0,
alpha_min = 0.001,
alpha_smooth = true,
variable = density_pressure)
volume_integral = VolumeIntegralShockCapturingHG(indicator_sc;
volume_flux_dg = volume_flux,
volume_flux_fv = surface_flux)

solver = DGSEM(polydeg = polydeg, surface_flux = surface_flux,
volume_integral = volume_integral)

coordinates_min = (-1.0, -1.0, -1.0) .* pi
coordinates_max = (1.0, 1.0, 1.0) .* pi

trees_per_dimension = (4, 4, 4)

mesh = P4estMesh(trees_per_dimension, polydeg = 3,
coordinates_min = coordinates_min, coordinates_max = coordinates_max,
periodicity = (true, true, true), initial_refinement_level = 1)

semi = SemidiscretizationHyperbolicParabolic(mesh, (equations, equations_parabolic),
initial_condition, solver)

###############################################################################
# ODE solvers, callbacks etc.

tspan = (0.0, 0.8)
ode = semidiscretize(semi, tspan)

summary_callback = SummaryCallback()

analysis_interval = 100
analysis_callback = AnalysisCallback(semi, interval = analysis_interval)
save_solution = SaveSolutionCallback(interval = analysis_interval,
save_initial_solution = true,
save_final_solution = true,
solution_variables = cons2prim)

amr_indicator = IndicatorLöhner(semi, variable = Trixi.density)

amr_controller = ControllerThreeLevel(semi, amr_indicator,
base_level = 0,
med_level = 1, med_threshold = 0.05,
max_level = 3, max_threshold = 0.1)
amr_callback = AMRCallback(semi, amr_controller,
interval = 10,
adapt_initial_condition = true,
adapt_initial_condition_only_refine = true)

alive_callback = AliveCallback(analysis_interval = analysis_interval)

callbacks = CallbackSet(summary_callback,
analysis_callback,
alive_callback,
amr_callback,
save_solution)

###############################################################################
# run the simulation

time_int_tol = 1e-8
sol = solve(ode, RDPK3SpFSAL49(); abstol = time_int_tol, reltol = time_int_tol,
ode_default_options()..., callback = callbacks)
summary_callback() # print the timer summary
106 changes: 106 additions & 0 deletions examples/p4est_3d_dgsem/elixir_navierstokes_taylor_green_vortex_amr.jl
Original file line number Diff line number Diff line change
@@ -0,0 +1,106 @@

using OrdinaryDiffEq
using Trixi

###############################################################################
# semidiscretization of the compressible Navier-Stokes equations

# TODO: parabolic; unify names of these accessor functions
prandtl_number() = 0.72
mu() = 6.25e-4 # equivalent to Re = 1600

equations = CompressibleEulerEquations3D(1.4)
equations_parabolic = CompressibleNavierStokesDiffusion3D(equations, mu = mu(),
Prandtl = prandtl_number())

"""
initial_condition_taylor_green_vortex(x, t, equations::CompressibleEulerEquations3D)
The classical Taylor-Green vortex.
"""
function initial_condition_taylor_green_vortex(x, t,
equations::CompressibleEulerEquations3D)
A = 1.0 # magnitude of speed
Ms = 0.1 # maximum Mach number

rho = 1.0
v1 = A * sin(x[1]) * cos(x[2]) * cos(x[3])
v2 = -A * cos(x[1]) * sin(x[2]) * cos(x[3])
v3 = 0.0
p = (A / Ms)^2 * rho / equations.gamma # scaling to get Ms
p = p +
1.0 / 16.0 * A^2 * rho *
(cos(2 * x[1]) * cos(2 * x[3]) + 2 * cos(2 * x[2]) + 2 * cos(2 * x[1]) +
cos(2 * x[2]) * cos(2 * x[3]))

return prim2cons(SVector(rho, v1, v2, v3, p), equations)
end
initial_condition = initial_condition_taylor_green_vortex

@inline function vel_mag(u, equations::CompressibleEulerEquations3D)
rho, rho_v1, rho_v2, rho_v3, _ = u
return sqrt(rho_v1^2 + rho_v2^2 + rho_v3^2) / rho
end

volume_flux = flux_ranocha
solver = DGSEM(polydeg = 3, surface_flux = flux_lax_friedrichs,
volume_integral = VolumeIntegralFluxDifferencing(volume_flux))

coordinates_min = (-1.0, -1.0, -1.0) .* pi
coordinates_max = (1.0, 1.0, 1.0) .* pi

trees_per_dimension = (2, 2, 2)

mesh = P4estMesh(trees_per_dimension, polydeg = 3,
coordinates_min = coordinates_min, coordinates_max = coordinates_max,
periodicity = (true, true, true), initial_refinement_level = 0)

semi = SemidiscretizationHyperbolicParabolic(mesh, (equations, equations_parabolic),
initial_condition, solver)

###############################################################################
# ODE solvers, callbacks etc.

tspan = (0.0, 0.5)
ode = semidiscretize(semi, tspan)

summary_callback = SummaryCallback()

analysis_interval = 50
analysis_callback = AnalysisCallback(semi, interval = analysis_interval,
save_analysis = true,
extra_analysis_integrals = (energy_kinetic,
energy_internal,
enstrophy))
save_solution = SaveSolutionCallback(interval = 100,
save_initial_solution = true,
save_final_solution = true,
solution_variables = cons2prim)

amr_indicator = IndicatorLöhner(semi, variable = vel_mag)

amr_controller = ControllerThreeLevel(semi, amr_indicator,
base_level = 0,
med_level = 1, med_threshold = 0.1,
max_level = 3, max_threshold = 0.2)

amr_callback = AMRCallback(semi, amr_controller,
interval = 5,
adapt_initial_condition = false,
adapt_initial_condition_only_refine = false)

alive_callback = AliveCallback(analysis_interval = analysis_interval)

callbacks = CallbackSet(summary_callback,
analysis_callback,
alive_callback,
amr_callback,
save_solution)

###############################################################################
# run the simulation

time_int_tol = 1e-8
sol = solve(ode, RDPK3SpFSAL49(); abstol = time_int_tol, reltol = time_int_tol,
ode_default_options()..., callback = callbacks)
summary_callback() # print the timer summary
4 changes: 2 additions & 2 deletions src/callbacks_step/amr_dg2d.jl
Original file line number Diff line number Diff line change
Expand Up @@ -137,7 +137,7 @@ function refine!(u_ode::AbstractVector, adaptor, mesh::Union{TreeMesh{2}, P4estM
end

function refine!(u_ode::AbstractVector, adaptor,
mesh::Union{TreeMesh{2}, P4estMesh{2}, TreeMesh{3}},
mesh::Union{TreeMesh{2}, P4estMesh{2}, TreeMesh{3}, P4estMesh{3}},
equations, dg::DGSEM, cache, cache_parabolic,
elements_to_refine)
# Call `refine!` for the hyperbolic part, which does the heavy lifting of
Expand Down Expand Up @@ -299,7 +299,7 @@ function coarsen!(u_ode::AbstractVector, adaptor,
end

function coarsen!(u_ode::AbstractVector, adaptor,
mesh::Union{TreeMesh{2}, P4estMesh{2}, TreeMesh{3}},
mesh::Union{TreeMesh{2}, P4estMesh{2}, TreeMesh{3}, P4estMesh{3}},
equations, dg::DGSEM, cache, cache_parabolic,
elements_to_remove)
# Call `coarsen!` for the hyperbolic part, which does the heavy lifting of
Expand Down
1 change: 1 addition & 0 deletions src/equations/laplace_diffusion_3d.jl
Original file line number Diff line number Diff line change
Expand Up @@ -18,6 +18,7 @@ function varnames(variable_mapping, equations_parabolic::LaplaceDiffusion3D)
varnames(variable_mapping, equations_parabolic.equations_hyperbolic)
end

# no orientation specified since the flux is vector-valued
function flux(u, gradients, orientation::Integer, equations_parabolic::LaplaceDiffusion3D)
dudx, dudy, dudz = gradients
if orientation == 1
Expand Down
Loading

0 comments on commit 96c5bef

Please sign in to comment.