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

This module contains all of the parameters characterizing the computational domain, simulation algorithm, initial condition and the stiffened equation of state. 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 s_finalize_global_parameters_module ()
 

Variables

integer num_procs
 Number of processors.
 
character(len=path_len) case_dir
 Case folder location.
 
logical old_grid
 Use existing grid data.
 
logical old_ic
 Use existing IC data.
 
integer t_step_old
 
integer t_step_start
 Existing IC/grid folder.
 
integer proc_rank
 Rank of the local processor.
 
integer m
 
integer n
 
integer p
 Number of cells in the x-, y- and z-coordinate directions.
 
integer(8) nglobal
 
integer m_glb
 
integer n_glb
 
integer p_glb
 Global number of cells in each direction.
 
integer num_dims
 Number of spatial dimensions.
 
logical cyl_coord
 
integer grid_geometry
 Cylindrical coordinates (either axisymmetric or full 3D)
 
real(kind(0d0)), dimension(:), allocatable x_cc
 
real(kind(0d0)), dimension(:), allocatable y_cc
 
real(kind(0d0)), dimension(:), allocatable z_cc
 Locations of cell-centers (cc) in x-, y- and z-directions, respectively.
 
real(kind(0d0)), dimension(:), allocatable x_cb
 
real(kind(0d0)), dimension(:), allocatable y_cb
 
real(kind(0d0)), dimension(:), allocatable z_cb
 Locations of cell-boundaries (cb) in x-, y- and z-directions, respectively.
 
real(kind(0d0)) dx
 
real(kind(0d0)) dy
 
real(kind(0d0)) dz
 Minimum cell-widths in the x-, y- and z-coordinate directions.
 
type(bounds_infox_domain
 
type(bounds_infoy_domain
 
type(bounds_infoz_domain
 Locations of the domain bounds in the x-, y- and z-coordinate directions.
 
logical stretch_x
 
logical stretch_y
 
logical stretch_z
 Grid stretching flags for the x-, y- and z-coordinate directions.
 
real(kind(0d0)) a_x
 
real(kind(0d0)) a_y
 
real(kind(0d0)) a_z
 
integer loops_x
 
integer loops_y
 
integer loops_z
 
real(kind(0d0)) x_a
 
real(kind(0d0)) y_a
 
real(kind(0d0)) z_a
 
real(kind(0d0)) x_b
 
real(kind(0d0)) y_b
 
real(kind(0d0)) z_b
 
integer model_eqns
 Multicomponent flow model.
 
logical relax
 activate phase change
 
integer relax_model
 Relax Model.
 
real(kind(0d0)) palpha_eps
 trigger parameter for the p relaxation procedure, phase change model
 
real(kind(0d0)) ptgalpha_eps
 trigger parameter for the pTg relaxation procedure, phase change model
 
integer num_fluids
 Number of different fluids present in the flow.
 
logical adv_alphan
 Advection of the last volume fraction.
 
logical mpp_lim
 Alpha limiter.
 
integer sys_size
 Number of unknowns in the system of equations.
 
integer weno_order
 Order of accuracy for the WENO reconstruction.
 
logical hypoelasticity
 activate hypoelasticity
 
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 total energy equation.
 
integer alf_idx
 Index of void fraction.
 
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 pi_inf_idx
 Index of liquid stiffness func. eqn.
 
type(int_bounds_infostress_idx
 Indexes of elastic shear stress eqns.
 
type(int_bounds_infobc_x
 
type(int_bounds_infobc_y
 
type(int_bounds_infobc_z
 Boundary conditions in the x-, y- and z-coordinate directions.
 
logical parallel_io
 Format of the data files.
 
logical file_per_process
 type of data output
 
integer precision
 Precision of output files.
 
logical vel_profile
 Set hyperbolic tangent streamwise velocity profile.
 
logical instability_wave
 Superimpose instability waves to surrounding fluid flow.
 
real(kind(0d0)) pi_fac
 Factor for artificial pi_inf.
 
logical perturb_flow
 
integer perturb_flow_fluid
 Fluid to be perturbed with perturb_flow flag.
 
real(kind(0d0)) perturb_flow_mag
 Magnitude of perturbation with perturb_flow flag.
 
logical perturb_sph
 
integer perturb_sph_fluid
 Fluid to be perturbed with perturb_sph flag.
 
real(kind(0d0)), dimension(num_fluids_max) fluid_rho
 
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
 
character(len=name_len) mpiiofs
 
integer mpi_info_int
 MPI info for parallel IO with Lustre file systems.
 
integer, private ierr
 
integer num_patches
 Number of patches composing initial condition.
 
type(ic_patch_parameters), dimension(num_patches_max) patch_icpp
 Database of the initial condition patch parameters (icpp) for each of the patches employed in the configuration of the initial condition. Note that the maximum allowable number of patches, num_patches_max, may be changed in the module m_derived_types.f90.
 
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(kind(0d0)) rhoref
 
real(kind(0d0)) pref
 Reference parameters for Tait EOS.
 
integer, dimension(:, :, :), allocatable logic_grid
 
type(pres_fieldpb
 
type(pres_fieldmv
 
Bubble modeling
integer nb
 
real(kind(0d0)) r0ref
 
real(kind(0d0)) ca
 
real(kind(0d0)) web
 
real(kind(0d0)) re_inv
 
real(kind(0d0)), dimension(:), allocatable weight
 
real(kind(0d0)), dimension(:), allocatable r0
 
real(kind(0d0)), dimension(:), allocatable v0
 
logical bubbles
 
logical qbmm
 Quadrature moment method.
 
integer nmom
 Number of carried moments.
 
real(kind(0d0)) sigr
 
real(kind(0d0)) sigv
 
real(kind(0d0)) rhorv
 standard deviations in R/V
 
logical adv_n
 Solve the number density equation and compute alpha from number density.
 
Immersed Boundaries
logical ib
 Turn immersed boundaries on.
 
integer num_ibs
 Number of immersed boundaries.
 
integer np
 
type(ib_patch_parameters), dimension(num_patches_max) patch_ib
 
type(probe_parameters), dimension(:), allocatable airfoil_grid_u
 
type(probe_parameters), dimension(:), allocatable airfoil_grid_l
 
Non-polytropic bubble gas compression
logical polytropic
 
logical polydisperse
 
integer thermal
 
real(kind(0d0)) r_n
 
real(kind(0d0)) r_v
 
real(kind(0d0)) phi_vn
 
real(kind(0d0)) phi_nv
 
real(kind(0d0)) pe_c
 
real(kind(0d0)) tw
 
real(kind(0d0)) pv
 
real(kind(0d0)) m_n
 
real(kind(0d0)) m_v
 
real(kind(0d0)), dimension(:), allocatable k_n
 
real(kind(0d0)), dimension(:), allocatable k_v
 
real(kind(0d0)), dimension(:), allocatable pb0
 
real(kind(0d0)), dimension(:), allocatable mass_n0
 
real(kind(0d0)), dimension(:), allocatable mass_v0
 
real(kind(0d0)), dimension(:), allocatable pe_t
 
real(kind(0d0)), dimension(:), allocatable re_trans_t
 
real(kind(0d0)), dimension(:), allocatable re_trans_c
 
real(kind(0d0)), dimension(:), allocatable im_trans_t
 
real(kind(0d0)), dimension(:), allocatable im_trans_c
 
real(kind(0d0)), dimension(:), allocatable omegan
 
real(kind(0d0)) mul0
 
real(kind(0d0)) ss
 
real(kind(0d0)) gamma_v
 
real(kind(0d0)) mu_v
 
real(kind(0d0)) gamma_m
 
real(kind(0d0)) gamma_n
 
real(kind(0d0)) mu_n
 
real(kind(0d0)) poly_sigma
 
integer dist_type
 
integer r0_type
 
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
 

Detailed Description

This module contains all of the parameters characterizing the computational domain, simulation algorithm, initial condition and the stiffened equation of state.

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
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
Here is the caller graph for this function:

Variable Documentation

◆ a_x

real(kind(0d0)) m_global_parameters::a_x

◆ a_y

real(kind(0d0)) m_global_parameters::a_y

◆ a_z

real(kind(0d0)) m_global_parameters::a_z

◆ adv_alphan

logical m_global_parameters::adv_alphan

Advection of the last volume fraction.

◆ 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(probe_parameters), dimension(:), allocatable m_global_parameters::airfoil_grid_l

◆ airfoil_grid_u

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

◆ alf_idx

integer m_global_parameters::alf_idx

Index of void fraction.

◆ 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

Boundary conditions in the x-, y- and z-coordinate directions.

◆ bub_idx

type(bub_bounds_info) m_global_parameters::bub_idx

Indexes of first & last bubble variable eqns.

◆ bubbles

logical m_global_parameters::bubbles

◆ bubxb

integer m_global_parameters::bubxb

◆ bubxe

integer m_global_parameters::bubxe

◆ ca

real(kind(0d0)) m_global_parameters::ca

◆ case_dir

character(len=path_len) m_global_parameters::case_dir

Case folder location.

◆ 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

◆ dist_type

integer m_global_parameters::dist_type

◆ dx

real(kind(0d0)) m_global_parameters::dx

◆ dy

real(kind(0d0)) m_global_parameters::dy

◆ dz

real(kind(0d0)) m_global_parameters::dz

Minimum cell-widths in the x-, y- and z-coordinate directions.

◆ e_idx

integer m_global_parameters::e_idx

Index of total energy equation.

◆ file_per_process

logical m_global_parameters::file_per_process

type of data output

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

◆ fluid_rho

real(kind(0d0)), dimension(num_fluids_max) m_global_parameters::fluid_rho

◆ gamma_idx

integer m_global_parameters::gamma_idx

Index of specific heat ratio func. eqn.

◆ gamma_m

real(kind(0d0)) m_global_parameters::gamma_m

◆ gamma_n

real(kind(0d0)) m_global_parameters::gamma_n

◆ gamma_v

real(kind(0d0)) m_global_parameters::gamma_v

◆ grid_geometry

integer m_global_parameters::grid_geometry

Cylindrical coordinates (either axisymmetric or full 3D)

◆ hypoelasticity

logical m_global_parameters::hypoelasticity

activate hypoelasticity

◆ ib

logical m_global_parameters::ib

Turn immersed boundaries on.

◆ ierr

integer, private m_global_parameters::ierr
private

◆ im_trans_c

real(kind(0d0)), dimension(:), allocatable m_global_parameters::im_trans_c

◆ im_trans_t

real(kind(0d0)), dimension(:), allocatable m_global_parameters::im_trans_t

◆ instability_wave

logical m_global_parameters::instability_wave

Superimpose instability waves to surrounding fluid flow.

◆ 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(kind(0d0)), dimension(:), allocatable m_global_parameters::k_n

◆ k_v

real(kind(0d0)), dimension(:), allocatable m_global_parameters::k_v

◆ logic_grid

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

◆ loops_x

integer m_global_parameters::loops_x

◆ loops_y

integer m_global_parameters::loops_y

◆ loops_z

integer m_global_parameters::loops_z

◆ m

integer m_global_parameters::m

◆ m_glb

integer m_global_parameters::m_glb

◆ m_n

real(kind(0d0)) m_global_parameters::m_n

◆ m_v

real(kind(0d0)) m_global_parameters::m_v

◆ mass_n0

real(kind(0d0)), dimension(:), allocatable m_global_parameters::mass_n0

◆ mass_v0

real(kind(0d0)), dimension(:), allocatable m_global_parameters::mass_v0

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

◆ momxb

integer m_global_parameters::momxb

◆ momxe

integer m_global_parameters::momxe

◆ mpi_info_int

integer m_global_parameters::mpi_info_int

MPI info for parallel IO with Lustre file systems.

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

type(mpi_io_ib_var), public m_global_parameters::mpi_io_ib_data

◆ mpiiofs

character(len=name_len) m_global_parameters::mpiiofs

◆ mpp_lim

logical m_global_parameters::mpp_lim

Alpha limiter.

◆ mu_n

real(kind(0d0)) m_global_parameters::mu_n

◆ mu_v

real(kind(0d0)) m_global_parameters::mu_v

◆ mul0

real(kind(0d0)) m_global_parameters::mul0

◆ mv

type(pres_field) m_global_parameters::mv

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

◆ nb

integer m_global_parameters::nb

◆ nglobal

integer(8) m_global_parameters::nglobal

◆ nmom

integer m_global_parameters::nmom

Number of carried moments.

◆ np

integer m_global_parameters::np

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

integer m_global_parameters::num_patches

Number of patches composing initial condition.

◆ num_procs

integer m_global_parameters::num_procs

Number of processors.

◆ old_grid

logical m_global_parameters::old_grid

Use existing grid data.

◆ old_ic

logical m_global_parameters::old_ic

Use existing IC data.

◆ omegan

real(kind(0d0)), dimension(:), allocatable m_global_parameters::omegan

◆ p

integer m_global_parameters::p

Number of cells in the x-, y- and z-coordinate directions.

◆ p_glb

integer m_global_parameters::p_glb

Global number of cells in each direction.

◆ palpha_eps

real(kind(0d0)) 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

◆ patch_icpp

type(ic_patch_parameters), dimension(num_patches_max) m_global_parameters::patch_icpp

Database of the initial condition patch parameters (icpp) for each of the patches employed in the configuration of the initial condition. Note that the maximum allowable number of patches, num_patches_max, may be changed in the module m_derived_types.f90.

◆ pb

type(pres_field) m_global_parameters::pb

◆ pb0

real(kind(0d0)), dimension(:), allocatable m_global_parameters::pb0

◆ pe_c

real(kind(0d0)) m_global_parameters::pe_c

◆ pe_t

real(kind(0d0)), dimension(:), allocatable m_global_parameters::pe_t

◆ perturb_flow

logical m_global_parameters::perturb_flow

◆ perturb_flow_fluid

integer m_global_parameters::perturb_flow_fluid

Fluid to be perturbed with perturb_flow flag.

◆ perturb_flow_mag

real(kind(0d0)) m_global_parameters::perturb_flow_mag

Magnitude of perturbation with perturb_flow flag.

◆ perturb_sph

logical m_global_parameters::perturb_sph

◆ perturb_sph_fluid

integer m_global_parameters::perturb_sph_fluid

Fluid to be perturbed with perturb_sph flag.

◆ phi_nv

real(kind(0d0)) m_global_parameters::phi_nv

◆ phi_vn

real(kind(0d0)) m_global_parameters::phi_vn

◆ pi_fac

real(kind(0d0)) 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.

◆ poly_sigma

real(kind(0d0)) m_global_parameters::poly_sigma

◆ polydisperse

logical m_global_parameters::polydisperse

◆ polytropic

logical m_global_parameters::polytropic

◆ precision

integer m_global_parameters::precision

Precision of output files.

◆ pref

real(kind(0d0)) m_global_parameters::pref

Reference parameters for Tait EOS.

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

◆ ptgalpha_eps

real(kind(0d0)) m_global_parameters::ptgalpha_eps

trigger parameter for the pTg relaxation procedure, phase change model

◆ pv

real(kind(0d0)) m_global_parameters::pv

◆ qbmm

logical m_global_parameters::qbmm

Quadrature moment method.

◆ r0

real(kind(0d0)), dimension(:), allocatable m_global_parameters::r0

◆ r0_type

integer m_global_parameters::r0_type

◆ r0ref

real(kind(0d0)) m_global_parameters::r0ref

◆ r_n

real(kind(0d0)) m_global_parameters::r_n

◆ r_v

real(kind(0d0)) m_global_parameters::r_v

◆ re_inv

real(kind(0d0)) m_global_parameters::re_inv

◆ re_trans_c

real(kind(0d0)), dimension(:), allocatable m_global_parameters::re_trans_c

◆ re_trans_t

real(kind(0d0)), dimension(:), allocatable m_global_parameters::re_trans_t

◆ relax

logical m_global_parameters::relax

activate phase change

◆ relax_model

integer m_global_parameters::relax_model

Relax Model.

◆ rhoref

real(kind(0d0)) m_global_parameters::rhoref

◆ rhorv

real(kind(0d0)) m_global_parameters::rhorv

standard deviations in R/V

◆ sigr

real(kind(0d0)) m_global_parameters::sigr

◆ sigv

real(kind(0d0)) m_global_parameters::sigv

◆ ss

real(kind(0d0)) 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 elastic shear stress eqns.

◆ stretch_x

logical m_global_parameters::stretch_x

◆ stretch_y

logical m_global_parameters::stretch_y

◆ stretch_z

logical m_global_parameters::stretch_z

Grid stretching flags for the x-, y- and z-coordinate directions.

◆ strxb

integer m_global_parameters::strxb

◆ strxe

integer m_global_parameters::strxe

◆ sys_size

integer m_global_parameters::sys_size

Number of unknowns in the system of equations.

◆ t_step_old

integer m_global_parameters::t_step_old

◆ t_step_start

integer m_global_parameters::t_step_start

Existing IC/grid folder.

◆ thermal

integer m_global_parameters::thermal

◆ tw

real(kind(0d0)) m_global_parameters::tw

◆ v0

real(kind(0d0)), dimension(:), allocatable m_global_parameters::v0

◆ vel_profile

logical m_global_parameters::vel_profile

Set hyperbolic tangent streamwise velocity profile.

◆ web

real(kind(0d0)) m_global_parameters::web

◆ weight

real(kind(0d0)), dimension(:), allocatable m_global_parameters::weight

◆ weno_order

integer m_global_parameters::weno_order

Order of accuracy for the WENO reconstruction.

◆ x_a

real(kind(0d0)) m_global_parameters::x_a

◆ x_b

real(kind(0d0)) m_global_parameters::x_b

◆ x_cb

real(kind(0d0)), dimension(:), allocatable m_global_parameters::x_cb

◆ x_cc

real(kind(0d0)), dimension(:), allocatable m_global_parameters::x_cc

◆ x_domain

type(bounds_info) m_global_parameters::x_domain

◆ y_a

real(kind(0d0)) m_global_parameters::y_a

◆ y_b

real(kind(0d0)) m_global_parameters::y_b

◆ y_cb

real(kind(0d0)), dimension(:), allocatable m_global_parameters::y_cb

◆ y_cc

real(kind(0d0)), dimension(:), allocatable m_global_parameters::y_cc

◆ y_domain

type(bounds_info) m_global_parameters::y_domain

◆ z_a

real(kind(0d0)) m_global_parameters::z_a

◆ z_b

real(kind(0d0)) m_global_parameters::z_b

◆ z_cb

real(kind(0d0)), dimension(:), allocatable m_global_parameters::z_cb

Locations of cell-boundaries (cb) in x-, y- and z-directions, respectively.

◆ z_cc

real(kind(0d0)), dimension(:), allocatable m_global_parameters::z_cc

Locations of cell-centers (cc) in x-, y- and z-directions, respectively.

◆ z_domain

type(bounds_info) m_global_parameters::z_domain

Locations of the domain bounds in the x-, y- and z-coordinate directions.