MFC: Pre-Process
High-fidelity multiphase flow simulation
|
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 |
logical | non_axis_sym |
Use existing IC data. | |
integer | t_step_old |
integer | t_step_start |
Existing IC/grid folder. | |
logical | cfl_adap_dt |
logical | cfl_const_dt |
logical | cfl_dt |
integer | n_start |
integer | n_start_old |
integer | proc_rank |
Rank of the local processor. | |
integer | m |
integer | n |
integer | p |
integer(8) | nglobal |
Global number of cells in the domain. | |
integer | m_glb |
integer | n_glb |
integer | p_glb |
Global number of cells in each direction. | |
integer | num_dims |
Number of spatial dimensions. | |
integer | num_vels |
Number of velocity components (different from num_dims for mhd) | |
logical | cyl_coord |
integer | grid_geometry |
Cylindrical coordinates (either axisymmetric or full 3D) | |
real(wp), dimension(:), allocatable | x_cc |
real(wp), dimension(:), allocatable | y_cc |
real(wp), dimension(:), allocatable | z_cc |
Locations of cell-centers (cc) in x-, y- and z-directions, respectively. | |
real(wp), dimension(:), allocatable | x_cb |
real(wp), dimension(:), allocatable | y_cb |
real(wp), dimension(:), allocatable | z_cb |
Locations of cell-boundaries (cb) in x-, y- and z-directions, respectively. | |
real(wp) | dx |
real(wp) | dy |
real(wp) | dz |
Minimum cell-widths in the x-, y- and z-coordinate directions. | |
type(bounds_info) | x_domain |
type(bounds_info) | y_domain |
type(bounds_info) | z_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(wp) | a_x |
real(wp) | a_y |
real(wp) | a_z |
integer | loops_x |
integer | loops_y |
integer | loops_z |
real(wp) | x_a |
real(wp) | y_a |
real(wp) | z_a |
real(wp) | x_b |
real(wp) | y_b |
real(wp) | z_b |
integer | model_eqns |
Multicomponent flow model. | |
logical | relax |
activate phase change | |
integer | relax_model |
Relax Model. | |
real(wp) | palpha_eps |
trigger parameter for the p relaxation procedure, phase change model | |
real(wp) | ptgalpha_eps |
trigger parameter for the pTg relaxation procedure, phase change model | |
integer | num_fluids |
Number of different fluids present in the flow. | |
logical | mpp_lim |
Alpha limiter. | |
integer | sys_size |
Number of unknowns in the system of equations. | |
integer | weno_polyn |
Degree of the WENO polynomials (polyn) | |
integer | weno_order |
Order of accuracy for the WENO reconstruction. | |
logical | hypoelasticity |
activate hypoelasticity | |
logical | hyperelasticity |
activate hyperelasticity | |
logical | elasticity |
elasticity modeling, true for hyper or hypo | |
logical | mhd |
Magnetohydrodynamics. | |
logical | relativity |
Relativity for RMHD. | |
integer | b_size |
Number of components in the b tensor. | |
integer | tensor_size |
Number of components in the nonsymmetric tensor. | |
logical | pre_stress |
activate pre_stressed domain | |
logical, parameter | chemistry = .False. |
Chemistry modeling. | |
type(int_bounds_info) | cont_idx |
Indexes of first & last continuity eqns. | |
type(int_bounds_info) | mom_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_info) | adv_idx |
Indexes of first & last advection eqns. | |
type(int_bounds_info) | internalenergies_idx |
Indexes of first & last internal energy eqns. | |
type(bub_bounds_info) | bub_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_info) | b_idx |
Indexes of first and last magnetic field eqns. | |
type(int_bounds_info) | stress_idx |
Indexes of elastic shear stress eqns. | |
type(int_bounds_info) | xi_idx |
Indexes of first and last reference map eqns. | |
integer | c_idx |
Index of the color function. | |
type(int_bounds_info) | species_idx |
Indexes of first & last concentration eqns. | |
type(int_bounds_info), dimension(1:3) | idwint |
type(int_bounds_info), dimension(1:3) | idwbuff |
type(int_bounds_info) | bc_x |
type(int_bounds_info) | bc_y |
type(int_bounds_info) | bc_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 | mixlayer_vel_profile |
Set hyperbolic tangent streamwise velocity profile. | |
real(wp) | mixlayer_vel_coef |
Coefficient for the hyperbolic tangent streamwise velocity profile. | |
real(wp) | mixlayer_domain |
Domain for the hyperbolic tangent streamwise velocity profile. | |
logical | mixlayer_perturb |
Superimpose instability waves to surrounding fluid flow. | |
real(wp) | pi_fac |
Factor for artificial pi_inf. | |
logical | viscous |
logical | bubbles_lagrange |
logical | perturb_flow |
integer | perturb_flow_fluid |
Fluid to be perturbed with perturb_flow flag. | |
real(wp) | 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(wp), dimension(num_fluids_max) | fluid_rho |
logical | elliptic_smoothing |
integer | elliptic_smoothing_iters |
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 |
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(wp) | rhoref |
real(wp) | pref |
Reference parameters for Tait EOS. | |
logical | rkck_adap_dt |
@ lagrangian solver parameters | |
integer, dimension(:, :, :), allocatable | logic_grid |
type(pres_field) | pb |
type(pres_field) | mv |
real(wp) | bx0 |
Constant magnetic field in the x-direction (1D) | |
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. | |
Bubble modeling | |
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 |
Quadrature moment method. | |
integer | nmom |
Number of carried moments. | |
real(wp) | sigr |
real(wp) | sigv |
real(wp) | 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(vec3_dt), dimension(:), allocatable | airfoil_grid_u |
type(vec3_dt), dimension(:), allocatable | airfoil_grid_l |
Non-polytropic bubble gas compression | |
logical | polytropic |
logical | polydisperse |
integer | thermal |
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) | 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 |
integer | dist_type |
integer | r0_type |
Surface Tension Modeling | |
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 |
This module contains all of the parameters characterizing the computational domain, simulation algorithm, initial condition and the stiffened equation of state.
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.
subroutine m_global_parameters::s_finalize_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.
subroutine m_global_parameters::s_initialize_parallel_io |
real(wp) m_global_parameters::a_x |
real(wp) m_global_parameters::a_y |
real(wp) m_global_parameters::a_z |
type(int_bounds_info) m_global_parameters::adv_idx |
Indexes of first & last advection eqns.
logical m_global_parameters::adv_n |
Solve the number density equation and compute alpha from number density.
integer m_global_parameters::advxb |
integer m_global_parameters::advxe |
type(vec3_dt), dimension(:), allocatable m_global_parameters::airfoil_grid_l |
type(vec3_dt), dimension(:), allocatable m_global_parameters::airfoil_grid_u |
integer m_global_parameters::alf_idx |
Index of void fraction.
type(int_bounds_info) m_global_parameters::b_idx |
Indexes of first and last magnetic field eqns.
integer m_global_parameters::b_size |
Number of components in the b tensor.
type(int_bounds_info) m_global_parameters::bc_x |
type(int_bounds_info) m_global_parameters::bc_y |
type(int_bounds_info) m_global_parameters::bc_z |
Boundary conditions in the x-, y- and z-coordinate directions.
type(bub_bounds_info) m_global_parameters::bub_idx |
Indexes of first & last bubble variable eqns.
logical m_global_parameters::bubbles_euler |
logical m_global_parameters::bubbles_lagrange |
integer m_global_parameters::bubxb |
integer m_global_parameters::bubxe |
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.
real(wp) m_global_parameters::bx0 |
Constant magnetic field in the x-direction (1D)
integer m_global_parameters::c_idx |
Index of the color function.
real(wp) m_global_parameters::ca |
character(len=path_len) m_global_parameters::case_dir |
Case folder location.
logical m_global_parameters::cfl_adap_dt |
logical m_global_parameters::cfl_const_dt |
logical m_global_parameters::cfl_dt |
logical, parameter m_global_parameters::chemistry = .False. |
Chemistry modeling.
integer m_global_parameters::chemxb |
integer m_global_parameters::chemxe |
type(int_bounds_info) m_global_parameters::cont_idx |
Indexes of first & last continuity eqns.
integer m_global_parameters::contxb |
integer m_global_parameters::contxe |
logical m_global_parameters::cyl_coord |
integer m_global_parameters::dist_type |
real(wp) m_global_parameters::dx |
real(wp) m_global_parameters::dy |
real(wp) m_global_parameters::dz |
Minimum cell-widths in the x-, y- and z-coordinate directions.
integer m_global_parameters::e_idx |
Index of total energy equation.
logical m_global_parameters::elasticity |
elasticity modeling, true for hyper or hypo
logical m_global_parameters::elliptic_smoothing |
integer m_global_parameters::elliptic_smoothing_iters |
logical m_global_parameters::file_per_process |
type of data output
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.
real(wp), dimension(num_fluids_max) m_global_parameters::fluid_rho |
integer m_global_parameters::gamma_idx |
Index of specific heat ratio func. eqn.
real(wp) m_global_parameters::gamma_m |
real(wp) m_global_parameters::gamma_n |
real(wp) m_global_parameters::gamma_v |
integer m_global_parameters::grid_geometry |
Cylindrical coordinates (either axisymmetric or full 3D)
logical m_global_parameters::hyperelasticity |
activate hyperelasticity
logical m_global_parameters::hypoelasticity |
activate hypoelasticity
logical m_global_parameters::ib |
Turn immersed boundaries on.
type(int_bounds_info), dimension(1:3) m_global_parameters::idwbuff |
type(int_bounds_info), dimension(1:3) m_global_parameters::idwint |
|
private |
real(wp), dimension(:), allocatable m_global_parameters::im_trans_c |
real(wp), dimension(:), allocatable m_global_parameters::im_trans_t |
type(int_bounds_info) m_global_parameters::internalenergies_idx |
Indexes of first & last internal energy eqns.
integer m_global_parameters::intxb |
integer m_global_parameters::intxe |
real(wp), dimension(:), allocatable m_global_parameters::k_n |
real(wp), dimension(:), allocatable m_global_parameters::k_v |
integer, dimension(:, :, :), allocatable m_global_parameters::logic_grid |
integer m_global_parameters::loops_x |
integer m_global_parameters::loops_y |
integer m_global_parameters::loops_z |
integer m_global_parameters::m |
integer m_global_parameters::m_glb |
real(wp) m_global_parameters::m_n |
real(wp) m_global_parameters::m_v |
real(wp), dimension(:), allocatable m_global_parameters::mass_n0 |
real(wp), dimension(:), allocatable m_global_parameters::mass_v0 |
logical m_global_parameters::mhd |
Magnetohydrodynamics.
real(wp) m_global_parameters::mixlayer_domain |
Domain for the hyperbolic tangent streamwise velocity profile.
logical m_global_parameters::mixlayer_perturb |
Superimpose instability waves to surrounding fluid flow.
real(wp) m_global_parameters::mixlayer_vel_coef |
Coefficient for the hyperbolic tangent streamwise velocity profile.
logical m_global_parameters::mixlayer_vel_profile |
Set hyperbolic tangent streamwise velocity profile.
integer m_global_parameters::model_eqns |
Multicomponent flow model.
type(int_bounds_info) m_global_parameters::mom_idx |
Indexes of first & last momentum eqns.
integer m_global_parameters::momxb |
integer m_global_parameters::momxe |
integer m_global_parameters::mpi_info_int |
MPI info for parallel IO with Lustre file systems.
type(mpi_io_airfoil_ib_var), public m_global_parameters::mpi_io_airfoil_ib_data |
type(mpi_io_var), public m_global_parameters::mpi_io_data |
type(mpi_io_ib_var), public m_global_parameters::mpi_io_ib_data |
type(mpi_io_levelset_var), public m_global_parameters::mpi_io_levelset_data |
type(mpi_io_levelset_norm_var), public m_global_parameters::mpi_io_levelsetnorm_data |
character(len=name_len) m_global_parameters::mpiiofs |
logical m_global_parameters::mpp_lim |
Alpha limiter.
real(wp) m_global_parameters::mu_n |
real(wp) m_global_parameters::mu_v |
real(wp) m_global_parameters::mul0 |
type(pres_field) m_global_parameters::mv |
integer m_global_parameters::n |
integer m_global_parameters::n_glb |
integer m_global_parameters::n_idx |
Index of number density.
integer m_global_parameters::n_start |
integer m_global_parameters::n_start_old |
integer m_global_parameters::nb |
integer(8) m_global_parameters::nglobal |
Global number of cells in the domain.
integer m_global_parameters::nmom |
Number of carried moments.
logical m_global_parameters::non_axis_sym |
Use existing IC data.
integer m_global_parameters::np |
integer m_global_parameters::num_dims |
Number of spatial dimensions.
integer m_global_parameters::num_fluids |
Number of different fluids present in the flow.
integer m_global_parameters::num_ibs |
Number of immersed boundaries.
integer m_global_parameters::num_patches |
Number of patches composing initial condition.
integer m_global_parameters::num_procs |
Number of processors.
integer m_global_parameters::num_vels |
Number of velocity components (different from num_dims for mhd)
logical m_global_parameters::old_grid |
Use existing grid data.
logical m_global_parameters::old_ic |
real(wp), dimension(:), allocatable m_global_parameters::omegan |
integer m_global_parameters::p |
integer m_global_parameters::p_glb |
Global number of cells in each direction.
real(wp) m_global_parameters::palpha_eps |
trigger parameter for the p relaxation procedure, phase change model
logical m_global_parameters::parallel_io |
Format of the data files.
type(ib_patch_parameters), dimension(num_patches_max) m_global_parameters::patch_ib |
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.
type(pres_field) m_global_parameters::pb |
real(wp), dimension(:), allocatable m_global_parameters::pb0 |
real(wp) m_global_parameters::pe_c |
real(wp), dimension(:), allocatable m_global_parameters::pe_t |
logical m_global_parameters::perturb_flow |
integer m_global_parameters::perturb_flow_fluid |
Fluid to be perturbed with perturb_flow flag.
real(wp) m_global_parameters::perturb_flow_mag |
Magnitude of perturbation with perturb_flow flag.
logical m_global_parameters::perturb_sph |
integer m_global_parameters::perturb_sph_fluid |
Fluid to be perturbed with perturb_sph flag.
real(wp) m_global_parameters::phi_nv |
real(wp) m_global_parameters::phi_vn |
real(wp) m_global_parameters::pi_fac |
Factor for artificial pi_inf.
integer m_global_parameters::pi_inf_idx |
Index of liquid stiffness func. eqn.
real(wp) m_global_parameters::poly_sigma |
logical m_global_parameters::polydisperse |
logical m_global_parameters::polytropic |
logical m_global_parameters::pre_stress |
activate pre_stressed domain
integer m_global_parameters::precision |
Precision of output files.
real(wp) m_global_parameters::pref |
Reference parameters for Tait EOS.
integer, dimension(:), allocatable m_global_parameters::proc_coords |
Processor coordinates in MPI_CART_COMM.
integer m_global_parameters::proc_rank |
Rank of the local processor.
real(wp) m_global_parameters::ptgalpha_eps |
trigger parameter for the pTg relaxation procedure, phase change model
real(wp) m_global_parameters::pv |
logical m_global_parameters::qbmm |
Quadrature moment method.
real(wp), dimension(:), allocatable m_global_parameters::r0 |
integer m_global_parameters::r0_type |
real(wp) m_global_parameters::r0ref |
real(wp) m_global_parameters::r_n |
real(wp) m_global_parameters::r_v |
real(wp) m_global_parameters::re_inv |
real(wp), dimension(:), allocatable m_global_parameters::re_trans_c |
real(wp), dimension(:), allocatable m_global_parameters::re_trans_t |
logical m_global_parameters::relativity |
Relativity for RMHD.
logical m_global_parameters::relax |
activate phase change
integer m_global_parameters::relax_model |
Relax Model.
real(wp) m_global_parameters::rhoref |
real(wp) m_global_parameters::rhorv |
standard deviations in R/V
logical m_global_parameters::rkck_adap_dt |
@ lagrangian solver parameters
real(wp) m_global_parameters::sigma |
real(wp) m_global_parameters::sigr |
real(wp) m_global_parameters::sigv |
type(int_bounds_info) m_global_parameters::species_idx |
Indexes of first & last concentration eqns.
real(wp) m_global_parameters::ss |
integer, dimension(:), allocatable m_global_parameters::start_idx |
Starting cell-center index of local processor in global grid.
type(int_bounds_info) m_global_parameters::stress_idx |
Indexes of elastic shear stress eqns.
logical m_global_parameters::stretch_x |
logical m_global_parameters::stretch_y |
logical m_global_parameters::stretch_z |
Grid stretching flags for the x-, y- and z-coordinate directions.
integer m_global_parameters::strxb |
integer m_global_parameters::strxe |
logical m_global_parameters::surface_tension |
integer m_global_parameters::sys_size |
Number of unknowns in the system of equations.
integer m_global_parameters::t_step_old |
integer m_global_parameters::t_step_start |
Existing IC/grid folder.
integer m_global_parameters::tensor_size |
Number of components in the nonsymmetric tensor.
integer m_global_parameters::thermal |
real(wp) m_global_parameters::tw |
real(wp), dimension(:), allocatable m_global_parameters::v0 |
logical m_global_parameters::viscous |
real(wp) m_global_parameters::web |
real(wp), dimension(:), allocatable m_global_parameters::weight |
integer m_global_parameters::weno_order |
Order of accuracy for the WENO reconstruction.
integer m_global_parameters::weno_polyn |
Degree of the WENO polynomials (polyn)
real(wp) m_global_parameters::x_a |
real(wp) m_global_parameters::x_b |
real(wp), dimension(:), allocatable m_global_parameters::x_cb |
real(wp), dimension(:), allocatable m_global_parameters::x_cc |
type(bounds_info) m_global_parameters::x_domain |
type(int_bounds_info) m_global_parameters::xi_idx |
Indexes of first and last reference map eqns.
integer m_global_parameters::xibeg |
integer m_global_parameters::xiend |
real(wp) m_global_parameters::y_a |
real(wp) m_global_parameters::y_b |
real(wp), dimension(:), allocatable m_global_parameters::y_cb |
real(wp), dimension(:), allocatable m_global_parameters::y_cc |
type(bounds_info) m_global_parameters::y_domain |
real(wp) m_global_parameters::z_a |
real(wp) m_global_parameters::z_b |
real(wp), dimension(:), allocatable m_global_parameters::z_cb |
Locations of cell-boundaries (cb) in x-, y- and z-directions, respectively.
real(wp), dimension(:), allocatable m_global_parameters::z_cc |
Locations of cell-centers (cc) in x-, y- and z-directions, respectively.
type(bounds_info) m_global_parameters::z_domain |
Locations of the domain bounds in the x-, y- and z-coordinate directions.