global_vars Module

Contains all the public/global variables used by more than one module


Uses

  • module~~global_vars~~UsesGraph module~global_vars global_vars module~global global module~global_vars->module~global

Used by


Contents

total_process total_entries process_id imin_id imax_id jmin_id jmax_id kmin_id kmax_id layers min_iter max_iters start_from checkpoint_iter checkpoint_iter_count current_iter r_count w_count res_write_interval purge_write last_iter write_percision write_data_format write_file_format read_data_format read_file_format outfile infile restartfile r_list w_list previous_flow_type CFL tolerance tolerance_type want_to_stop Halt time_stepping_method time_step_accuracy global_time_step delta_t sim_clock scheme_name interpolant qp_n dEdx_1 dEdx_2 dEdx_3 n_var qp qp_inf density x_speed y_speed z_speed pressure density_inf x_speed_inf y_speed_inf z_speed_inf pressure_inf MInf intermittency ExtraVar1 ExtraVar2 ExtraVar3 ExtraVar4 ExtraVar5 free_stream_density free_stream_x_speed free_stream_y_speed free_stream_z_speed free_stream_pressure free_stream_tk free_stream_tw free_stream_te free_stream_tv free_stream_tkl free_stream_tu free_stream_tgm vel_mag Reynolds_number mu_ratio_inf Turb_intensity_inf dist CCnormalX CCnormalY CCnormalZ CCVn DCCVnX DCCVnY DCCVnZ sst_n_var sst_n_grad tk tw te tv tkl tgm tk_inf tw_inf te_inf tv_inf tkl_inf tgm_inf F_p G_p H_p residue mass_residue x_mom_residue y_mom_residue z_mom_residue energy_residue TKE_residue omega_residue KL_residue dissipation_residue tv_residue gm R_gas mu_ref mu_variation T_ref Sutherland_temp Pr tPr supersonic_flag ilimiter_switch jlimiter_switch klimiter_switch itlimiter_switch jtlimiter_switch ktlimiter_switch iPB_switch jPB_switch kPB_switch turbulence transition mu mu_t sst_mu kkl_mu sa_mu Res_list Res_count Res_itr Res_abs Res_rel Res_save Res_scale resnorm vis_resnorm turb_resnorm cont_resnorm x_mom_resnorm y_mom_resnorm z_mom_resnorm energy_resnorm TKE_resnorm omega_resnorm resnorm_d1 vis_resnorm_d1 turb_resnorm_d1 cont_resnorm_d1 x_mom_resnorm_d1 y_mom_resnorm_d1 z_mom_resnorm_d1 energy_resnorm_d1 TKE_resnorm_d1 omega_resnorm_d1 resnorm_0 vis_resnorm_0 turb_resnorm_0 cont_resnorm_0 x_mom_resnorm_0 y_mom_resnorm_0 z_mom_resnorm_0 energy_resnorm_0 TKE_resnorm_0 omega_resnorm_0 resnorm_0s vis_resnorm_0s turb_resnorm_0s cont_resnorm_0s x_mom_resnorm_0s y_mom_resnorm_0s z_mom_resnorm_0s energy_resnorm_0s TKE_resnorm_0s omega_resnorm_0s imx jmx kmx imn jmn kmn grid_x grid_y grid_z xn yn zn xnx xny xnz ynx yny ynz znx zny znz xA yA zA volume left_ghost_centroid right_ghost_centroid front_ghost_centroid back_ghost_centroid top_ghost_centroid bottom_ghost_centroid n_grad gradqp_x gradqp_y gradqp_z gradu_x gradu_y gradu_z gradv_x gradv_y gradv_z gradw_x gradw_y gradw_z gradT_x gradT_y gradT_z gradtk_x gradtk_y gradtk_z gradtw_x gradtw_y gradtw_z gradtkl_x gradtkl_y gradtkl_z gradte_x gradte_y gradte_z gradtv_x gradtv_y gradtv_z gradtgm_x gradtgm_y gradtgm_z accur face_names id c1 c2 c3 fixed_density fixed_pressure fixed_x_speed fixed_y_speed fixed_z_speed fixed_tk fixed_tw fixed_te fixed_tv fixed_tkl fixed_tgm fixed_wall_temperature fixed_Tpressure fixed_Ttemperature N_blocks I_blocks J_blocks K_blocks imin imax jmin jmax kmin kmax ilo ihi jlo jhi klo khi dir_switch otherface make_F_flux_zero make_G_flux_zero make_H_flux_zero PbcId

Variables

TypeVisibility AttributesNameInitial
integer, public :: total_process

Total number of process to be used for computation

integer, public :: total_entries

Total enteries in layout.md for each processor

integer, public :: process_id

Id no. of each processor assinged by MPICH library

integer, public :: imin_id

Boundary condition number/ID at imin for particulat processor

integer, public :: imax_id

Boundary condition number/ID at imax for particulat processor

integer, public :: jmin_id

Boundary condition number/ID at jmin for particulat processor

integer, public :: jmax_id

Boundary condition number/ID at jmax for particulat processor

integer, public :: kmin_id

Boundary condition number/ID at kmin for particulat processor

integer, public :: kmax_id

Boundary condition number/ID at kmax for particulat processor

integer, public :: layers =3

Number of ghost cell layers to transfer with mpi

integer, public :: min_iter =1

Minimum iteration value, starting iteration value

integer, public :: max_iters =1

Maximum iteration value, stop after these many iteration

integer, public :: start_from =0

Number of the folder (in time_directories) to load stored state from to restart computation

integer, public :: checkpoint_iter =0

Write interval for output file. Number of iteration after which solver will dump/store a state in a folder in time_directories

integer, public :: checkpoint_iter_count =0

Counter of folder number to write in time_directories/

integer, public :: current_iter =0

Current iteration number

integer, public :: r_count =0

Number of variable to read from the restart file

integer, public :: w_count =0

Number of variable to write in the output file

integer, public :: res_write_interval

Write resnorm after every "res_write_interval" iteration

integer, public :: purge_write

Remove unwanted folder. If Purge_write=2, latest two folder in time_direcotires are kept and 0=no purge

integer, public :: last_iter =0

Last iteration that is stored in the restart file

integer, public :: write_percision =6

Number of place after decimal. Only used for resnorm file

character(len=FORMAT_LENGTH), public :: write_data_format

write data type. Either ASCII or BINARY

character(len=FORMAT_LENGTH), public :: write_file_format

Write file type. Either vtk or tecplot

character(len=FORMAT_LENGTH), public :: read_data_format ='ASCII'

Read data type in file. Either ASCII or BINARY

character(len=FORMAT_LENGTH), public :: read_file_format ="vtk"

Read file type. Either vtk or tecplot

character(len=FILE_NAME_LENGTH), public :: outfile

String to store name of output file

character(len=FILE_NAME_LENGTH), public :: infile

String to store the name of restart/load file

character(len=FILE_NAME_LENGTH), public :: restartfile

Sting to store the name of restart log file

character(len=STATE_NAME_LENGTH), public, dimension(:), allocatable:: r_list

Read variable list

character(len=STATE_NAME_LENGTH), public, dimension(:), allocatable:: w_list

Write variable list

character(len=FLOW_TYPE_LENGTH), public :: previous_flow_type ="none"

Type of flow:inviscid, laminar, etc, stored in the load file

real, public :: CFL

Courant–Friedrichs–Lewy (CFL) (Read from input)

real, public :: tolerance

Minimum value of resnorm after which simulation stop

character(len=TOLERANCE_LENGTH), public :: tolerance_type ="abs"

Type of tolerance to check:absolute or relative

integer, public :: want_to_stop =0

0: continue the solver; 1=Stop the solver

logical, public :: Halt =.FALSE.

Logical value used to stop the solver in main program file.

character, public :: time_stepping_method

Either local time stepping or global time stepping

character(len=INTERPOLANT_NAME_LENGTH), public :: time_step_accuracy

Type of time_integration scheme: RK4, none(firt order explicit) implicit,

real, public :: global_time_step

Value of global time step to march the solution with

real, public, dimension(:, :, :), allocatable:: delta_t

Local time increment value at each cell center

real, public :: sim_clock

Simluation clock time

character(len=SCHEME_NAME_LENGTH), public :: scheme_name

Flux Scheme to use: ausm, ldfss0, vanleer, ausmup, ausmp, slau

character(len=INTERPOLANT_NAME_LENGTH), public :: interpolant

Face state reconstruction method to user: muscl, ppm, none, weno, and wenoNM

real, public, dimension(:, :, :, :), allocatable:: qp_n
real, public, dimension(:, :, :, :), allocatable:: dEdx_1
real, public, dimension(:, :, :, :), allocatable:: dEdx_2
real, public, dimension(:, :, :, :), allocatable:: dEdx_3
integer, public :: n_var =5

Number of variable to solve for

real, public, dimension(:, :, :, :), allocatable, target:: qp

Store primitive variable at cell center

real, public, dimension(:), allocatable, target:: qp_inf

Store primitive variable at infinity

real, public, dimension(:, :, :), pointer:: density

Rho pointer, point to slice of qp (:,:,:,1)

real, public, dimension(:, :, :), pointer:: x_speed

U pointer, point to slice of qp (:,:,:,2)

real, public, dimension(:, :, :), pointer:: y_speed

V pointer, point to slice of qp (:,:,:,3)

real, public, dimension(:, :, :), pointer:: z_speed

W pointer, point to slice of qp (:,:,:,4)

real, public, dimension(:, :, :), pointer:: pressure

P pointer, point to slice of qp (:,:,:,5)

real, public, pointer:: density_inf

Rho pointer, point to slice of qp_inf (1)

real, public, pointer:: x_speed_inf

U pointer, point to slice of qp_inf (2)

real, public, pointer:: y_speed_inf

V pointer, point to slice of qp_inf (3)

real, public, pointer:: z_speed_inf

W pointer, point to slice of qp_inf (4)

real, public, pointer:: pressure_inf

P pointer, point to slice of qp_inf (5)

real, public :: MInf

Free-stream Mach number

real, public, dimension(:, :, :), allocatable, target:: intermittency

Intermiitency pointer

real, public, dimension(:, :, :), allocatable, target:: ExtraVar1

Extravar1 used only for debuging or store some sepcial kind of compination of other varialbes

real, public, dimension(:, :, :), allocatable, target:: ExtraVar2

Extravar2 used only for debuging or store some sepcial kind of compination of other varialbes

real, public, dimension(:, :, :), allocatable, target:: ExtraVar3

Extravar3 used only for debuging or store some sepcial kind of compination of other varialbes

real, public, dimension(:, :, :), allocatable, target:: ExtraVar4

Extravar4 used only for debuging or store some sepcial kind of compination of other varialbes

real, public, dimension(:, :, :), allocatable, target:: ExtraVar5

Extravar5 used only for debuging or store some sepcial kind of compination of other varialbes

real, public :: free_stream_density

Read freestream Density from control file

real, public :: free_stream_x_speed

Read freestream U from control file

real, public :: free_stream_y_speed

Read freestream V from control file

real, public :: free_stream_z_speed

Read freestream W from control file

real, public :: free_stream_pressure

Read freestream Pressure from control file

real, public :: free_stream_tk

Read freestream turbulent kinetic energy rate from control file

real, public :: free_stream_tw

Read freestream turbulent dissipation rate from control file

real, public :: free_stream_te

Read freestream turbulent dissipation from control file

real, public :: free_stream_tv

Read freestream turbulent viscosity(SA) from control file

real, public :: free_stream_tkl

Read freestream kL variable from control file

real, public :: free_stream_tu

Read freestream turbulence intensity (percentage) from control file

real, public :: free_stream_tgm

Read freestream turbulence intermittency from control file

real, public :: vel_mag

Calulated freestream Velocity Magnitude from control file

real, public :: Reynolds_number

Calculated free_stream Reynolds_number

real, public :: mu_ratio_inf

Read freestream turbulent viscosity to molecular viscosity ratio

real, public :: Turb_intensity_inf

Calculate free_stream turbulence intensity

real, public, dimension(:, :, :), allocatable:: dist

Store wall distance for each cell center

real, public, dimension(:, :, :), allocatable:: CCnormalX

Cell-Center normal nx with respect to wall; used for transition model (pressure gradient calcualtion)

real, public, dimension(:, :, :), allocatable:: CCnormalY

Cell-Center normal ny with respect to wall; used for transiton model (pressure gradient calculation)

real, public, dimension(:, :, :), allocatable:: CCnormalZ

Cell-Center normal nz with respect to wall; used for transiton model (pressure gradient calculation)

real, public, dimension(:, :, :), allocatable:: CCVn

Store value at Cell-Center of dot product between velocity vector and cell-center normal. {vec(Velocity).normal}

real, public, dimension(:, :, :), allocatable:: DCCVnX

Store Derivative of Cell-Center CCVn with respect to x

real, public, dimension(:, :, :), allocatable:: DCCVnY

Store Derivative of Cell-Center CCVn with respect to y

real, public, dimension(:, :, :), allocatable:: DCCVnZ

Store Derivative of Cell-Center CCVn with respect to z

integer, public :: sst_n_var =2
integer, public :: sst_n_grad =2
real, public, dimension(:, :, :), pointer:: tk

TKE/mass

real, public, dimension(:, :, :), pointer:: tw

Omega

real, public, dimension(:, :, :), pointer:: te

Dissipation

real, public, dimension(:, :, :), pointer:: tv

SA visocity

real, public, dimension(:, :, :), pointer:: tkl

KL K-KL method

real, public, dimension(:, :, :), pointer:: tgm

Intermittency of LCTM2015

real, public, pointer:: tk_inf

TKE/mass at inf

real, public, pointer:: tw_inf

Omega at inf

real, public, pointer:: te_inf

Dissipation at inf

real, public, pointer:: tv_inf

SA viscosity at inf

real, public, pointer:: tkl_inf

kl at inf

real, public, pointer:: tgm_inf

Intermittency at inf

real, public, dimension(:, :, :, :), pointer:: F_p

Flux pointer for face in the I direction

real, public, dimension(:, :, :, :), pointer:: G_p

Flux pointer for face in the G direction

real, public, dimension(:, :, :, :), pointer:: H_p

Flux pointer for face in the K direction

real, public, dimension(:, :, :, :), pointer:: residue

Store residue at each cell-center

real, public, dimension(:, :, :), pointer:: mass_residue

Store continuity equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: x_mom_residue

Store x-momentum equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: y_mom_residue

Store y-momentum equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: z_mom_residue

Store z-momentum equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: energy_residue

Store energy equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: TKE_residue

Store TKE equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: omega_residue

Store Omega equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: KL_residue

Store KL equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: dissipation_residue

Store Disspaiton equation residual at each cell-center

real, public, dimension(:, :, :), pointer:: tv_residue

Store nut equation(SA model) residual at each cell-center

real, public :: gm

Gamma commonly 1.4

real, public :: R_gas

Univarsal gas constant

real, public :: mu_ref

Molecular viscoity reference

character(len=FILE_NAME_LENGTH), public :: mu_variation

Type of viscosity variaiton: Sutherland or constant

real, public :: T_ref

Reference Temperature of flow for viscosity calculation

real, public :: Sutherland_temp

Sutherland temperature for viscosity calculation

real, public :: Pr =0.7

prandtl number

real, public :: tPr =0.9

turbulent Prandtl number

logical, public :: supersonic_flag

Switch for boundary condition. No longer in use

integer, public :: ilimiter_switch

Turn on/off application of limiter for MUSCL (higer order face state reconstiion) for I direction faces.

integer, public :: jlimiter_switch

Turn on/off application of limiter for MUSCL (higer order face state reconstiion) for J direction faces.

integer, public :: klimiter_switch

Turn on/off application of limiter for MUSCL (higer order face state reconstiion) for K direction faces.

integer, public :: itlimiter_switch

Turn on/off application of limiter for MUSCL (higer order face turbulent variable state reconstiion) for I direction faces.

integer, public :: jtlimiter_switch

Turn on/off application of limiter for MUSCL (higer order face turbulent variable state reconstiion) for J direction faces.

integer, public :: ktlimiter_switch

Turn on/off application of limiter for MUSCL (higer order face turbulent variable state reconstiion) for K direction faces.

integer, public :: iPB_switch

Turn on/off application of pressure based switching for higher order methods for I direction faces.

integer, public :: jPB_switch

Turn on/off application of pressure based switching for higher order methods for J direction faces.

integer, public :: kPB_switch

Turn on/off application of pressure based switching for higher order methods for K direction faces.

character(len=8), public :: turbulence

Store Turbulence model name

character(len=8), public :: transition

Store Transition model name

real, public, dimension(:, :, :), allocatable, target:: mu

Cell-center molecular viscosity

real, public, dimension(:, :, :), allocatable, target:: mu_t

Cell-center turbulent viscosity

real, public, dimension(:, :, :), pointer:: sst_mu

Pointer to turbulent viscosity for SST turbulence model

real, public, dimension(:, :, :), pointer:: kkl_mu

Pointer to turbulent viscosity for KKL turbulence model

real, public, dimension(:, :, :), pointer:: sa_mu

Pointer to turbulent viscosity for SA turbulence model

character(len=STATE_NAME_LENGTH), public, dimension(:), allocatable:: Res_list
integer, public :: Res_count

No of variable to save

integer, public :: Res_itr =3

Iteration to save

real, public, dimension(:), allocatable:: Res_abs

Absolute value

real, public, dimension(:), allocatable:: Res_rel

Relative value

real, public, dimension(:), allocatable:: Res_save

Saved iteration for relative

real, public, dimension(:), allocatable:: Res_scale

Scaling factor

real, public, pointer:: resnorm
         Residual normalized
real, public, pointer:: vis_resnorm

{rho+V+P} equation residual normalized

real, public, pointer:: turb_resnorm

Turbulent residual normalized

real, public, pointer:: cont_resnorm

Mass residual normalized

real, public, pointer:: x_mom_resnorm

X momentum residual normalized

real, public, pointer:: y_mom_resnorm

Y momentum residual normalized

real, public, pointer:: z_mom_resnorm

Z momentum residual normalized

real, public, pointer:: energy_resnorm

Energy residual normalized

real, public, pointer:: TKE_resnorm

TKE residual normalized

real, public, pointer:: omega_resnorm

Omega residual normalized

real, public, pointer:: resnorm_d1

Residual normalized/same at iter 1

real, public, pointer:: vis_resnorm_d1

{rho+V+P} residual normalized/same at iter 1

real, public, pointer:: turb_resnorm_d1

Turbulent residual normalized/same at iter 1

real, public, pointer:: cont_resnorm_d1

Mass residual normalized/same at iter 1

real, public, pointer:: x_mom_resnorm_d1

X momentum residual normalized/same at iter 1

real, public, pointer:: y_mom_resnorm_d1

Y momentum residual normalized/same at iter 1

real, public, pointer:: z_mom_resnorm_d1

Z momentum residual normalized/same at iter 1

real, public, pointer:: energy_resnorm_d1

Energy residual normalized/same at iter 1

real, public, pointer:: TKE_resnorm_d1

TKE residual normalized/same at iter 1

real, public, pointer:: omega_resnorm_d1

Omega residual normalized/same at iter 1

real, public :: resnorm_0

Residual normalized at iter 1

real, public :: vis_resnorm_0

{rho+V+P} residual normalized at iter 1

real, public :: turb_resnorm_0

Turbulent residual normalized at iter 1

real, public :: cont_resnorm_0

Mass residual normalized at iter 1

real, public :: x_mom_resnorm_0

X momentum residual normalized at iter 1

real, public :: y_mom_resnorm_0

Y momentum residual normalized at iter 1

real, public :: z_mom_resnorm_0

Z momentum residual normalized at iter 1

real, public :: energy_resnorm_0

Energy residual normalized at iter 1

real, public :: TKE_resnorm_0

TKE residual normalized at iter 1

real, public :: omega_resnorm_0

Omega residual normalized at iter 1

real, public :: resnorm_0s

Residual normalized at iter 1

real, public :: vis_resnorm_0s

{rho+V+P} residual normalized at iter 1

real, public :: turb_resnorm_0s

Turbulent residual normalized at iter 1

real, public :: cont_resnorm_0s

Mass residual normalized at iter 1

real, public :: x_mom_resnorm_0s

X momentum residual normalized at iter 1

real, public :: y_mom_resnorm_0s

Y momentum residual normalized at iter 1

real, public :: z_mom_resnorm_0s

Z momentum residual normalized at iter 1

real, public :: energy_resnorm_0s

Energy residual normalized at iter 1

real, public :: TKE_resnorm_0s

TKE residual normalized at iter 1

real, public :: omega_resnorm_0s

Omega residual normalized at iter 1

integer, public :: imx

Maximum number of grid points in the I direction

integer, public :: jmx

Maximum number of grid points in the K direction

integer, public :: kmx

Maximum number of grid points in the K direction

integer, public :: imn
integer, public :: jmn
integer, public :: kmn
real, public, dimension(:, :, :), allocatable:: grid_x

X corrdinate of the grid point

real, public, dimension(:, :, :), allocatable:: grid_y

Y corrdinate of the grid point

real, public, dimension(:, :, :), allocatable:: grid_z

Z corrdinate of the grid point

real, public, dimension(:, :, :,:), allocatable, target:: xn

Store unit face normal vector for all I faces

real, public, dimension(:, :, :,:), allocatable, target:: yn

Store unit face normal vector for all J faces

real, public, dimension(:, :, :,:), allocatable, target:: zn

Store unit face normal vector for all K faces

real, public, dimension(:, :, :), pointer:: xnx

Pointer to x component of face unit normal of I faces

real, public, dimension(:, :, :), pointer:: xny

Pointer to y component of face unit normal of I faces

real, public, dimension(:, :, :), pointer:: xnz

Pointer to z component of face unit normal of I faces

real, public, dimension(:, :, :), pointer:: ynx

Pointer to x component of face unit normal of J faces

real, public, dimension(:, :, :), pointer:: yny

Pointer to y component of face unit normal of J faces

real, public, dimension(:, :, :), pointer:: ynz

Pointer to z component of face unit normal of J faces

real, public, dimension(:, :, :), pointer:: znx

Pointer to x component of face unit normal of K faces

real, public, dimension(:, :, :), pointer:: zny

Pointer to y component of face unit normal of K faces

real, public, dimension(:, :, :), pointer:: znz

Pointer to z component of face unit normal of K faces

real, public, dimension(:, :, :), allocatable, target:: xA

Store magnitude of face area vector of I direction faces

real, public, dimension(:, :, :), allocatable, target:: yA

Store magnitude of face area vector of J direction faces

real, public, dimension(:, :, :), allocatable, target:: zA

Store magnitude of face area vector of K direction faces

real, public, dimension(:, :, :), allocatable, target:: volume

Store cell volume

real, public, dimension(:, :, :), allocatable, target:: left_ghost_centroid

Store the cell center of the ghost cell on 1 face

real, public, dimension(:, :, :), allocatable, target:: right_ghost_centroid

Store the cell center of the ghost cell on 2 face

real, public, dimension(:, :, :), allocatable, target:: front_ghost_centroid

Store the cell center of the ghost cell on 3 face

real, public, dimension(:, :, :), allocatable, target:: back_ghost_centroid

Store the cell center of the ghost cell on 4 face

real, public, dimension(:, :, :), allocatable, target:: top_ghost_centroid

Store the cell center of the ghost cell on 5 face

real, public, dimension(:, :, :), allocatable, target:: bottom_ghost_centroid

Store the cell center of the ghost cell on 6 face

integer, public :: n_grad =4

Number of variable to store gradient for

real, public, dimension(:, :, :, :), allocatable, target:: gradqp_x

Store gradient of n_grad variables with respect to direction x

real, public, dimension(:, :, :, :), allocatable, target:: gradqp_y

Store gradient of n_grad variables with respect to direction y

real, public, dimension(:, :, :, :), allocatable, target:: gradqp_z

Store gradient of n_grad variables with respect to direction z

real, public, dimension(:, :, :), pointer:: gradu_x

Gradient of variable U with respect to direction x

real, public, dimension(:, :, :), pointer:: gradu_y

Gradient of variable U with respect to direction y

real, public, dimension(:, :, :), pointer:: gradu_z

Gradient of variable U with respect to direction z

real, public, dimension(:, :, :), pointer:: gradv_x

Gradient of variable V with respect to direction x

real, public, dimension(:, :, :), pointer:: gradv_y

Gradient of variable V with respect to direction y

real, public, dimension(:, :, :), pointer:: gradv_z

Gradient of variable V with respect to direction z

real, public, dimension(:, :, :), pointer:: gradw_x

Gradient of variable W with respect to direction x

real, public, dimension(:, :, :), pointer:: gradw_y

Gradient of variable W with respect to direction y

real, public, dimension(:, :, :), pointer:: gradw_z

Gradient of variable W with respect to direction z

real, public, dimension(:, :, :), pointer:: gradT_x

Gradient of variable Temperature with respect to direction x

real, public, dimension(:, :, :), pointer:: gradT_y

Gradient of variable Temperature with respect to direction y

real, public, dimension(:, :, :), pointer:: gradT_z

Gradient of variable Temperature with respect to direction z

real, public, dimension(:, :, :), pointer:: gradtk_x

Gradient of variable turbulent kinetic energy with respect to direction x

real, public, dimension(:, :, :), pointer:: gradtk_y

Gradient of variable turbulent kinetic energy with respect to direction y

real, public, dimension(:, :, :), pointer:: gradtk_z

Gradient of variable turbulent kinetic energy with respect to direction z

real, public, dimension(:, :, :), pointer:: gradtw_x

Gradient of variable dissipation rate with respect to direction x

real, public, dimension(:, :, :), pointer:: gradtw_y

Gradient of variable dissipation rate with respect to direction y

real, public, dimension(:, :, :), pointer:: gradtw_z

Gradient of variable dissipation rate with respect to direction z

real, public, dimension(:, :, :), pointer:: gradtkl_x

Gradient of variable kL with respect to direction x

real, public, dimension(:, :, :), pointer:: gradtkl_y

Gradient of variable kL with respect to direction y

real, public, dimension(:, :, :), pointer:: gradtkl_z

Gradient of variable kL with respect to direction z

real, public, dimension(:, :, :), pointer:: gradte_x

Gradient of variable turbulent energy dissiaption with respect to direction x

real, public, dimension(:, :, :), pointer:: gradte_y

Gradient of variable turbulent energy dissiaption with respect to direction y

real, public, dimension(:, :, :), pointer:: gradte_z

Gradient of variable turbulent energy dissiaption with respect to direction z

real, public, dimension(:, :, :), pointer:: gradtv_x

Gradient of variable turbulenct visocity(SA mode) with respect to direction x

real, public, dimension(:, :, :), pointer:: gradtv_y

Gradient of variable turbulenct visocity(SA mode) with respect to direction y

real, public, dimension(:, :, :), pointer:: gradtv_z

Gradient of variable turbulenct visocity(SA mode) with respect to direction z

real, public, dimension(:, :, :), pointer:: gradtgm_x

Gradient of variable intermittency with respect to direction x

real, public, dimension(:, :, :), pointer:: gradtgm_y

Gradient of variable intermittency with respect to direction y

real, public, dimension(:, :, :), pointer:: gradtgm_z

Gradient of variable intermittency with respect to direction z

integer, public :: accur =1

Switch for higher order boundary condition

character(len=4), public, dimension(6):: face_names

Store name of all six boundary faces

integer, public, dimension(6):: id

Store the boundary condition ID of all six faces

real, public :: c1

First coefficient user for higher order boundary condition

real, public :: c2

Second coefficient user for higher order boundary condition

real, public :: c3

Third coefficient user for higher order boundary condition

real, public, dimension(6):: fixed_density =0.

Density value to fix at particular boundary

real, public, dimension(6):: fixed_pressure =0.

Pressure value to fix at particular boundary

real, public, dimension(6):: fixed_x_speed =0.

X component of velocity to fix at particular boundary condition

real, public, dimension(6):: fixed_y_speed =0.

Y component of velocity to fix at particular boundary condition

real, public, dimension(6):: fixed_z_speed =0.

Z component of velocity to fix at particular boundary condition

real, public, dimension(6):: fixed_tk =0.

Turbulent kinetic energy value to fix at particular boundary condition

real, public, dimension(6):: fixed_tw =0.

Turbulent kinetic energy dissiaption rate value to fix at particular boundary condition(k-omega and SST model)

real, public, dimension(6):: fixed_te =0.

Turbulent kinetic energy dissiaption value to fix at particular boundary condition (K-eplision model)

real, public, dimension(6):: fixed_tv =0.

Turbulent viscosity varialble value to fix at particular boundary condition (for SA turbulence model)

real, public, dimension(6):: fixed_tkl =0.

(Turbulent kinetic energy x length) varialble value to fix at particular boundary condition (for k-kL turbulence model)

real, public, dimension(6):: fixed_tgm =0.

Fixed intermittency value to apply at particular boundary condition (for SST2003-gamma transition model)

real, public, dimension(6):: fixed_wall_temperature =0.

Fixed wall temperature value to apply at isothermal wall boundary condition.

real, public, dimension(6):: fixed_Tpressure =0.

Fixed Total Pressure value to apply at particular boundary condition

real, public, dimension(6):: fixed_Ttemperature =0.

Fixed Total Temperature value to apply at particular boundary condition

integer, public :: N_blocks

Total number of blocks

integer, public :: I_blocks

Total number of blocks in I direction

integer, public :: J_blocks

Total number of blocks in J direction

integer, public :: K_blocks

Total number of blocks in K direction

integer, public, dimension(:), allocatable:: imin
integer, public, dimension(:), allocatable:: imax
integer, public, dimension(:), allocatable:: jmin
integer, public, dimension(:), allocatable:: jmax
integer, public, dimension(:), allocatable:: kmin
integer, public, dimension(:), allocatable:: kmax
integer, public, dimension(6):: ilo

Store the lower and upper bound of the indecies of I loop for the interface mapping

integer, public, dimension(6):: ihi

Store the lower and upper bound of the indecies of I loop for the interface mapping

integer, public, dimension(6):: jlo

Store the lower and upper bound of the indecies of J loop for the interface mapping

integer, public, dimension(6):: jhi

Store the lower and upper bound of the indecies of J loop for the interface mapping

integer, public, dimension(6):: klo

Store the lower and upper bound of the indecies of K loop for the interface mapping

integer, public, dimension(6):: khi

Store the lower and upper bound of the indecies of K loop for the interface mapping

integer, public, dimension(6):: dir_switch =0

Switch for each boundary face. Activated only if ( for eg I-direction in the mapping is mapped with J-direction)

integer, public, dimension(6):: otherface

Store the face number with which the current interface is connected.

integer, public, dimension(:), allocatable:: make_F_flux_zero

Store zero to boundary face, which has wall ID, to make F flux zero

integer, public, dimension(:), allocatable:: make_G_flux_zero

Store zero to boundary face, which has wall ID, to make G flux zero

integer, public, dimension(:), allocatable:: make_H_flux_zero

Store zero to boundary face, which has wall ID, to make H flux zero

integer, public, dimension(6):: PbcId =-1

Block ID for Periodic boundary condition