Loading [MathJax]/extensions/tex2jax.js
MFC: Post-Process
High-fidelity multiphase flow simulation
All Classes Namespaces Files Functions Variables Pages
m_global_parameters Module Reference

This module contains all of the parameters characterizing the computational domain, simulation algorithm, stiffened equation of state and finally, the formatted database file(s) structure. More...

Functions/Subroutines

subroutine s_assign_default_values_to_user_inputs
 Assigns default values to user inputs prior to reading them in. This allows for an easier consistency check of these parameters once they are read from the input file.
 
subroutine s_initialize_global_parameters_module
 Computation of parameters, allocation procedures, and/or any other tasks needed to properly setup the module.
 
subroutine s_initialize_parallel_io
 Subroutine to initialize parallel infrastructure.
 
subroutine s_finalize_global_parameters_module
 Deallocation procedures for the module.
 

Variables

integer proc_rank
 Rank of the local processor.
 
integer(8) nglobal
 
integer num_dims
 Number of spatial dimensions.
 
integer num_vels
 Number of velocity components (different from num_dims for mhd)
 
integer buff_size
 Number of cells in buffer region. For the variables which feature a buffer region, this region is used to store information outside the computational domain based on the boundary conditions.
 
integer t_step_start
 First time-step directory.
 
integer t_step_stop
 Last time-step directory.
 
integer t_step_save
 Interval between consecutive time-step directory.
 
integer avg_state
 Average state evaluation method.
 
type(int_bounds_info), dimension(1:3) idwint
 
type(int_bounds_info), dimension(1:3) idwbuff
 
logical parallel_io
 Format of the data files.
 
logical sim_data
 
logical file_per_process
 output format
 
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.
 
integer num_ibs
 Number of immersed boundaries.
 
type(mpi_io_var), public mpi_io_data
 
type(mpi_io_ib_var), public mpi_io_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_lg_bubbles
 
integer, private ierr
 
type(physical_parameters), dimension(num_fluids_max) 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.
 
real(wp), dimension(:), allocatable adv
 Advection variables.
 
integer format
 Format of the database file(s)
 
integer precision
 Floating point precision of the database file(s)
 
logical output_partial_domain
 Specify portion of domain to output for post-processing.
 
type(bounds_infox_output
 
type(bounds_infoy_output
 
type(bounds_infoz_output
 Portion of domain to output for post-processing.
 
type(int_bounds_infox_output_idx
 
type(int_bounds_infoy_output_idx
 
type(int_bounds_infoz_output_idx
 Indices of domain to output for post-processing.
 
real(wp), dimension(num_fluids_max) schlieren_alpha
 Amplitude coefficients of the numerical Schlieren function that are used to adjust the intensity of numerical Schlieren renderings for individual fluids. This enables waves and interfaces of varying strengths and in all of the fluids to be made simultaneously visible on a single plot.
 
integer fd_order
 The order of the finite-difference (fd) approximations of the first-order derivatives that need to be evaluated when vorticity and/or the numerical Schlieren function are to be outputted to the formatted database file(s).
 
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.
 
real(wp) bx0
 Constant magnetic field in the x-direction (1D)
 
Logistics
integer num_procs
 Number of processors.
 
character(len=path_len) case_dir
 Case folder location.
 
Number of cells in the x-, y- and z-coordinate directions
integer m
 
integer m_root
 
integer n
 
integer p
 
Cylindrical coordinates (either axisymmetric or full 3D)
logical cyl_coord
 
integer grid_geometry
 
Global number of cells in each direction
integer m_glb
 
integer n_glb
 
integer p_glb
 
Cell-boundary locations in the x-, y- and z-coordinate directions
real(wp), dimension(:), allocatable x_cb
 
real(wp), dimension(:), allocatable x_root_cb
 
real(wp), dimension(:), allocatable y_cb
 
real(wp), dimension(:), allocatable z_cb
 
real(wp), dimension(:), allocatable x_cb_s
 
real(wp), dimension(:), allocatable y_cb_s
 
real(wp), dimension(:), allocatable z_cb_s
 
Cell-center locations in the x-, y- and z-coordinate directions
real(wp), dimension(:), allocatable x_cc
 
real(wp), dimension(:), allocatable x_root_cc
 
real(wp), dimension(:), allocatable y_cc
 
real(wp), dimension(:), allocatable z_cc
 
real(sp), dimension(:), allocatable x_root_cc_s
 
real(sp), dimension(:), allocatable x_cc_s
 
real(wp), dimension(:), allocatable dx
 Cell-width distributions in the x-, y- and z-coordinate directions.
 
real(wp), dimension(:), allocatable dy
 
real(wp), dimension(:), allocatable dz
 
IO options for adaptive time-stepping
logical cfl_adap_dt
 
logical cfl_const_dt
 
logical cfl_dt
 
real(wp) t_save
 
real(wp) t_stop
 
real(wp) cfl_target
 
integer n_save
 
integer n_start
 
Simulation Algorithm Parameters
integer model_eqns
 Multicomponent flow model.
 
integer num_fluids
 Number of different fluids present in the flow.
 
logical relax
 phase change
 
integer relax_model
 Phase change relaxation model.
 
logical mpp_lim
 Maximum volume fraction limiter.
 
integer sys_size
 Number of unknowns in the system of equations.
 
integer weno_order
 Order of accuracy for the WENO reconstruction.
 
logical mixture_err
 Mixture error limiter.
 
logical alt_soundspeed
 Alternate sound speed.
 
logical mhd
 Magnetohydrodynamics.
 
logical relativity
 Relativity for RMHD.
 
logical hypoelasticity
 Turn hypoelasticity on.
 
logical hyperelasticity
 Turn hyperelasticity on.
 
logical elasticity
 elasticity modeling, true for hyper or hypo
 
integer b_size
 Number of components in the b tensor.
 
integer tensor_size
 Number of components in the nonsymmetric tensor.
 
logical, parameter chemistry = .False.
 Chemistry modeling.
 
Annotations of the structure, i.e. the organization, of the state vectors
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 gamma_idx
 Index of specific heat ratio func. eqn.
 
integer alf_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
 Indices of elastic stresses.
 
type(int_bounds_infoxi_idx
 Indexes of first and last reference map eqns.
 
integer c_idx
 Index of color function.
 
type(int_bounds_infospecies_idx
 Indexes of first & last concentration eqns.
 
Boundary conditions in the x-, y- and z-coordinate directions
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_len) mpiiofs
 
integer mpi_info_int
 
Size of the ghost zone layer in the x-, y- and z-coordinate directions.

The definition of the ghost zone layers is only necessary when using the Silo database file format in multidimensions. These zones provide VisIt with the subdomain connectivity information that it requires in order to produce smooth plots.

type(int_bounds_infooffset_x
 
type(int_bounds_infooffset_y
 
type(int_bounds_infooffset_z
 
The list of all possible flow variables that may be written to a database

file. It includes partial densities, density, momentum, velocity, energy, pressure, volume fraction(s), specific heat ratio function, specific heat ratio, liquid stiffness function, liquid stiffness, primitive variables, conservative variables, speed of sound, the vorticity, and the numerical Schlieren function.

logical, dimension(num_fluids_max) alpha_rho_wrt
 
logical rho_wrt
 
logical, dimension(3) mom_wrt
 
logical, dimension(3) vel_wrt
 
integer flux_lim
 
logical, dimension(3) flux_wrt
 
logical e_wrt
 
logical pres_wrt
 
logical, dimension(num_fluids_max) alpha_wrt
 
logical gamma_wrt
 
logical heat_ratio_wrt
 
logical pi_inf_wrt
 
logical pres_inf_wrt
 
logical prim_vars_wrt
 
logical cons_vars_wrt
 
logical c_wrt
 
logical, dimension(3) omega_wrt
 
logical qm_wrt
 
logical schlieren_wrt
 
logical cf_wrt
 
logical ib
 
logical, dimension(1:num_species) chem_wrt_y
 
logical chem_wrt_t
 
Reference parameters for Tait EOS
real(wp) rhoref
 
real(wp) pref
 
Bubble modeling variables and parameters
integer nb
 
real(wp) r0ref
 
real(wp) ca
 
real(wp) web
 
real(wp) re_inv
 
real(wp), dimension(:), allocatable weight
 
real(wp), dimension(:), allocatable r0
 
real(wp), dimension(:), allocatable v0
 
logical bubbles_euler
 
logical qbmm
 
logical polytropic
 
logical polydisperse
 
logical adv_n
 
integer thermal
 1 = adiabatic, 2 = isotherm, 3 = transfer
 
real(wp) r_n
 
real(wp) r_v
 
real(wp) phi_vn
 
real(wp) phi_nv
 
real(wp) pe_c
 
real(wp) tw
 
real(wp) g
 
real(wp) pv
 
real(wp) m_n
 
real(wp) m_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(wp) mul0
 
real(wp) ss
 
real(wp) gamma_v
 
real(wp) mu_v
 
real(wp) gamma_m
 
real(wp) gamma_n
 
real(wp) mu_n
 
real(wp) poly_sigma
 
real(wp) sigr
 
integer nmom
 
surface tension coefficient
real(wp) sigma
 
logical surface_tension
 
Index variables used for m_variables_conversion

#}

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 xibeg
 
integer xiend
 
integer chemxb
 
integer chemxe
 
Lagrangian bubbles
logical bubbles_lagrange
 
logical rkck_adap_dt
 

Detailed Description

This module contains all of the parameters characterizing the computational domain, simulation algorithm, stiffened equation of state and finally, the formatted database file(s) structure.

Function/Subroutine Documentation

◆ s_assign_default_values_to_user_inputs()

subroutine m_global_parameters::s_assign_default_values_to_user_inputs

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

Here is the caller graph for this function:

◆ s_finalize_global_parameters_module()

subroutine m_global_parameters::s_finalize_global_parameters_module

Deallocation procedures for the module.

Here is the caller graph for this function:

◆ s_initialize_global_parameters_module()

subroutine m_global_parameters::s_initialize_global_parameters_module

Computation of parameters, allocation procedures, and/or any other tasks needed to properly setup the module.

Here is the caller graph for this function:

◆ s_initialize_parallel_io()

subroutine m_global_parameters::s_initialize_parallel_io

Subroutine to initialize parallel infrastructure.

Here is the caller graph for this function:

Variable Documentation

◆ adv

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

Advection variables.

◆ 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

◆ advxb

integer m_global_parameters::advxb

◆ advxe

integer m_global_parameters::advxe

◆ alf_idx

integer m_global_parameters::alf_idx

Index of specific heat ratio func. eqn.

◆ alpha_rho_wrt

logical, dimension(num_fluids_max) m_global_parameters::alpha_rho_wrt

◆ alpha_wrt

logical, dimension(num_fluids_max) m_global_parameters::alpha_wrt

◆ alt_soundspeed

logical m_global_parameters::alt_soundspeed

Alternate 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 components in the b tensor.

◆ 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

◆ bub_idx

type(bub_bounds_info) m_global_parameters::bub_idx

Indexes of first & last bubble variable eqns.

◆ bubbles_euler

logical m_global_parameters::bubbles_euler

◆ bubbles_lagrange

logical m_global_parameters::bubbles_lagrange

◆ bubxb

integer m_global_parameters::bubxb

◆ bubxe

integer m_global_parameters::bubxe

◆ buff_size

integer m_global_parameters::buff_size

Number of cells in buffer region. For the variables which feature a buffer region, this region is used to store information outside the computational domain based on the boundary conditions.

◆ 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.

◆ c_wrt

logical m_global_parameters::c_wrt

◆ ca

real(wp) m_global_parameters::ca

◆ case_dir

character(len=path_len) m_global_parameters::case_dir

Case folder location.

◆ cf_wrt

logical m_global_parameters::cf_wrt

◆ 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_wrt_t

logical m_global_parameters::chem_wrt_t

◆ chem_wrt_y

logical, dimension(1:num_species) m_global_parameters::chem_wrt_y

◆ chemistry

logical, parameter m_global_parameters::chemistry = .False.

Chemistry modeling.

◆ chemxb

integer m_global_parameters::chemxb

◆ chemxe

integer m_global_parameters::chemxe

◆ cons_vars_wrt

logical m_global_parameters::cons_vars_wrt

◆ 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

◆ cyl_coord

logical m_global_parameters::cyl_coord

◆ dx

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

Cell-width distributions in the x-, y- and z-coordinate directions.

◆ dy

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

◆ dz

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

◆ e_idx

integer m_global_parameters::e_idx

Index of energy equation.

◆ e_wrt

logical m_global_parameters::e_wrt

◆ 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 vorticity and/or the numerical Schlieren function are to be outputted to the formatted database file(s).

◆ file_per_process

logical m_global_parameters::file_per_process

output format

◆ 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.

◆ flux_lim

integer m_global_parameters::flux_lim

◆ flux_wrt

logical, dimension(3) m_global_parameters::flux_wrt

◆ format

integer m_global_parameters::format

Format of the database file(s)

◆ g

real(wp) m_global_parameters::g

◆ 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

◆ gamma_wrt

logical m_global_parameters::gamma_wrt

◆ grid_geometry

integer m_global_parameters::grid_geometry

◆ heat_ratio_wrt

logical m_global_parameters::heat_ratio_wrt

◆ hyperelasticity

logical m_global_parameters::hyperelasticity

Turn hyperelasticity on.

◆ hypoelasticity

logical m_global_parameters::hypoelasticity

Turn hypoelasticity on.

◆ ib

logical m_global_parameters::ib

◆ idwbuff

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

◆ idwint

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

◆ ierr

integer, private m_global_parameters::ierr
private

◆ 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

◆ 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_v

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

◆ m

integer m_global_parameters::m

◆ m_glb

integer m_global_parameters::m_glb

◆ m_n

real(wp) m_global_parameters::m_n

◆ m_root

integer m_global_parameters::m_root

◆ m_v

real(wp) m_global_parameters::m_v

◆ 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 error limiter.

◆ model_eqns

integer m_global_parameters::model_eqns

Multicomponent flow model.

◆ mom_idx

type(int_bounds_info) m_global_parameters::mom_idx

Indexes of first & last momentum eqns.

◆ mom_wrt

logical, dimension(3) m_global_parameters::mom_wrt

◆ momxb

integer m_global_parameters::momxb

◆ momxe

integer m_global_parameters::momxe

◆ mpi_info_int

integer m_global_parameters::mpi_info_int

◆ mpi_io_data

type(mpi_io_var), public m_global_parameters::mpi_io_data

◆ mpi_io_data_lg_bubbles

real(wp), dimension(:, :), allocatable, public m_global_parameters::mpi_io_data_lg_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

Maximum volume fraction limiter.

◆ 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

◆ 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_save

integer m_global_parameters::n_save

◆ n_start

integer m_global_parameters::n_start

◆ nb

integer m_global_parameters::nb

◆ nglobal

integer(8) m_global_parameters::nglobal

◆ nmom

integer m_global_parameters::nmom

◆ num_dims

integer m_global_parameters::num_dims

Number of spatial dimensions.

◆ num_fluids

integer m_global_parameters::num_fluids

Number of different fluids present in the flow.

◆ num_ibs

integer m_global_parameters::num_ibs

Number of immersed boundaries.

◆ num_procs

integer m_global_parameters::num_procs

Number of processors.

◆ num_vels

integer m_global_parameters::num_vels

Number of velocity components (different from num_dims for mhd)

◆ offset_x

type(int_bounds_info) m_global_parameters::offset_x

◆ offset_y

type(int_bounds_info) m_global_parameters::offset_y

◆ offset_z

type(int_bounds_info) m_global_parameters::offset_z

◆ omega_wrt

logical, dimension(3) m_global_parameters::omega_wrt

◆ omegan

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

◆ output_partial_domain

logical m_global_parameters::output_partial_domain

Specify portion of domain to output for post-processing.

◆ p

integer m_global_parameters::p

◆ p_glb

integer m_global_parameters::p_glb

◆ parallel_io

logical m_global_parameters::parallel_io

Format of the data files.

◆ pb0

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

◆ 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_inf_idx

integer m_global_parameters::pi_inf_idx

Index of liquid stiffness func. eqn.

◆ pi_inf_wrt

logical m_global_parameters::pi_inf_wrt

◆ poly_sigma

real(wp) m_global_parameters::poly_sigma

◆ polydisperse

logical m_global_parameters::polydisperse

◆ polytropic

logical m_global_parameters::polytropic

◆ precision

integer m_global_parameters::precision

Floating point precision of the database file(s)

◆ pref

real(wp) m_global_parameters::pref

◆ pres_inf_wrt

logical m_global_parameters::pres_inf_wrt

◆ pres_wrt

logical m_global_parameters::pres_wrt

◆ prim_vars_wrt

logical m_global_parameters::prim_vars_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.

◆ pv

real(wp) m_global_parameters::pv

◆ qbmm

logical m_global_parameters::qbmm

◆ qm_wrt

logical m_global_parameters::qm_wrt

◆ r0

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

◆ r0ref

real(wp) m_global_parameters::r0ref

◆ r_n

real(wp) m_global_parameters::r_n

◆ r_v

real(wp) m_global_parameters::r_v

◆ re_inv

real(wp) m_global_parameters::re_inv

◆ 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

◆ relativity

logical m_global_parameters::relativity

Relativity for RMHD.

◆ relax

logical m_global_parameters::relax

phase change

◆ relax_model

integer m_global_parameters::relax_model

Phase change relaxation model.

◆ rho_wrt

logical m_global_parameters::rho_wrt

◆ rhoref

real(wp) m_global_parameters::rhoref

◆ rkck_adap_dt

logical m_global_parameters::rkck_adap_dt

◆ schlieren_alpha

real(wp), dimension(num_fluids_max) m_global_parameters::schlieren_alpha

Amplitude coefficients of the numerical Schlieren function that are used to adjust the intensity of numerical Schlieren renderings for individual fluids. This enables waves and interfaces of varying strengths and in all of the fluids to be made simultaneously visible on a single plot.

◆ schlieren_wrt

logical m_global_parameters::schlieren_wrt

◆ sigma

real(wp) m_global_parameters::sigma

◆ sigr

real(wp) m_global_parameters::sigr

◆ sim_data

logical m_global_parameters::sim_data

◆ 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

Indices of elastic stresses.

◆ 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 the system of equations.

◆ t_save

real(wp) m_global_parameters::t_save

◆ t_step_save

integer m_global_parameters::t_step_save

Interval between consecutive time-step directory.

◆ t_step_start

integer m_global_parameters::t_step_start

First time-step directory.

◆ t_step_stop

integer m_global_parameters::t_step_stop

Last time-step directory.

◆ t_stop

real(wp) m_global_parameters::t_stop

◆ tensor_size

integer m_global_parameters::tensor_size

Number of components in the nonsymmetric tensor.

◆ thermal

integer m_global_parameters::thermal

1 = adiabatic, 2 = isotherm, 3 = transfer

◆ tw

real(wp) m_global_parameters::tw

◆ v0

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

◆ vel_wrt

logical, dimension(3) m_global_parameters::vel_wrt

◆ web

real(wp) m_global_parameters::web

◆ weight

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

◆ weno_order

integer m_global_parameters::weno_order

Order of accuracy for the WENO reconstruction.

◆ x_cb

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

◆ x_cb_s

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

◆ x_cc

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

◆ x_cc_s

real(sp), dimension(:), allocatable m_global_parameters::x_cc_s

◆ x_output

type(bounds_info) m_global_parameters::x_output

◆ x_output_idx

type(int_bounds_info) m_global_parameters::x_output_idx

◆ x_root_cb

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

◆ x_root_cc

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

◆ x_root_cc_s

real(sp), dimension(:), allocatable m_global_parameters::x_root_cc_s

◆ 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_cb

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

◆ y_cb_s

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

◆ y_cc

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

◆ y_output

type(bounds_info) m_global_parameters::y_output

◆ y_output_idx

type(int_bounds_info) m_global_parameters::y_output_idx

◆ z_cb

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

◆ z_cb_s

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

◆ z_cc

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

◆ z_output

type(bounds_info) m_global_parameters::z_output

Portion of domain to output for post-processing.

◆ z_output_idx

type(int_bounds_info) m_global_parameters::z_output_idx

Indices of domain to output for post-processing.