DART-Ray
Functions/Subroutines | Variables
user_routines_galaxy Module Reference

Contains the subroutines to specify the stellar emission and dust density distribution for the analytical galaxy geometry. More...

Functions/Subroutines

subroutine read_input_galaxy
 Reads input file for the grid creation for the galaxy 2D model. More...
 
subroutine initialize_input_galaxy
 Initialize variables specific for the galaxy grid creation program. More...
 
subroutine check_lambda_list_galaxy
 Checks that lambda_arr contains at least two wavelengths of which one is equal to 0.443 um (B-band). This wavelength is necessary for calc_scaling_factors_dust() to work properly. More...
 
subroutine check_grid_type
 
subroutine calc_luminosities_pt11
 Calculates luminosity of the different stellar components depending on wavelength and intensity parameters old and sfr. The unit luminosities are those from Popescu et al. 2011. More...
 
subroutine calc_luminosities
 Calculates luminosity of the different stellar components depending on wavelength and intensity parameters old and sfr. The unit luminosities are those from the input files file_old_star_sed() and file_young_star_sed(). More...
 
subroutine calc_scaling_factors_stars
 
subroutine calc_scaling_factors_dust
 
subroutine interpolate_kext
 Interpolates value of kext given wavelength lambda. More...
 
real(kind=real64) function av_disk (x, y, z, cellsize, disk_comp, disk_type_ID)
 
real(kind=real64) function av_star_bulge (x, y, z, cellsize)
 
subroutine create_grid_arrays_galaxy
 
subroutine fix_dens_stars_arrays
 
subroutine print_3d_grid_file_galaxy
 
subroutine print_profiles_stars
 
subroutine set_galaxy_input
 
subroutine assign_dens_to_parent
 
subroutine read_stellar_sed
 Reads the input stellar emission SEDs in unit luminosities from the input files file_old_star_sed() and file_young_star_sed(). More...
 
subroutine assign_disk_type_id (disk_type, disk_type_ID)
 Assigns the right value of the disk_type_ID() depending on the input disk_type(). Using numbers instead of character variables is more efficient in IF statement and less error prone while modifying the code. More...
 

Variables

real(kind=real64) lambda_in
 
real(kind=real64) lambda_min
 
real(kind=real64) lambda_max
 
real(kind=real64) old
 
real(kind=real64) lnu_old
 
real(kind=real64) hs_disk_b
 
real(kind=real64) zs_disk
 
real(kind=real64) zs_disk_r1
 
real(kind=real64) zs_disk_rsun
 
real(kind=real64) hsin
 
real(kind=real64) hs_disk
 
real(kind=real64) hs_disk2
 
real(kind=real64) eta_disk0
 
real(kind=real64) chi_disk
 
real(kind=real64), dimension(:), allocatable hs_disk_arr
 
real(kind=real64), dimension(:), allocatable hs_disk2_arr
 
integer, dimension(:), allocatable id_hs_disk_arr
 
integer, parameter maxsize_hs_disk_arr = 1000
 
real(kind=real64) theta_disk_ellipt
 
real(kind=real64) sfr
 
real(kind=real64) lnu_sf
 
real(kind=real64) hs_tdisk
 
real(kind=real64) hs_tdisk2
 
real(kind=real64) zs_tdisk
 
real(kind=real64) hs1in
 
real(kind=real64) eta_tdisk0
 
real(kind=real64) zs_tdisk_r1
 
real(kind=real64) zs_tdisk_rsun
 
real(kind=real64) chi_tdisk
 
real(kind=real64) theta_tdisk_ellipt
 
real(kind=real64) reff
 
real(kind=real64) lnu_bulge
 
real(kind=real64) acap_bulge
 
real(kind=real64) ellipt
 
real(kind=real64) ellipt_xy
 
real(kind=real64) mtrunc
 
real(kind=real64) bd_ratio
 
real(kind=real64) eta_bulge0
 
integer nsersic
 
real(kind=real64) theta_bulge
 
real(kind=real64) lnu_tot
 
real(kind=real64) hd_disk
 
real(kind=real64) hd_disk2
 
real(kind=real64) zd_disk
 
real(kind=real64) zd_disk_r1
 
real(kind=real64) zd_disk_rsun
 
real(kind=real64) hdin
 
real(kind=real64) tau1
 
real(kind=real64) kext_disk0
 
real(kind=real64) chi_dust_disk
 
real(kind=real64) theta_dust_disk_ellipt
 
real(kind=real64) hd_tdisk
 
real(kind=real64) hd_tdisk2
 
real(kind=real64) zd_tdisk
 
real(kind=real64) hd1in
 
real(kind=real64) tau2
 
real(kind=real64) kext_tdisk0
 
real(kind=real64) zd_tdisk_r1
 
real(kind=real64) zd_tdisk_rsun
 
real(kind=real64) chi_dust_tdisk
 
real(kind=real64) theta_dust_tdisk_ellipt
 
real(kind=real64) rtrun
 
real(kind=real64) rsun
 
real(kind=real64) max_z
 
real(kind=real64) max_rad
 
real(kind=real64) sha
 
real(kind=real64) sha1
 
real(kind=real64) omega_max
 
integer, parameter lcar_type =30
 
character(len=lcar_typeold_disk_type
 
integer old_disk_type_id
 
character(len=lcar_typeyoung_disk_type
 
integer young_disk_type_id
 
character(len=lcar_typethick_disk_type
 
integer thick_disk_type_id
 
character(len=lcar_typethin_disk_type
 
integer thin_disk_type_id
 
character(len=lcar_typegrid_type
 
integer, parameter expr_expz_id = 0
 
integer, parameter expr_sech2z_id = 1
 
integer, parameter flared_expz_id = 2
 
integer, parameter flared_sech2z_id = 3
 
integer, parameter ellipt_expr_expz_id = 4
 
integer, parameter ellipt_expr_sech2z_id = 5
 
real(kind=real64), dimension(:), allocatable dens_disk
 
real(kind=real64), dimension(:), allocatable dens_tdisk
 
real(kind=real64), dimension(:), allocatable dens_bulge
 
real(kind=real64), dimension(:), allocatable dens_dust_disk
 
real(kind=real64), dimension(:), allocatable dens_dust_tdisk
 
real(kind=real64) omega_cell
 
integer, parameter step_int =10
 
character(len=lcar) file_old_star_sed
 
character(len=lcar) file_young_star_sed
 
real(kind=real64), dimension(:), allocatable lambda_arr_old_sed
 
integer nlambda_old_sed
 
real(kind=real64), dimension(:), allocatable lambda_arr_sf_sed
 
integer nlambda_sf_sed
 
real(kind=real64), dimension(:), allocatable lnu_old_unit
 
real(kind=real64), dimension(:), allocatable lnu_sf_unit
 
real(kind=real64) z_subd_lim
 
real(kind=real64) z_subd_lim2
 
real(kind=real64) r_subd_lim
 
character(len=lcar_typesubdivision_criteria
 

Detailed Description

Contains the subroutines to specify the stellar emission and dust density distribution for the analytical galaxy geometry.

Function/Subroutine Documentation

subroutine user_routines_galaxy::assign_dens_to_parent ( )

Here is the caller graph for this function:

subroutine user_routines_galaxy::assign_disk_type_id ( character(len=lcar_type disk_type,
integer  disk_type_ID 
)

Assigns the right value of the disk_type_ID() depending on the input disk_type(). Using numbers instead of character variables is more efficient in IF statement and less error prone while modifying the code.

Here is the caller graph for this function:

real(kind=real64) function user_routines_galaxy::av_disk ( real(kind=real64)  x,
real(kind=real64)  y,
real(kind=real64)  z,
real(kind=real64)  cellsize,
character(len=lcar_type disk_comp,
integer  disk_type_ID 
)

Here is the caller graph for this function:

real(kind=real64) function user_routines_galaxy::av_star_bulge ( real(kind=real64)  x,
real(kind=real64)  y,
real(kind=real64)  z,
real(kind=real64)  cellsize 
)

Here is the caller graph for this function:

subroutine user_routines_galaxy::calc_luminosities ( )

Calculates luminosity of the different stellar components depending on wavelength and intensity parameters old and sfr. The unit luminosities are those from the input files file_old_star_sed() and file_young_star_sed().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine user_routines_galaxy::calc_luminosities_pt11 ( )

Calculates luminosity of the different stellar components depending on wavelength and intensity parameters old and sfr. The unit luminosities are those from Popescu et al. 2011.

Here is the call graph for this function:

subroutine user_routines_galaxy::calc_scaling_factors_dust ( )

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine user_routines_galaxy::calc_scaling_factors_stars ( )

Here is the caller graph for this function:

subroutine user_routines_galaxy::check_grid_type ( )

Here is the caller graph for this function:

subroutine user_routines_galaxy::check_lambda_list_galaxy ( )

Checks that lambda_arr contains at least two wavelengths of which one is equal to 0.443 um (B-band). This wavelength is necessary for calc_scaling_factors_dust() to work properly.

Here is the caller graph for this function:

subroutine user_routines_galaxy::create_grid_arrays_galaxy ( )

Here is the caller graph for this function:

subroutine user_routines_galaxy::fix_dens_stars_arrays ( )

Here is the caller graph for this function:

subroutine user_routines_galaxy::initialize_input_galaxy ( )

Initialize variables specific for the galaxy grid creation program.

Here is the caller graph for this function:

subroutine user_routines_galaxy::interpolate_kext ( )

Interpolates value of kext given wavelength lambda.

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine user_routines_galaxy::print_3d_grid_file_galaxy ( )

Here is the caller graph for this function:

subroutine user_routines_galaxy::print_profiles_stars ( )

Here is the call graph for this function:

subroutine user_routines_galaxy::read_input_galaxy ( )

Reads input file for the grid creation for the galaxy 2D model.

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine user_routines_galaxy::read_stellar_sed ( )

Reads the input stellar emission SEDs in unit luminosities from the input files file_old_star_sed() and file_young_star_sed().

Here is the call graph for this function:

Here is the caller graph for this function:

subroutine user_routines_galaxy::set_galaxy_input ( )

Here is the call graph for this function:

Here is the caller graph for this function:

Variable Documentation

real(kind=real64) user_routines_galaxy::acap_bulge
Parameters
acap_bulgeInner truncation radius for the bulge profile
real(kind=real64) user_routines_galaxy::bd_ratio
Parameters
bd_ratioBulge-to-Disk luminosity ratio. Used to define luminosity scaling for the bulge, that is, bd_ratio*old*lnu_old.
real(kind=real64) user_routines_galaxy::chi_disk
Parameters
chi_diskParameter used in the "flared" profile to specify the steepness of the radial profile within the inner radius hsin().
real(kind=real64) user_routines_galaxy::chi_dust_disk
Parameters
chi_dust_diskParameter used in the "flared" profile to specify the steepness of the radial profile within the inner radius hdin().
real(kind=real64) user_routines_galaxy::chi_dust_tdisk
Parameters
chi_dust_tdiskParameter used in the "flared" profile to specify the steepness of the radial profile within the inner radius hd1in().
real(kind=real64) user_routines_galaxy::chi_tdisk
Parameters
chi_tdiskParameter used in the "flared" profile to specify the steepness of the radial profile within the inner radius hs1in().
real(kind=real64), dimension(:), allocatable user_routines_galaxy::dens_bulge
Parameters
dens_bulgeVolume emissivity for the bulge.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::dens_disk
Parameters
dens_diskVolume emissivity for the old stellar disk.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::dens_dust_disk
Parameters
dens_dust_diskDust density for the thick dust disk.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::dens_dust_tdisk
Parameters
dens_dust_tdiskDust density for the thin dust disk.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::dens_tdisk
Parameters
dens_tdiskVolume emissivity for the young stellar disk.
real(kind=real64) user_routines_galaxy::ellipt
Parameters
elliptBulge ellipticity. The normalized radial coordinate m for the bulge volume emissivity is defined as

\[ m=\sqrt{R^2 + (z/ellipt)^2}/ R_{eff} \]

integer, parameter user_routines_galaxy::ellipt_expr_expz_id = 4
integer, parameter user_routines_galaxy::ellipt_expr_sech2z_id = 5
real(kind=real64) user_routines_galaxy::ellipt_xy
Parameters
ellipt_xyBulge XY ellipticity. The radial coordinate R for the bulge volume emissivity is defined as

\[ R=\sqrt{x^2 + (y/ellipt_{xy})^2} \]

real(kind=real64) user_routines_galaxy::eta_bulge0
Parameters
eta_bulge0Central value of the bulge volume emissivity.
real(kind=real64) user_routines_galaxy::eta_disk0
Parameters
eta_disk0Central value of the old stellar disk volume emissivity.
real(kind=real64) user_routines_galaxy::eta_tdisk0
Parameters
eta_tdisk0Central value of the young stellar disk volume emissivity.
integer, parameter user_routines_galaxy::expr_expz_id = 0
integer, parameter user_routines_galaxy::expr_sech2z_id = 1
character(len=lcar) user_routines_galaxy::file_old_star_sed
Parameters
file_old_star_sedFile containing the SED to be used by the old stellar components in units luminosities to be multiplied by the OLD parameter.
character(len=lcar) user_routines_galaxy::file_young_star_sed
Parameters
file_young_star_sedFile containing the SED to be used by the young stellar components in units luminosities to be multiplied by the SFR parameter.
integer, parameter user_routines_galaxy::flared_expz_id = 2
integer, parameter user_routines_galaxy::flared_sech2z_id = 3
character(len=lcar_type) user_routines_galaxy::grid_type
Parameters
Specifywhich stellar emission components have to be included: 'all'= all components; 'disk' = only old stellar disk; 'tdisk' = only thin stellar disk; 'bulge' = only bulge component.
real(kind=real64) user_routines_galaxy::hd1in
Parameters
hd1inInner radius for the thin dust disk.
real(kind=real64) user_routines_galaxy::hd_disk
Parameters
hd_diskScale length of the thick dust disk or X'-axis scale length in the case of the ellipsoidal exponential profile
real(kind=real64) user_routines_galaxy::hd_disk2
Parameters
hd_disk2Y'-axis thick dust disk scale length for the ellipsoidal exponential profile.
real(kind=real64) user_routines_galaxy::hd_tdisk
Parameters
hd_tdiskScale length of the thin dust disk or X'-axis scale length for the ellipsoidal exponential profile.
real(kind=real64) user_routines_galaxy::hd_tdisk2
Parameters
hd_tdisk2Y'-axis thin dust disk scale length for the ellipsoidal exponential profile.
real(kind=real64) user_routines_galaxy::hdin
Parameters
hdinInner radius for the thick dust disk.
real(kind=real64) user_routines_galaxy::hs1in
Parameters
hs1inInner radius of the young stellar disk.
real(kind=real64) user_routines_galaxy::hs_disk
Parameters
hs_diskOld disk scale length or X'-axis scale length if elliptical exponential model is used.
real(kind=real64) user_routines_galaxy::hs_disk2
Parameters
hs_disk2Y'-axis old disk scale length for the elliptical exponential model.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::hs_disk2_arr
Parameters
hs_disk2_arrSame as hs_disk_arr() but for the Y'-axis scale length required in the elliptical exponential disk profile type.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::hs_disk_arr
Parameters
hs_disk_arrScale lenghts values for the old stellar disk at each wavelength of the input wavelength grid. In the case of the elliptical exponential profile, this is the X'-axis scale length. By default, all values are set equal to hs_disk_b. If different values are required, hs_disk_arr can be specified in the input. The wavelength indeces of the input hs_disk values have to be specified in id_hs_disk_arr()
real(kind=real64) user_routines_galaxy::hs_disk_b
Parameters
hs_disk_bB-band (4430 A) old stellar disk scale length.
real(kind=real64) user_routines_galaxy::hs_tdisk
Parameters
hs_tdiskScale length of the young stellar disk or, in the case of the ellipsoidal exponential profile, X'-axis scale length
real(kind=real64) user_routines_galaxy::hs_tdisk2
Parameters
hs_tdisk2Y'-axis young stellar disk scale length for the ellipsoidal esponential profile.
real(kind=real64) user_routines_galaxy::hsin
Parameters
hsinInner radius of the old stellar disk.
integer, dimension(:), allocatable user_routines_galaxy::id_hs_disk_arr
Parameters
id_hs_disk_arrWavelength grid indeces of the values of hs_disk specified in the input hs_disk_arr() and hs_disk2_arr().
real(kind=real64) user_routines_galaxy::kext_disk0
Parameters
kext_disk0Central value for the thick dust disk density profile.
real(kind=real64) user_routines_galaxy::kext_tdisk0
Parameters
kext_tdisk0Central value for the thin dust disk density profile.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::lambda_arr_old_sed
Parameters
lambda_arr_old_sedWavelength array in [um] for the old stellar luminosity sed
real(kind=real64), dimension(:), allocatable user_routines_galaxy::lambda_arr_sf_sed
Parameters
lambda_arr_sf_sedWavelength array in [um] for the young stellar luminosity sed
real(kind=real64) user_routines_galaxy::lambda_in
Parameters
lambda_inWavelength variable
real(kind=real64) user_routines_galaxy::lambda_max
Parameters
lambda_maxMaximum wavelength used in the calculation of the lambda grids.
real(kind=real64) user_routines_galaxy::lambda_min
Parameters
lambda_minMinimum wavelength used in the calculation of the lambda grids.
integer, parameter user_routines_galaxy::lcar_type =30
Parameters
lcar_typeString variable length parameter.
real(kind=real64) user_routines_galaxy::lnu_bulge
Parameters
lnu_bulgeBulge volume emissivity.
real(kind=real64) user_routines_galaxy::lnu_old
Parameters
lnu_oldOld stellar luminosity spectra.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::lnu_old_unit
Parameters
lnu_old_unitOld stellar luminosity sed in unit luminosities for the old() parameter.
real(kind=real64) user_routines_galaxy::lnu_sf
Parameters
lnu_sfYoung stellar disk luminosity.
real(kind=real64), dimension(:), allocatable user_routines_galaxy::lnu_sf_unit
Parameters
lnu_sf_unitYoung stellar luminosity sed in unit luminosities for the young() parameter.
real(kind=real64) user_routines_galaxy::lnu_tot
Parameters
lnu_totModel total luminosity.
real(kind=real64) user_routines_galaxy::max_rad
Parameters
max_radMaximum R allowed for non zero stellar emissivity and dust density.
real(kind=real64) user_routines_galaxy::max_z
Parameters
max_zMaximum |z| allowed for non zero stellar emissivity and dust density.
integer, parameter user_routines_galaxy::maxsize_hs_disk_arr = 1000
Parameters
maxsize_hs_disk_arrMaximum number of input values in hs_disk_arr() and hs_disk2_arr()
real(kind=real64) user_routines_galaxy::mtrunc
Parameters
mtruncOutern truncation radius for the bulge in units of effective radii.
integer user_routines_galaxy::nlambda_old_sed
Parameters
nlambda_old_sedNumber of elements in lambda_arr_old_sed()
integer user_routines_galaxy::nlambda_sf_sed
Parameters
nlambda_sf_sedNumber of elements in lambda_arr_sf_sed()
integer user_routines_galaxy::nsersic
Parameters
nsersicBulge sersic index (see inside subroutine av_star_bulge() for the volume emissivity formula used in each case).
real(kind=real64) user_routines_galaxy::old
Parameters
oldScaling factor applied to the input old stellar luminosity spectra.
character(len=lcar_type) user_routines_galaxy::old_disk_type
Parameters
old_disk_typeOld stellar disk profile type. Possible choices:
  • 'expR_expz' :

    \[ \rho = \rho_o exp(-R/hs -|z|/z_s) \]

  • 'expR_sech2z':

    \[ \rho(R,z) = \rho_o exp(-R/hs)sech^2(|z|/z_s) \]

  • 'flared_expz':

    \[ \gamma = log(\frac{zs(R_{sun})-zs(0)}{zs(R1)-zs(0)})/log(\frac{R_{sun}}{R1}) \]

    \[ zs(R)=zs(0)+(zs(R1)-zs(0))*(R/R1)^{\gamma} \]

    \[ \rho(R,z) = \rho_o [\frac{R}{R1}*(1-\chi) + \chi]*\frac{zs(0)}{zs(R)}*exp(-\frac{R1}{hs})*exp(-\frac{|z|}{zs(R)})\qquad if ~ R < R1 \]

    \[ \rho(R,z) = \rho_o \frac{zs(0)}{zs(R)}*exp(-\frac{R}{hs})*exp(-\frac{|z|}{zs(R)}) \qquad if ~ R \ge R1 \]

  • 'flared_sech2z': as 'flared_expz' but with $sech^2(\frac{|z|}{zs(R)})$ instead of $exp(-\frac{|z|}{zs(R)})$;
  • 'ellipt_expR_expz': $zs(R)$ and $\gamma$ defined as for 'flared_expz'

    \[ \rho(x,y,z) = \rho_o \frac{zs(0)}{zs(R)}*exp\left(-\sqrt{(\frac{x}{hs})^2+ (\frac{y}{hs2})^2}\right)*exp(-\frac{|z|}{zs(R)}) \qquad if ~ R < R1 \]

    \[ \rho(x,y,z) = 0 \qquad if ~ R \ge R1 \]

  • 'ellipt_expR_sech2z': as 'ellipt_expR_expz' but with $sech^2(\frac{|z|}{zs(R)})$ instead of $exp(-\frac{|z|}{zs(R)})$.
integer user_routines_galaxy::old_disk_type_id
Parameters
old_disk_type_IDID number for old_disk_type().
real(kind=real64) user_routines_galaxy::omega_cell
Parameters
Solidangle subtended by a cell
real(kind=real64) user_routines_galaxy::omega_max
Parameters
omega_maxMaximum subtended solid angle of a cell seen from the position (rsun(), 0,0). To use this variable you have to make sure that the corresponding line in the function subdivision is used while compiling the program.
real(kind=real64) user_routines_galaxy::r_subd_lim
Parameters
R_subd_limR coordinate below which cells have to be subdivided if their z is less than z_subd_lim()
real(kind=real64) user_routines_galaxy::reff
Parameters
reffBulge effective radius.
real(kind=real64) user_routines_galaxy::rsun
Parameters
rsunThird radial position used in the "flared" profile. Called rsun because it has been used to set the sun position in Milky Way model.
real(kind=real64) user_routines_galaxy::rtrun
Parameters
rtrunRadial truncation radius for all disks.
real(kind=real64) user_routines_galaxy::sfr
Parameters
sfrScaling factor applied to the young stellar disk luminosity spectra.
real(kind=real64) user_routines_galaxy::sha
Parameters
shaFactor determining the sharpness of the profiles close to the truncation radius rtrun(). The profile goes to zero within a radial interval equal to sha() in units of rtrun(). This factor is for the thick stellar and dust disks.
real(kind=real64) user_routines_galaxy::sha1
Parameters
sha1Factor determining the sharpness of the profiles close to the truncation radius rtrun(). The profile goes to zero within a radial interval equal to sha1() in units of rtrun(). This factor is for the thin stellar and dust disks.
integer, parameter user_routines_galaxy::step_int =10
character(len=lcar_type) user_routines_galaxy::subdivision_criteria
Parameters
subdivision_criteriaSubdivision criteria to be used. Choices are:
  • 'standard': subdivision IF subdivision level < max_lvl() AND (cell optical depth > max_dtau() OR stellar disk luminosity > max_dlum()*total luminosity OR subdivision level < min_lvl() OR (ABS(z) < z_subd_lim AND R < R_subd_lim())) 'milky way' : subdivision IF subdivision level < max_lvl() AND (cell optical depth > max_dtau() OR stellar disk luminosity > max_dlum()*total luminosity OR subdivision level < min_lvl() OR (ABS(z) < z_subd_lim AND R < R_subd_lim()) OR (cell subtended solid angle from position (rsun(), 0,0) > omega_max AND ABS(z)-half cell size < z_subd_lim2))
real(kind=real64) user_routines_galaxy::tau1
Parameters
tau1B-band (4430 A) central face-on optical depth of the thick dust disk in the case of the pure exponential profile. In the case of the flared profiles, this is the optical depth one would have if the exponential radial profile for R>R1 would continue until R=0.
real(kind=real64) user_routines_galaxy::tau2
Parameters
tau2B-band (4430 A) central face-on optical depth of the thin dust disk in the case of the pure exponential profile. Other profiles still use this factor to set the dust density although its meaning is different.
real(kind=real64) user_routines_galaxy::theta_bulge
Parameters
theta_bulgeRotation angle around the Z-axis for the bulge profile.
real(kind=real64) user_routines_galaxy::theta_disk_ellipt
Parameters
theta_disk_elliptRotation angle around the Z-axis for the elliptical exponential profile for the old stellar component [deg]
real(kind=real64) user_routines_galaxy::theta_dust_disk_ellipt
Parameters
theta_dust_disk_elliptRotation angle around the Z-axis for the elliptical exponential profile for the thick dust disk component [deg].
real(kind=real64) user_routines_galaxy::theta_dust_tdisk_ellipt
Parameters
theta_dust_tdisk_elliptRotation angle around the Z-axis for the elliptical exponential profile for the thin dust disk component [deg].
real(kind=real64) user_routines_galaxy::theta_tdisk_ellipt
Parameters
theta_tdisk_elliptRotation angle around the Z-axis for the elliptical exponential profile for the young stellar component [deg].
character(len=lcar_type) user_routines_galaxy::thick_disk_type
Parameters
thick_disk_typeThick dust disk profile type. Same choices as for old_disk_type().
integer user_routines_galaxy::thick_disk_type_id
Parameters
thick_disk_type_IDID number for thick_disk_type().
character(len=lcar_type) user_routines_galaxy::thin_disk_type
Parameters
thin_disk_typeThin dust disk profile type. Same choices as for old_disk_type().
integer user_routines_galaxy::thin_disk_type_id
Parameters
thin_disk_type_IDID number for thin_disk_type().
character(len=lcar_type) user_routines_galaxy::young_disk_type
Parameters
young_disk_typeYoung stellar disk profile type. Same choices as for old_disk_type().
integer user_routines_galaxy::young_disk_type_id
Parameters
young_disk_type_IDID number for young_disk_type().
real(kind=real64) user_routines_galaxy::z_subd_lim
Parameters
z_subd_limZ coordinate below which cells have to be subdivided if their R is less than R_subd_lim()
real(kind=real64) user_routines_galaxy::z_subd_lim2
Parameters
z_subd_lim2Z coordinate used in the 'milky_way' subdivision criteria to limit the subdivisions of cells with small subtended solid angle from the position (rsun(), 0,0). See subdivision_criteria().
real(kind=real64) user_routines_galaxy::zd_disk
Parameters
zd_diskScale height for the thick dust disk (basic value).
real(kind=real64) user_routines_galaxy::zd_disk_r1
Parameters
zd_disk_r1Scale height for the thick dust disk at the inner radius hdin().
real(kind=real64) user_routines_galaxy::zd_disk_rsun
Parameters
zd_disk_rsunScale height for the thick dust disk at the radius rsun().
real(kind=real64) user_routines_galaxy::zd_tdisk
Parameters
zd_tdiskScale height for the thin dust disk (basic value).
real(kind=real64) user_routines_galaxy::zd_tdisk_r1
Parameters
zd_tdisk_r1Scale height for the thin dust disk at the inner radius hd1in().
real(kind=real64) user_routines_galaxy::zd_tdisk_rsun
Parameters
zd_tdisk_rsunScale height for the thin dust disk at the radius rsun().
real(kind=real64) user_routines_galaxy::zs_disk
Parameters
zs_diskScale height for the old stellar disk (basic value).
real(kind=real64) user_routines_galaxy::zs_disk_r1
Parameters
zs_disk_r1Scale height for the old stellar disk at the inner radius hsin().
real(kind=real64) user_routines_galaxy::zs_disk_rsun
Parameters
zs_disk_rsunScale height for the old stellar disk at the radius rsun().
real(kind=real64) user_routines_galaxy::zs_tdisk
Parameters
zs_tdiskScale height of the young stellar disk (basic value).
real(kind=real64) user_routines_galaxy::zs_tdisk_r1
Parameters
zs_tdisk_r1Scale height of the young stellar disk at the inner radius hs1in().
real(kind=real64) user_routines_galaxy::zs_tdisk_rsun
Parameters
zs_tdisk_rsunScale height of the young stellar disk at the radius rsun().