MFC: Simulation
High-fidelity multiphase flow simulation
Loading...
Searching...
No Matches
m_global_parameters Module Reference

The module contains all of the parameters describing the program logistics, the computational domain and the simulation algorithm. Additionally, for the volume fraction model, physical parameters of each of the fluids present in the flow are located here. They include stiffened gas equation of state parameters, the Reynolds numbers and the Weber numbers. More...

Functions/Subroutines

impure subroutine s_assign_default_values_to_user_inputs
 Assigns default values to the user inputs before reading them in. This enables for an easier consistency check of these parameters once they are read from the input file.
 
impure subroutine s_initialize_global_parameters_module
 The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.
 
impure subroutine s_initialize_parallel_io
 Initializes parallel infrastructure.
 
impure subroutine s_finalize_global_parameters_module
 Module deallocation and/or disassociation procedures.
 

Variables

real(wpwall_time = 0
 
real(wpwall_time_avg = 0
 
integer num_procs
 Number of processors.
 
character(len=path_lencase_dir
 Case folder location.
 
logical run_time_info
 Run-time output flag.
 
integer t_step_old
 Existing IC/grid folder.
 
integer proc_rank
 Rank of the local processor.
 
real(wpdt
 Size of the time-step.
 
logical cfl_adap_dt
 
logical cfl_const_dt
 
logical cfl_dt
 
integer t_step_print
 Number of time-steps between printouts.
 
integer model_eqns
 Multicomponent flow model.
 
integer num_dims
 Number of spatial dimensions.
 
integer num_vels
 Number of velocity components (different from num_dims for mhd)
 
logical mpp_lim
 Mixture physical parameters (MPP) limits.
 
integer time_stepper
 Time-stepper algorithm.
 
logical prim_vars_wrt
 
integer recon_type
 Reconstruction Type.
 
integer weno_polyn
 Degree of the WENO polynomials (polyn)
 
integer muscl_polyn
 Degree of the MUSCL polynomials (polyn)i.
 
integer weno_order
 Order of the WENO reconstruction.
 
integer muscl_order
 Order of the MUSCL reconstruction.
 
integer weno_num_stencils
 Number of stencils for WENO reconstruction (only different from weno_polyn for TENO(>5))
 
integer muscl_lim
 MUSCL Limiter.
 
integer num_fluids
 number of fluids in the simulation
 
logical wenojs
 WENO-JS (default)
 
logical mapped_weno
 WENO-M (WENO with mapping of nonlinear weights)
 
logical wenoz
 WENO-Z.
 
logical teno
 TENO (Targeted ENO)
 
real(wpwenoz_q
 Power constant for WENO-Z.
 
logical mhd
 Magnetohydrodynamics.
 
logical relativity
 Relativity (only for MHD)
 
integer igr_iter_solver
 IGR elliptic solver.
 
integer igr_order
 Reconstruction order for IGR.
 
logical igr
 Use information geometric regularization.
 
logical igr_pres_lim
 Limit to positive pressures for IGR.
 
logical viscous
 Viscous effects.
 
real(wpweno_eps
 Binding for the WENO nonlinear weights.
 
real(wpteno_ct
 Smoothness threshold for TENO.
 
logical mp_weno
 Monotonicity preserving (MP) WENO.
 
logical weno_avg
 
logical weno_re_flux
 WENO reconstruct velocity gradients for viscous stress tensor.
 
integer riemann_solver
 Riemann solver algorithm.
 
integer low_mach
 Low Mach number fix to HLLC Riemann solver.
 
integer wave_speeds
 Wave speeds estimation method.
 
integer avg_state
 Average state evaluation method.
 
logical alt_soundspeed
 Alternate mixture sound speed.
 
logical null_weights
 Null undesired WENO weights.
 
logical mixture_err
 Mixture properties correction.
 
logical hypoelasticity
 hypoelasticity modeling
 
logical hyperelasticity
 hyperelasticity modeling
 
logical int_comp
 THINC interface compression.
 
real(wpic_eps
 THINC Epsilon to compress on surface cells.
 
real(wpic_beta
 THINC Sharpness Parameter.
 
integer hyper_model
 hyperelasticity solver algorithm
 
logical elasticity
 elasticity modeling, true for hyper or hypo
 
logical, parameter chemistry = .False.
 Chemistry modeling.
 
logical shear_stress
 Shear stresses.
 
logical bulk_stress
 Bulk stresses.
 
logical cont_damage
 Continuum damage modeling.
 
integer num_igr_iters
 number of iterations for elliptic solve
 
integer num_igr_warm_start_iters
 number of warm start iterations for elliptic solve
 
real(wpalf_factor
 alpha factor for IGR
 
logical bodyforces
 
logical bf_x
 
logical bf_y
 
logical bf_z
 body force toggle in three directions amplitude, frequency, and phase shift sinusoid in each direction
 
real(wpk_x
 
real(wpw_x
 
real(wpp_x
 
real(wpg_x
 
real(wpk_y
 
real(wpw_y
 
real(wpp_y
 
real(wpg_y
 
real(wpk_z
 
real(wpw_z
 
real(wpp_z
 
real(wpg_z
 
real(wp), dimension(3) accel_bf
 
integer cpu_start
 
integer cpu_end
 
integer cpu_rate
 
logical relax
 activate phase change
 
integer relax_model
 Relaxation model.
 
real(wppalpha_eps
 trigger parameter for the p relaxation procedure, phase change model
 
real(wpptgalpha_eps
 trigger parameter for the pTg relaxation procedure, phase change model
 
integer num_bc_patches
 
logical bc_io
 
type(bounds_infox_domain
 
type(bounds_infoy_domain
 
type(bounds_infoz_domain
 
real(wpx_a
 
real(wpy_a
 
real(wpz_a
 
real(wpx_b
 
real(wpy_b
 
real(wpz_b
 
logical parallel_io
 Format of the data files.
 
logical file_per_process
 shared file or not when using parallel io
 
integer precision
 Precision of output files.
 
logical down_sample
 down sample the output files
 
integer, dimension(:), allocatable proc_coords
 Processor coordinates in MPI_CART_COMM.
 
integer, dimension(:), allocatable start_idx
 Starting cell-center index of local processor in global grid.
 
type(mpi_io_var), public mpi_io_data
 
type(mpi_io_ib_var), public mpi_io_ib_data
 
type(mpi_io_airfoil_ib_var), public mpi_io_airfoil_ib_data
 
type(mpi_io_levelset_var), public mpi_io_levelset_data
 
type(mpi_io_levelset_norm_var), public mpi_io_levelsetnorm_data
 
real(wp), dimension(:, :), allocatable, public mpi_io_data_lag_bubbles
 
type(int_bounds_info), dimension(1:3) idwint
 
type(int_bounds_info), dimension(1:3) idwbuff
 
integer buff_size
 The number of cells that are necessary to be able to store enough boundary conditions data to march the solution in the physical computational domain to the next time-step.
 
integer shear_num
 
integer, dimension(3) shear_indices
 Indices of the stress components that represent shear stress.
 
integer shear_bc_flip_num
 Number of shear stress components to reflect for boundary conditions.
 
integer, dimension(3, 2) shear_bc_flip_indices
 Indices of shear stress components to reflect for boundary conditions. Size: (1:3, 1:shear_BC_flip_num) for (x/y/z, [indices])
 
type(physical_parameters), dimension(num_fluids_maxfluid_pp
 Database of the physical parameters of each of the fluids that is present in the flow. These include the stiffened gas equation of state parameters, the Reynolds numbers and the Weber numbers.
 
integer fd_order
 The order of the finite-difference (fd) approximations of the first-order derivatives that need to be evaluated when the CoM or flow probe data files are to be written at each time step.
 
integer fd_number
 The finite-difference number is given by MAX(1, fd_order/2). Essentially, it is a measure of the half-size of the finite-difference stencil for the selected order of accuracy.
 
logical probe_wrt
 
logical integral_wrt
 
integer num_probes
 
integer num_integrals
 
type(vec3_dt), dimension(num_probes_maxprobe
 
type(integral_parameters), dimension(num_probes_maxintegral
 
type(chemistry_parameterschem_params
 
integer momxb
 
integer momxe
 
integer advxb
 
integer advxe
 
integer contxb
 
integer contxe
 
integer intxb
 
integer intxe
 
integer bubxb
 
integer bubxe
 
integer strxb
 
integer strxe
 
integer chemxb
 
integer chemxe
 
integer xibeg
 
integer xiend
 
real(wp), dimension(:), allocatable gammas
 
real(wp), dimension(:), allocatable gs_min
 
real(wp), dimension(:), allocatable pi_infs
 
real(wp), dimension(:), allocatable ps_inf
 
real(wp), dimension(:), allocatable cvs
 
real(wp), dimension(:), allocatable qvs
 
real(wp), dimension(:), allocatable qvps
 
real(wpmytime
 Current simulation time.
 
real(wpfinaltime
 Final simulation time.
 
logical rdma_mpi
 
type(pres_field), dimension(:), allocatable pb_ts
 
type(pres_field), dimension(:), allocatable mv_ts
 
real(wpbx0
 Constant magnetic field in the x-direction (1D)
 
logical powell
 Powell‐correction for div B = 0.
 
logical fft_wrt
 
Number of cells in the x-, y- and z-directions, respectively
integer m
 
integer n
 
integer p
 
Max and min number of cells in a direction of each combination of x-,y-, and z-
type(cell_num_boundscells_bounds
 
Global number of cells in each direction
integer m_glb
 
integer n_glb
 
integer p_glb
 
Cylindrical coordinates (either axisymmetric or full 3D)
logical cyl_coord
 
integer grid_geometry
 
Cell-boundary (CB) locations in the x-, y- and z-directions, respectively
real(wp), dimension(:), allocatable, target x_cb
 
real(wp), dimension(:), allocatable, target y_cb
 
real(wp), dimension(:), allocatable, target z_cb
 
Cell-center (CC) locations in the x-, y- and z-directions, respectively
real(wp), dimension(:), allocatable, target x_cc
 
real(wp), dimension(:), allocatable, target y_cc
 
real(wp), dimension(:), allocatable, target z_cc
 
Cell-width distributions in the x-, y- and z-directions, respectively
real(wp), dimension(:), allocatable, target dx
 
real(wp), dimension(:), allocatable, target dy
 
real(wp), dimension(:), allocatable, target dz
 
Starting time-step iteration, stopping time-step iteration and the number

of time-step iterations between successive solution backups, respectively

integer t_step_start
 
integer t_step_stop
 
integer t_step_save
 
Starting time, stopping time, and time between backups, simulation time,

and prescribed cfl respectively

real(wpt_stop
 
real(wpt_save
 
real(wpcfl_target
 
integer n_start
 
Variables for our of core IGR computation on NVIDIA
logical nv_uvm_out_of_core
 
integer nv_uvm_igr_temps_on_gpu
 
logical nv_uvm_pref_gpu
 
Boundary conditions (BC) in the x-, y- and z-directions, respectively
type(int_bounds_infobc_x
 
type(int_bounds_infobc_y
 
type(int_bounds_infobc_z
 
MPI info for parallel IO with Lustre file systems
character(len=name_lenmpiiofs
 
integer mpi_info_int
 
Annotations of the structure of the state and flux vectors in terms of the

size and the configuration of the system of equations to which they belong

integer sys_size
 Number of unknowns in system of eqns.
 
type(int_bounds_infocont_idx
 Indexes of first & last continuity eqns.
 
type(int_bounds_infomom_idx
 Indexes of first & last momentum eqns.
 
integer e_idx
 Index of energy equation.
 
integer n_idx
 Index of number density.
 
type(int_bounds_infoadv_idx
 Indexes of first & last advection eqns.
 
type(int_bounds_infointernalenergies_idx
 Indexes of first & last internal energy eqns.
 
type(bub_bounds_infobub_idx
 Indexes of first & last bubble variable eqns.
 
integer alf_idx
 Index of void fraction.
 
integer gamma_idx
 Index of specific heat ratio func. eqn.
 
integer pi_inf_idx
 Index of liquid stiffness func. eqn.
 
type(int_bounds_infob_idx
 Indexes of first and last magnetic field eqns.
 
type(int_bounds_infostress_idx
 Indexes of first and last shear stress eqns.
 
type(int_bounds_infoxi_idx
 Indexes of first and last reference map eqns.
 
integer b_size
 Number of elements in the symmetric b tensor, plus one.
 
integer tensor_size
 Number of elements in the full tensor plus one.
 
type(int_bounds_infospecies_idx
 Indexes of first & last concentration eqns.
 
integer c_idx
 Index of color function.
 
integer damage_idx
 Index of damage state variable (D) for continuum damage model.
 
The number of fluids, along with their identifying indexes, respectively,

for which viscous effects, e.g. the shear and/or the volume Reynolds (Re) numbers, will be non-negligible.

integer, dimension(2) re_size
 
integer re_size_max
 
integer, dimension(:, :), allocatable re_idx
 
real(wpwa_flg
 
The coordinate direction indexes and flags (flg), respectively, for which

the configurations will be determined with respect to a working direction and that will be used to isolate the contributions, in that direction, in the dimensionally split system of equations.

integer, dimension(3) dir_idx
 
real(wp), dimension(3) dir_flg
 
integer, dimension(3) dir_idx_tau
 
Reference density and pressure for Tait EOS
real(wprhoref
 
real(wppref
 
Immersed Boundaries
logical ib
 
integer num_ibs
 
type(ib_patch_parameters), dimension(num_patches_maxpatch_ib
 
type(vec3_dt), dimension(:), allocatable airfoil_grid_u
 
type(vec3_dt), dimension(:), allocatable airfoil_grid_l
 
integer np
 
Bubble modeling
integer nb
 Number of eq. bubble sizes.
 
real(wpr0ref
 Reference bubble size.
 
real(wpca
 Cavitation number.
 
real(wpweb
 Weber number.
 
real(wpre_inv
 Inverse Reynolds number.
 
real(wp), dimension(:), allocatable weight
 Simpson quadrature weights.
 
real(wp), dimension(:), allocatable r0
 Bubble sizes.
 
logical bubbles_euler
 Bubbles euler on/off.
 
logical polytropic
 Polytropic switch.
 
logical polydisperse
 Polydisperse bubbles.
 
logical adv_n
 Solve the number density equation and compute alpha from number density.
 
logical adap_dt
 Adaptive step size control.
 
real(wpadap_dt_tol
 Tolerance to control adaptive step size.
 
integer adap_dt_max_iters
 Maximum number of iterations.
 
integer bubble_model
 Gilmore or Keller–Miksis bubble model.
 
integer thermal
 Thermal behavior. 1 = adiabatic, 2 = isotherm, 3 = transfer.
 
real(wp), dimension(:, :, :), allocatable ptil
 Pressure modification.
 
real(wppoly_sigma
 log normal sigma for polydisperse PDF
 
logical qbmm
 Quadrature moment method.
 
integer, parameter nmom = 6
 Number of carried moments per R0 location.
 
integer nmomsp
 Number of moments required by ensemble-averaging.
 
integer nmomtot
 Total number of carried moments moments/transport equations.
 
real(wppi_fac
 Factor for artificial pi_inf.
 
type(scalar_field), dimension(:), allocatable mom_sp
 
type(scalar_field), dimension(:, :, :), allocatable mom_3d
 
Physical bubble parameters (see Ando 2010, Preston 2007)
real(wpr_n
 
real(wpr_v
 
real(wpphi_vn
 
real(wpphi_nv
 
real(wppe_c
 
real(wptw
 
real(wppv
 
real(wpm_n
 
real(wpm_v
 
real(wpk_vl
 
real(wpk_nl
 
real(wpcp_n
 
real(wpcp_v
 
real(wp), dimension(:), allocatable k_n
 
real(wp), dimension(:), allocatable k_v
 
real(wp), dimension(:), allocatable pb0
 
real(wp), dimension(:), allocatable mass_n0
 
real(wp), dimension(:), allocatable mass_v0
 
real(wp), dimension(:), allocatable pe_t
 
real(wp), dimension(:), allocatable re_trans_t
 
real(wp), dimension(:), allocatable re_trans_c
 
real(wp), dimension(:), allocatable im_trans_t
 
real(wp), dimension(:), allocatable im_trans_c
 
real(wp), dimension(:), allocatable omegan
 
real(wpmul0
 
real(wpss
 
real(wpgamma_v
 
real(wpmu_v
 
real(wpgamma_m
 
real(wpgamma_n
 
real(wpmu_n
 
real(wpgam
 
Acoustic acoustic_source parameters
logical acoustic_source
 Acoustic source switch.
 
type(acoustic_parameters), dimension(num_probes_maxacoustic
 Acoustic source parameters.
 
integer num_source
 Number of acoustic sources.
 
Surface tension parameters
real(wpsigma
 
logical surface_tension
 
lagrangian subgrid bubble parameters

!

logical bubbles_lagrange
 Lagrangian subgrid bubble model switch.
 
type(bubbles_lagrange_parameterslag_params
 Lagrange bubbles' parameters.
 
Continuum damage model parameters

!

real(wptau_star
 Stress threshold for continuum damage modeling.
 
real(wpcont_damage_s
 Exponent s for continuum damage modeling.
 
real(wpalpha_bar
 Damage rate factor for continuum damage modeling.
 

Detailed Description

The module contains all of the parameters describing the program logistics, the computational domain and the simulation algorithm. Additionally, for the volume fraction model, physical parameters of each of the fluids present in the flow are located here. They include stiffened gas equation of state parameters, the Reynolds numbers and the Weber numbers.

Function/Subroutine Documentation

◆ s_assign_default_values_to_user_inputs()

impure subroutine m_global_parameters::s_assign_default_values_to_user_inputs

Assigns default values to the user inputs before reading them in. This enables for an easier consistency check of these parameters once they are read from the input file.

Here is the call graph for this function:
Here is the caller graph for this function:

◆ s_finalize_global_parameters_module()

impure subroutine m_global_parameters::s_finalize_global_parameters_module

Module deallocation and/or disassociation procedures.

Here is the caller graph for this function:

◆ s_initialize_global_parameters_module()

impure subroutine m_global_parameters::s_initialize_global_parameters_module

The computation of parameters, the allocation of memory, the association of pointers and/or the execution of any other procedures that are necessary to setup the module.

Here is the caller graph for this function:

◆ s_initialize_parallel_io()

impure subroutine m_global_parameters::s_initialize_parallel_io

Initializes parallel infrastructure.

Here is the caller graph for this function:

Variable Documentation

◆ accel_bf

real(wp), dimension(3) m_global_parameters::accel_bf

◆ acoustic

type(acoustic_parameters), dimension(num_probes_max) m_global_parameters::acoustic

Acoustic source parameters.

◆ acoustic_source

logical m_global_parameters::acoustic_source

Acoustic source switch.

◆ adap_dt

logical m_global_parameters::adap_dt

Adaptive step size control.

◆ adap_dt_max_iters

integer m_global_parameters::adap_dt_max_iters

Maximum number of iterations.

◆ adap_dt_tol

real(wp) m_global_parameters::adap_dt_tol

Tolerance to control adaptive step size.

◆ adv_idx

type(int_bounds_info) m_global_parameters::adv_idx

Indexes of first & last advection eqns.

◆ adv_n

logical m_global_parameters::adv_n

Solve the number density equation and compute alpha from number density.

◆ advxb

integer m_global_parameters::advxb

◆ advxe

integer m_global_parameters::advxe

◆ airfoil_grid_l

type(vec3_dt), dimension(:), allocatable m_global_parameters::airfoil_grid_l

◆ airfoil_grid_u

type(vec3_dt), dimension(:), allocatable m_global_parameters::airfoil_grid_u

◆ alf_factor

real(wp) m_global_parameters::alf_factor

alpha factor for IGR

◆ alf_idx

integer m_global_parameters::alf_idx

Index of void fraction.

◆ alpha_bar

real(wp) m_global_parameters::alpha_bar

Damage rate factor for continuum damage modeling.

◆ alt_soundspeed

logical m_global_parameters::alt_soundspeed

Alternate mixture sound speed.

◆ avg_state

integer m_global_parameters::avg_state

Average state evaluation method.

◆ b_idx

type(int_bounds_info) m_global_parameters::b_idx

Indexes of first and last magnetic field eqns.

◆ b_size

integer m_global_parameters::b_size

Number of elements in the symmetric b tensor, plus one.

◆ bc_io

logical m_global_parameters::bc_io

◆ bc_x

type(int_bounds_info) m_global_parameters::bc_x

◆ bc_y

type(int_bounds_info) m_global_parameters::bc_y

◆ bc_z

type(int_bounds_info) m_global_parameters::bc_z

◆ bf_x

logical m_global_parameters::bf_x

◆ bf_y

logical m_global_parameters::bf_y

◆ bf_z

logical m_global_parameters::bf_z

body force toggle in three directions amplitude, frequency, and phase shift sinusoid in each direction

◆ bodyforces

logical m_global_parameters::bodyforces

◆ bub_idx

type(bub_bounds_info) m_global_parameters::bub_idx

Indexes of first & last bubble variable eqns.

◆ bubble_model

integer m_global_parameters::bubble_model

Gilmore or Keller–Miksis bubble model.

◆ bubbles_euler

logical m_global_parameters::bubbles_euler

Bubbles euler on/off.

◆ bubbles_lagrange

logical m_global_parameters::bubbles_lagrange

Lagrangian subgrid bubble model switch.

◆ bubxb

integer m_global_parameters::bubxb

◆ bubxe

integer m_global_parameters::bubxe

◆ buff_size

integer m_global_parameters::buff_size

The number of cells that are necessary to be able to store enough boundary conditions data to march the solution in the physical computational domain to the next time-step.

◆ bulk_stress

logical m_global_parameters::bulk_stress

Bulk stresses.

◆ bx0

real(wp) m_global_parameters::bx0

Constant magnetic field in the x-direction (1D)

◆ c_idx

integer m_global_parameters::c_idx

Index of color function.

◆ ca

real(wp) m_global_parameters::ca

Cavitation number.

◆ case_dir

character(len=path_len) m_global_parameters::case_dir

Case folder location.

◆ cells_bounds

type(cell_num_bounds) m_global_parameters::cells_bounds

◆ cfl_adap_dt

logical m_global_parameters::cfl_adap_dt

◆ cfl_const_dt

logical m_global_parameters::cfl_const_dt

◆ cfl_dt

logical m_global_parameters::cfl_dt

◆ cfl_target

real(wp) m_global_parameters::cfl_target

◆ chem_params

type(chemistry_parameters) m_global_parameters::chem_params

◆ chemistry

logical, parameter m_global_parameters::chemistry = .False.

Chemistry modeling.

◆ chemxb

integer m_global_parameters::chemxb

◆ chemxe

integer m_global_parameters::chemxe

◆ cont_damage

logical m_global_parameters::cont_damage

Continuum damage modeling.

◆ cont_damage_s

real(wp) m_global_parameters::cont_damage_s

Exponent s for continuum damage modeling.

◆ cont_idx

type(int_bounds_info) m_global_parameters::cont_idx

Indexes of first & last continuity eqns.

◆ contxb

integer m_global_parameters::contxb

◆ contxe

integer m_global_parameters::contxe

◆ cp_n

real(wp) m_global_parameters::cp_n

◆ cp_v

real(wp) m_global_parameters::cp_v

◆ cpu_end

integer m_global_parameters::cpu_end

◆ cpu_rate

integer m_global_parameters::cpu_rate

◆ cpu_start

integer m_global_parameters::cpu_start

◆ cvs

real(wp), dimension(:), allocatable m_global_parameters::cvs

◆ cyl_coord

logical m_global_parameters::cyl_coord

◆ damage_idx

integer m_global_parameters::damage_idx

Index of damage state variable (D) for continuum damage model.

◆ dir_flg

real(wp), dimension(3) m_global_parameters::dir_flg

◆ dir_idx

integer, dimension(3) m_global_parameters::dir_idx

◆ dir_idx_tau

integer, dimension(3) m_global_parameters::dir_idx_tau

◆ down_sample

logical m_global_parameters::down_sample

down sample the output files

◆ dt

real(wp) m_global_parameters::dt

Size of the time-step.

◆ dx

real(wp), dimension(:), allocatable, target m_global_parameters::dx

◆ dy

real(wp), dimension(:), allocatable, target m_global_parameters::dy

◆ dz

real(wp), dimension(:), allocatable, target m_global_parameters::dz

◆ e_idx

integer m_global_parameters::e_idx

Index of energy equation.

◆ elasticity

logical m_global_parameters::elasticity

elasticity modeling, true for hyper or hypo

◆ fd_number

integer m_global_parameters::fd_number

The finite-difference number is given by MAX(1, fd_order/2). Essentially, it is a measure of the half-size of the finite-difference stencil for the selected order of accuracy.

◆ fd_order

integer m_global_parameters::fd_order

The order of the finite-difference (fd) approximations of the first-order derivatives that need to be evaluated when the CoM or flow probe data files are to be written at each time step.

◆ fft_wrt

logical m_global_parameters::fft_wrt

◆ file_per_process

logical m_global_parameters::file_per_process

shared file or not when using parallel io

◆ finaltime

real(wp) m_global_parameters::finaltime

Final simulation time.

◆ fluid_pp

type(physical_parameters), dimension(num_fluids_max) m_global_parameters::fluid_pp

Database of the physical parameters of each of the fluids that is present in the flow. These include the stiffened gas equation of state parameters, the Reynolds numbers and the Weber numbers.

◆ g_x

real(wp) m_global_parameters::g_x

◆ g_y

real(wp) m_global_parameters::g_y

◆ g_z

real(wp) m_global_parameters::g_z

◆ gam

real(wp) m_global_parameters::gam

◆ gamma_idx

integer m_global_parameters::gamma_idx

Index of specific heat ratio func. eqn.

◆ gamma_m

real(wp) m_global_parameters::gamma_m

◆ gamma_n

real(wp) m_global_parameters::gamma_n

◆ gamma_v

real(wp) m_global_parameters::gamma_v

◆ gammas

real(wp), dimension(:), allocatable m_global_parameters::gammas

◆ grid_geometry

integer m_global_parameters::grid_geometry

◆ gs_min

real(wp), dimension(:), allocatable m_global_parameters::gs_min

◆ hyper_model

integer m_global_parameters::hyper_model

hyperelasticity solver algorithm

◆ hyperelasticity

logical m_global_parameters::hyperelasticity

hyperelasticity modeling

◆ hypoelasticity

logical m_global_parameters::hypoelasticity

hypoelasticity modeling

◆ ib

logical m_global_parameters::ib

◆ ic_beta

real(wp) m_global_parameters::ic_beta

THINC Sharpness Parameter.

◆ ic_eps

real(wp) m_global_parameters::ic_eps

THINC Epsilon to compress on surface cells.

◆ idwbuff

type(int_bounds_info), dimension(1:3) m_global_parameters::idwbuff

◆ idwint

type(int_bounds_info), dimension(1:3) m_global_parameters::idwint

◆ igr

logical m_global_parameters::igr

Use information geometric regularization.

◆ igr_iter_solver

integer m_global_parameters::igr_iter_solver

IGR elliptic solver.

◆ igr_order

integer m_global_parameters::igr_order

Reconstruction order for IGR.

◆ igr_pres_lim

logical m_global_parameters::igr_pres_lim

Limit to positive pressures for IGR.

◆ im_trans_c

real(wp), dimension(:), allocatable m_global_parameters::im_trans_c

◆ im_trans_t

real(wp), dimension(:), allocatable m_global_parameters::im_trans_t

◆ int_comp

logical m_global_parameters::int_comp

THINC interface compression.

◆ integral

type(integral_parameters), dimension(num_probes_max) m_global_parameters::integral

◆ integral_wrt

logical m_global_parameters::integral_wrt

◆ internalenergies_idx

type(int_bounds_info) m_global_parameters::internalenergies_idx

Indexes of first & last internal energy eqns.

◆ intxb

integer m_global_parameters::intxb

◆ intxe

integer m_global_parameters::intxe

◆ k_n

real(wp), dimension(:), allocatable m_global_parameters::k_n

◆ k_nl

real(wp) m_global_parameters::k_nl

◆ k_v

real(wp), dimension(:), allocatable m_global_parameters::k_v

◆ k_vl

real(wp) m_global_parameters::k_vl

◆ k_x

real(wp) m_global_parameters::k_x

◆ k_y

real(wp) m_global_parameters::k_y

◆ k_z

real(wp) m_global_parameters::k_z

◆ lag_params

type(bubbles_lagrange_parameters) m_global_parameters::lag_params

Lagrange bubbles' parameters.

◆ low_mach

integer m_global_parameters::low_mach

Low Mach number fix to HLLC Riemann solver.

◆ m

integer m_global_parameters::m

◆ m_glb

integer m_global_parameters::m_glb

◆ m_n

real(wp) m_global_parameters::m_n

◆ m_v

real(wp) m_global_parameters::m_v

◆ mapped_weno

logical m_global_parameters::mapped_weno

WENO-M (WENO with mapping of nonlinear weights)

◆ mass_n0

real(wp), dimension(:), allocatable m_global_parameters::mass_n0

◆ mass_v0

real(wp), dimension(:), allocatable m_global_parameters::mass_v0

◆ mhd

logical m_global_parameters::mhd

Magnetohydrodynamics.

◆ mixture_err

logical m_global_parameters::mixture_err

Mixture properties correction.

◆ model_eqns

integer m_global_parameters::model_eqns

Multicomponent flow model.

◆ mom_3d

type(scalar_field), dimension(:, :, :), allocatable m_global_parameters::mom_3d

◆ mom_idx

type(int_bounds_info) m_global_parameters::mom_idx

Indexes of first & last momentum eqns.

◆ mom_sp

type(scalar_field), dimension(:), allocatable m_global_parameters::mom_sp

◆ momxb

integer m_global_parameters::momxb

◆ momxe

integer m_global_parameters::momxe

◆ mp_weno

logical m_global_parameters::mp_weno

Monotonicity preserving (MP) WENO.

◆ mpi_info_int

integer m_global_parameters::mpi_info_int

◆ mpi_io_airfoil_ib_data

type(mpi_io_airfoil_ib_var), public m_global_parameters::mpi_io_airfoil_ib_data

◆ mpi_io_data

type(mpi_io_var), public m_global_parameters::mpi_io_data

◆ mpi_io_data_lag_bubbles

real(wp), dimension(:, :), allocatable, public m_global_parameters::mpi_io_data_lag_bubbles

◆ mpi_io_ib_data

type(mpi_io_ib_var), public m_global_parameters::mpi_io_ib_data

◆ mpi_io_levelset_data

type(mpi_io_levelset_var), public m_global_parameters::mpi_io_levelset_data

◆ mpi_io_levelsetnorm_data

type(mpi_io_levelset_norm_var), public m_global_parameters::mpi_io_levelsetnorm_data

◆ mpiiofs

character(len=name_len) m_global_parameters::mpiiofs

◆ mpp_lim

logical m_global_parameters::mpp_lim

Mixture physical parameters (MPP) limits.

◆ mu_n

real(wp) m_global_parameters::mu_n

◆ mu_v

real(wp) m_global_parameters::mu_v

◆ mul0

real(wp) m_global_parameters::mul0

◆ muscl_lim

integer m_global_parameters::muscl_lim

MUSCL Limiter.

◆ muscl_order

integer m_global_parameters::muscl_order

Order of the MUSCL reconstruction.

◆ muscl_polyn

integer m_global_parameters::muscl_polyn

Degree of the MUSCL polynomials (polyn)i.

◆ mv_ts

type(pres_field), dimension(:), allocatable m_global_parameters::mv_ts

◆ mytime

real(wp) m_global_parameters::mytime

Current simulation time.

◆ n

integer m_global_parameters::n

◆ n_glb

integer m_global_parameters::n_glb

◆ n_idx

integer m_global_parameters::n_idx

Index of number density.

◆ n_start

integer m_global_parameters::n_start

◆ nb

integer m_global_parameters::nb

Number of eq. bubble sizes.

◆ nmom

integer, parameter m_global_parameters::nmom = 6

Number of carried moments per R0 location.

◆ nmomsp

integer m_global_parameters::nmomsp

Number of moments required by ensemble-averaging.

◆ nmomtot

integer m_global_parameters::nmomtot

Total number of carried moments moments/transport equations.

◆ np

integer m_global_parameters::np

◆ null_weights

logical m_global_parameters::null_weights

Null undesired WENO weights.

◆ num_bc_patches

integer m_global_parameters::num_bc_patches

◆ num_dims

integer m_global_parameters::num_dims

Number of spatial dimensions.

◆ num_fluids

integer m_global_parameters::num_fluids

number of fluids in the simulation

◆ num_ibs

integer m_global_parameters::num_ibs

◆ num_igr_iters

integer m_global_parameters::num_igr_iters

number of iterations for elliptic solve

◆ num_igr_warm_start_iters

integer m_global_parameters::num_igr_warm_start_iters

number of warm start iterations for elliptic solve

◆ num_integrals

integer m_global_parameters::num_integrals

◆ num_probes

integer m_global_parameters::num_probes

◆ num_procs

integer m_global_parameters::num_procs

Number of processors.

◆ num_source

integer m_global_parameters::num_source

Number of acoustic sources.

◆ num_vels

integer m_global_parameters::num_vels

Number of velocity components (different from num_dims for mhd)

◆ nv_uvm_igr_temps_on_gpu

integer m_global_parameters::nv_uvm_igr_temps_on_gpu

◆ nv_uvm_out_of_core

logical m_global_parameters::nv_uvm_out_of_core

◆ nv_uvm_pref_gpu

logical m_global_parameters::nv_uvm_pref_gpu

◆ omegan

real(wp), dimension(:), allocatable m_global_parameters::omegan

◆ p

integer m_global_parameters::p

◆ p_glb

integer m_global_parameters::p_glb

◆ p_x

real(wp) m_global_parameters::p_x

◆ p_y

real(wp) m_global_parameters::p_y

◆ p_z

real(wp) m_global_parameters::p_z

◆ palpha_eps

real(wp) m_global_parameters::palpha_eps

trigger parameter for the p relaxation procedure, phase change model

◆ parallel_io

logical m_global_parameters::parallel_io

Format of the data files.

◆ patch_ib

type(ib_patch_parameters), dimension(num_patches_max) m_global_parameters::patch_ib

◆ pb0

real(wp), dimension(:), allocatable m_global_parameters::pb0

◆ pb_ts

type(pres_field), dimension(:), allocatable m_global_parameters::pb_ts

◆ pe_c

real(wp) m_global_parameters::pe_c

◆ pe_t

real(wp), dimension(:), allocatable m_global_parameters::pe_t

◆ phi_nv

real(wp) m_global_parameters::phi_nv

◆ phi_vn

real(wp) m_global_parameters::phi_vn

◆ pi_fac

real(wp) m_global_parameters::pi_fac

Factor for artificial pi_inf.

◆ pi_inf_idx

integer m_global_parameters::pi_inf_idx

Index of liquid stiffness func. eqn.

◆ pi_infs

real(wp), dimension(:), allocatable m_global_parameters::pi_infs

◆ poly_sigma

real(wp) m_global_parameters::poly_sigma

log normal sigma for polydisperse PDF

◆ polydisperse

logical m_global_parameters::polydisperse

Polydisperse bubbles.

◆ polytropic

logical m_global_parameters::polytropic

Polytropic switch.

◆ powell

logical m_global_parameters::powell

Powell‐correction for div B = 0.

◆ precision

integer m_global_parameters::precision

Precision of output files.

◆ pref

real(wp) m_global_parameters::pref

◆ prim_vars_wrt

logical m_global_parameters::prim_vars_wrt

◆ probe

type(vec3_dt), dimension(num_probes_max) m_global_parameters::probe

◆ probe_wrt

logical m_global_parameters::probe_wrt

◆ proc_coords

integer, dimension(:), allocatable m_global_parameters::proc_coords

Processor coordinates in MPI_CART_COMM.

◆ proc_rank

integer m_global_parameters::proc_rank

Rank of the local processor.

◆ ps_inf

real(wp), dimension(:), allocatable m_global_parameters::ps_inf

◆ ptgalpha_eps

real(wp) m_global_parameters::ptgalpha_eps

trigger parameter for the pTg relaxation procedure, phase change model

◆ ptil

real(wp), dimension(:, :, :), allocatable m_global_parameters::ptil

Pressure modification.

◆ pv

real(wp) m_global_parameters::pv

◆ qbmm

logical m_global_parameters::qbmm

Quadrature moment method.

◆ qvps

real(wp), dimension(:), allocatable m_global_parameters::qvps

◆ qvs

real(wp), dimension(:), allocatable m_global_parameters::qvs

◆ r0

real(wp), dimension(:), allocatable m_global_parameters::r0

Bubble sizes.

◆ r0ref

real(wp) m_global_parameters::r0ref

Reference bubble size.

◆ r_n

real(wp) m_global_parameters::r_n

◆ r_v

real(wp) m_global_parameters::r_v

◆ rdma_mpi

logical m_global_parameters::rdma_mpi

◆ re_idx

integer, dimension(:, :), allocatable m_global_parameters::re_idx

◆ re_inv

real(wp) m_global_parameters::re_inv

Inverse Reynolds number.

◆ re_size

integer, dimension(2) m_global_parameters::re_size

◆ re_size_max

integer m_global_parameters::re_size_max

◆ re_trans_c

real(wp), dimension(:), allocatable m_global_parameters::re_trans_c

◆ re_trans_t

real(wp), dimension(:), allocatable m_global_parameters::re_trans_t

◆ recon_type

integer m_global_parameters::recon_type

Reconstruction Type.

◆ relativity

logical m_global_parameters::relativity

Relativity (only for MHD)

◆ relax

logical m_global_parameters::relax

activate phase change

◆ relax_model

integer m_global_parameters::relax_model

Relaxation model.

◆ rhoref

real(wp) m_global_parameters::rhoref

◆ riemann_solver

integer m_global_parameters::riemann_solver

Riemann solver algorithm.

◆ run_time_info

logical m_global_parameters::run_time_info

Run-time output flag.

◆ shear_bc_flip_indices

integer, dimension(3, 2) m_global_parameters::shear_bc_flip_indices

Indices of shear stress components to reflect for boundary conditions. Size: (1:3, 1:shear_BC_flip_num) for (x/y/z, [indices])

◆ shear_bc_flip_num

integer m_global_parameters::shear_bc_flip_num

Number of shear stress components to reflect for boundary conditions.

◆ shear_indices

integer, dimension(3) m_global_parameters::shear_indices

Indices of the stress components that represent shear stress.

◆ shear_num

integer m_global_parameters::shear_num

◆ shear_stress

logical m_global_parameters::shear_stress

Shear stresses.

◆ sigma

real(wp) m_global_parameters::sigma

◆ species_idx

type(int_bounds_info) m_global_parameters::species_idx

Indexes of first & last concentration eqns.

◆ ss

real(wp) m_global_parameters::ss

◆ start_idx

integer, dimension(:), allocatable m_global_parameters::start_idx

Starting cell-center index of local processor in global grid.

◆ stress_idx

type(int_bounds_info) m_global_parameters::stress_idx

Indexes of first and last shear stress eqns.

◆ strxb

integer m_global_parameters::strxb

◆ strxe

integer m_global_parameters::strxe

◆ surface_tension

logical m_global_parameters::surface_tension

◆ sys_size

integer m_global_parameters::sys_size

Number of unknowns in system of eqns.

◆ t_save

real(wp) m_global_parameters::t_save

◆ t_step_old

integer m_global_parameters::t_step_old

Existing IC/grid folder.

◆ t_step_print

integer m_global_parameters::t_step_print

Number of time-steps between printouts.

◆ t_step_save

integer m_global_parameters::t_step_save

◆ t_step_start

integer m_global_parameters::t_step_start

◆ t_step_stop

integer m_global_parameters::t_step_stop

◆ t_stop

real(wp) m_global_parameters::t_stop

◆ tau_star

real(wp) m_global_parameters::tau_star

Stress threshold for continuum damage modeling.

◆ teno

logical m_global_parameters::teno

TENO (Targeted ENO)

◆ teno_ct

real(wp) m_global_parameters::teno_ct

Smoothness threshold for TENO.

◆ tensor_size

integer m_global_parameters::tensor_size

Number of elements in the full tensor plus one.

◆ thermal

integer m_global_parameters::thermal

Thermal behavior. 1 = adiabatic, 2 = isotherm, 3 = transfer.

◆ time_stepper

integer m_global_parameters::time_stepper

Time-stepper algorithm.

◆ tw

real(wp) m_global_parameters::tw

◆ viscous

logical m_global_parameters::viscous

Viscous effects.

◆ w_x

real(wp) m_global_parameters::w_x

◆ w_y

real(wp) m_global_parameters::w_y

◆ w_z

real(wp) m_global_parameters::w_z

◆ wa_flg

real(wp) m_global_parameters::wa_flg

◆ wall_time

real(wp) m_global_parameters::wall_time = 0

◆ wall_time_avg

real(wp) m_global_parameters::wall_time_avg = 0

◆ wave_speeds

integer m_global_parameters::wave_speeds

Wave speeds estimation method.

◆ web

real(wp) m_global_parameters::web

Weber number.

◆ weight

real(wp), dimension(:), allocatable m_global_parameters::weight

Simpson quadrature weights.

◆ weno_avg

logical m_global_parameters::weno_avg

◆ weno_eps

real(wp) m_global_parameters::weno_eps

Binding for the WENO nonlinear weights.

◆ weno_num_stencils

integer m_global_parameters::weno_num_stencils

Number of stencils for WENO reconstruction (only different from weno_polyn for TENO(>5))

◆ weno_order

integer m_global_parameters::weno_order

Order of the WENO reconstruction.

◆ weno_polyn

integer m_global_parameters::weno_polyn

Degree of the WENO polynomials (polyn)

◆ weno_re_flux

logical m_global_parameters::weno_re_flux

WENO reconstruct velocity gradients for viscous stress tensor.

◆ wenojs

logical m_global_parameters::wenojs

WENO-JS (default)

◆ wenoz

logical m_global_parameters::wenoz

WENO-Z.

◆ wenoz_q

real(wp) m_global_parameters::wenoz_q

Power constant for WENO-Z.

◆ x_a

real(wp) m_global_parameters::x_a

◆ x_b

real(wp) m_global_parameters::x_b

◆ x_cb

real(wp), dimension(:), allocatable, target m_global_parameters::x_cb

◆ x_cc

real(wp), dimension(:), allocatable, target m_global_parameters::x_cc

◆ x_domain

type(bounds_info) m_global_parameters::x_domain

◆ xi_idx

type(int_bounds_info) m_global_parameters::xi_idx

Indexes of first and last reference map eqns.

◆ xibeg

integer m_global_parameters::xibeg

◆ xiend

integer m_global_parameters::xiend

◆ y_a

real(wp) m_global_parameters::y_a

◆ y_b

real(wp) m_global_parameters::y_b

◆ y_cb

real(wp), dimension(:), allocatable, target m_global_parameters::y_cb

◆ y_cc

real(wp), dimension(:), allocatable, target m_global_parameters::y_cc

◆ y_domain

type(bounds_info) m_global_parameters::y_domain

◆ z_a

real(wp) m_global_parameters::z_a

◆ z_b

real(wp) m_global_parameters::z_b

◆ z_cb

real(wp), dimension(:), allocatable, target m_global_parameters::z_cb

◆ z_cc

real(wp), dimension(:), allocatable, target m_global_parameters::z_cc

◆ z_domain

type(bounds_info) m_global_parameters::z_domain