![]() |
CosmoBolognaLib
Free Software C++/Python libraries for cosmological calculations
|
#include "Headers/Cosmology.h"
Public Member Functions | |
Constructors/destructors | |
Cosmology (const double Omega_matter=0.27, const double Omega_baryon=0.046, const double Omega_neutrinos=0., const double massless_neutrinos=3.04, const int massive_neutrinos=0, const double Omega_DE=0.73, const double Omega_radiation=0., const double hh=0.7, const double scalar_amp=2.46e-9, const double scalar_pivot=0.05, const double n_spec=0.96, const double w0=-1., const double wa=0., const double fNL=0., const int type_NG=1, const double tau=0.09, const std::string model="LCDM", const bool unit=true) | |
constructor More... | |
Cosmology (const CosmologicalModel cosmoModel, const std::string model="LCDM", const bool unit=true) | |
constructor using built-in cosmological models More... | |
~Cosmology ()=default | |
default destructor | |
Functions to get the private members of the class | |
double | value (const CosmologicalParameter parameter) const |
get the private member specified by the enum CosmologicalParameter More... | |
double | Omega_matter () const |
get the private member Cosmology::m_Omega_matter More... | |
double | Omega_baryon () const |
get the private member Cosmology::m_Omega_baryon More... | |
double | Omega_neutrinos () const |
get the private member Cosmology::m_Omega_neutrinos More... | |
double | massless_neutrinos () const |
get the private member Cosmology::m_massless_neutrinos More... | |
int | massive_neutrinos () const |
get the private member Cosmology::m_massive_neutrinos More... | |
double | Omega_DE () const |
get the private member Cosmology::m_Omega_DE More... | |
double | Omega_radiation () const |
get the private member Cosmology::m_Omega_radiation More... | |
double | Omega_k () const |
get the private member Cosmology::m_Omega_k More... | |
double | Omega_CDM () const |
get the private member Cosmology::m_Omega_CDM More... | |
double | H0 () const |
get the private member Cosmology::m_H0 More... | |
double | hh () const |
get the private member Cosmology::m_hh More... | |
double | t_H () const |
get the private member Cosmology::m_t_H More... | |
double | D_H () const |
get the private member Cosmology::m_D_H More... | |
double | sigma8 () const |
get the private member Cosmology::m_sigma8 More... | |
double | scalar_amp () const |
get the private member Cosmology::m_scalar_amp More... | |
double | scalar_pivot () const |
get the private member Cosmology::m_scalar_pivot More... | |
double | n_spec () const |
get the private member Cosmology::m_n_spec More... | |
double | w0 () const |
get the private member Cosmology::m_w0 More... | |
double | wa () const |
get the private member Cosmology::m_wa More... | |
double | RhoZero () const |
get the private member Cosmology::m_RhoZero More... | |
double | fNL () const |
get the private member Cosmology::m_fNL More... | |
int | type_NG () const |
get the private member Cosmology::m_type_NG More... | |
double | tau () const |
get the private member Cosmology::m_tau More... | |
double | rs () const |
get the sound horizon at recombination More... | |
double | Pk0_EH () const |
get the private member Cosmology::m_Pk0_EH More... | |
double | Pk0_CAMB () const |
get the private member Cosmology::m_Pk0_CAMB More... | |
double | Pk0_MPTbreeze () const |
get the private member Cosmology::m_Pk0_MPTbreeze More... | |
double | Pk0_CLASS () const |
get the private member Cosmology::m_Pk0_CLASS More... | |
std::string | model () const |
get the private member Cosmology::m_model More... | |
bool | unit () const |
get the private member Cosmology::m_unit More... | |
void | print_parameters () const |
print the values of the private members on the screen | |
Functions to set the private members of the class | |
void | set_parameter (const CosmologicalParameter parameter, const double value) |
set the value of one cosmological paramter More... | |
void | set_parameters (const std::vector< CosmologicalParameter > parameter, const std::vector< double > value) |
set the value of some cosmological paramters More... | |
void | set_Omega_all (const double OmegaB, const double OmegaCDM, const double OmegaNu, const double OmegaR, const double OmegaDE) |
set the value of \(\Omega_{\rm b}\), \(\Omega_{\rm cdm}\), \(\Omega_{\nu}\), \(\Omega_{\rm rad}\), \(\Omega_{\rm DE}\), and consequently the values of More... | |
void | set_Omega (const double Omega_matter=0.27) |
set the value of ΩM, keeping ΩDE=1-ΩM-Ωrad-Ωk More... | |
void | set_OmegaB (const double Omega_baryon=0.046) |
set the value of Ωb, keeping ΩCDM=ΩM-Ωb More... | |
void | set_OmegaB_h2 (const double Omega_baryonh2=0.0222) |
set the value of Ωb, keeping ΩCDM=ΩM-Ωb More... | |
void | set_OmegaM (const double Omega_matter=0.27) |
set the value of ΩM More... | |
void | set_OmegaDE (const double Omega_DE=0.73) |
set the value of ΩDE More... | |
void | set_OmegaNu (const double Omega_neutrinos=0., const double massless_neutrinos=3.04, const int massive_neutrinos=0) |
set the value of Ων More... | |
void | set_Omega_radiation (const double Omega_radiation) |
set the private member Cosmology::m_Omega_radiation More... | |
void | set_hh (const double hh=0.7, const bool warn=true) |
set the value of h More... | |
void | set_H0 (const double H0=70., const bool warn=true) |
set the value of H0 More... | |
void | set_sigma8 (const double sigma8=-1.) |
set the value of σ8 More... | |
void | set_scalar_amp (const double scalar_amp=2.46e-9) |
set the value of As More... | |
void | set_scalar_pivot (const double scalar_pivot=0.05) |
set the value of the scalar pivot More... | |
void | set_n_spec (const double n_spec) |
set the value of nspec More... | |
void | set_w0 (const double w0=-1.) |
set the value of w0 More... | |
void | set_wa (const double wa=0.) |
set the value of wa More... | |
void | set_RhoZero (const double RhoZero=7.5e10) |
set the value of ρ0 More... | |
void | set_fNL (const double fNL=0.) |
set the value of fNL More... | |
void | set_type_NG (const int type_NG=1) |
set the value of the non-Gaussian shape More... | |
void | set_tau (const double tau=0.09) |
set the value of the τ More... | |
void | set_rs (const double rs=-1) |
set the value of the \(r_s\); More... | |
void | set_model (const std::string model="LCDM") |
set the cosmologial model used to compute distances More... | |
void | set_unit (const bool unit=true) |
set the value of unit More... | |
Functions to estimate general cosmological parameters | |
double | OmegaM (const double redshift=0.) const |
the matter density at a given redshift More... | |
double | OmegaDE (const double redshift=0.) const |
the dark energy density at a given redshift More... | |
double | OmegaR (const double redshift=0.) const |
the radiation density at a given redshift More... | |
double | OmegaR_zeq (const double z_eq=3395.) const |
the radiation density, as a function of the redshift of radiation-matter equality More... | |
double | OmegaNu (const double redshift=0.) const |
the neutrino density at a given redshift More... | |
double | OmegaK (const double redshift=0.) const |
the density of curvature energy at a given redshift More... | |
double | Omega (const double redshift=0.) const |
the cosmic density at a given redshift More... | |
double | Omega_neutrinos (const double Mnu) const |
the density of massive neutrinos, given the neutrino mass More... | |
double | neutrino_mass () const |
the total neutrino mass More... | |
double | rho_crit (const double redshift, const bool unit1=false) const |
the critical cosmic density More... | |
double | rho_m (const double redshift=0., const bool unit1=false, const bool nu=false) const |
the mean cosmic background density More... | |
double | Delta_c (const double redshift, const std::string author="BryanNorman") const |
the critical overdensity More... | |
double | M_vir (const double r_vir, const double redshift, const std::string author="BryanNorman", const bool unit1=false) const |
the virial mass, given the virial radius and the redshift More... | |
double | r_vir (const double M_vir, const double redshift, const std::string author="BryanNorman", const bool unit1=false) const |
the virial radius, given the virial mass and the redshift More... | |
double | w_CPL (const double redshift=0.) const |
the DE equation of state in the CPL parameterisation, as a function of redshift More... | |
double | f_DE (const double redshift=0.) const |
auxiliary function used to compute the Hubble function More... | |
double | EE (const double redshift=0.) const |
auxiliary function used to compute the Hubble function More... | |
double | EE_inv (const double redshift=0.) const |
inverse of the auxiliary function used to compute the Hubble function integrand of the comoving distance More... | |
double | EE_inv2 (const double redshift=0.) const |
inverse of the auxiliary function used to compute the Hubble function, integrand of the lookback time More... | |
double | EE_inv3 (const double aa) const |
inverse of the auxiliary function used to compute the Hubble function integrand of the cosmic time More... | |
double | HH (const double redshift=0.) const |
the Hubble function More... | |
double | DN (const double redshift, const double redshift_norm=0., const double prec=1.e-4) const |
the normalised amplitude of the growing mode at a given redshift, \(D(z)/D(0)\) More... | |
double | DD (const double redshift) const |
the amplitude of the growing mode at a given redshift, \(D(z)\) More... | |
double | gg (const double redshift=0.) const |
the linear growth factor at a given redshift, \(g(z)\) More... | |
double | sigma8 (const double redshift) const |
σ8 at a given redshift More... | |
double | lookback_time (const double redshift=0.) const |
lookback time at a given redshift More... | |
double | cosmic_time (const double redshift=0.) const |
cosmic time at a given redshift More... | |
double | EE2 (const double redshift=0.) const |
auxiliary function used to compute the deceleration parameter More... | |
double | qq (const double redshift=0.) const |
the deceleration parameter at a given redshift More... | |
double | Hdot (const double redshift=0.) const |
derivative of the Hubble function at a given redshift More... | |
double | z_decoupling () const |
redshift at wich occurs baryon photon decoupling More... | |
double | z_drag () const |
redshift of drag epoch More... | |
double | z_acc () const |
redshift at which the Universe begins to accelerate More... | |
double | z_eq () const |
redshift of matter-dark energy equality More... | |
double | z_eq_rad (const double T_CMB=2.7255) const |
redshift of matter-radiation equality More... | |
double | sound_speed (const double redshift, const double T_CMB=2.7255) const |
the sound speed More... | |
double | rs_integrand (const double redshift, const double T_CMB=2.7255) const |
the sound horizon integrand More... | |
double | rs (const double redshift, const double T_CMB=2.7255) const |
the sound horizon More... | |
double | Mag_Volume_limited (const double z_max=1., const double mag_lim=-20.) const |
maximum absolute magnitude to have a volume-limited catalogue More... | |
double | Lum_bol (const double redshift=0., const double flux=1.) const |
bolometric luminosity More... | |
double | Redshift (const double d_c=1., const double z1_guess=0., const double z2_guess=10., const double prec=0.0001) const |
redshift at a given comoving distance More... | |
double | Redshift_LCDM (const double d_c=1., const double z1_guess=0., const double z2_guess=10., const bool go_fast=1, const double prec=0.0001) const |
redshift at a given comoving distance More... | |
double | Redshift (const double mm, const double redshift, const double ff, const std::string method_SS, const double wwf, const bool store_output=true, const std::string output_root="test") const |
redshift at a given wf More... | |
double | Redshift_time (const double time, const double z1_guess, const double z2_guess) const |
redshift at a given cosmic time More... | |
double | deltac (const double redshift) const |
spherical collapse density threshold at a given redshift More... | |
double | deltav_L (const double deltav_NL, const double b_eff, double slope=0.854, double offset=0.420) const |
Linear (under)density contrast. More... | |
double | deltav_NL (const double deltav=-2.71) const |
Non-Linear (under)density contrast. More... | |
double | r_rL (const double deltav=-2.71) const |
expansion factor More... | |
Functions to estimate cosmological distances and volumes | |
double | D_C (const double redshift) const |
the comoving line-of-sight distance at a given redshift More... | |
double | D_C_LCDM (const double redshift) const |
the comoving line-of-sight distance at a given redshift More... | |
void | D_C_table (const std::string file_table, const double z_min, const double z_max, const int step, std::vector< double > &Redshift, std::vector< double > &dc) const |
create a table of [redshift, comoving line-of-sight distance] More... | |
double | D_M (const double redshift) const |
the comoving transverse distance at a given redshift More... | |
double | D_A (const double redshift) const |
the angular diameter distance at a given redshift More... | |
double | D_A (const double z1, const double z2) const |
the angular diameter distance between objects at two redshifts More... | |
double | D_L (const double redshift) const |
the luminosity distance at a given redshift More... | |
double | D_V (const double redshift) const |
the average distance at a given redshift, used to rescale the correlation function More... | |
double | F_AP (const double redshift) const |
F_AP, the ALCOCK-PACZYNSKI distortion parameter. More... | |
double | Distance (const double redshift, const std::string distance_type) const |
the distance at a given redshift More... | |
double | Volume (const double z1, const double z2, const double Area) const |
comoving volume for a given redshift range and sky area More... | |
double | Volume (const double z1, const double z2, const double RA_min, const double RA_max, const double Dec_min, const double Dec_max) const |
comoving volume for a given redshift range and R.A.-Dec limits More... | |
double | Volume (const double zz) const |
total comoving volume from z=0 to z More... | |
double | max_redshift (const double Volume, const double Area, const double z_min) const |
maximum redshift for a given volume, sky area and minimum redshift More... | |
double | dV_dZdOmega (const double redshift, const bool angle_rad) const |
the derivative of the comoving volume, d2V/(dz*dΩ) at a given redshift More... | |
Functions to estimate the halo mass function and related quantities | |
std::string | create_grid_sigmaM (const std::string method_SS, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
auxiliary function to create a grid file with σ(M) More... | |
double | mass_function (const double Mass, const double redshift, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool default_delta=true, const double delta_t=1.686) |
the mass function of dark matter haloes (filaments and sheets) More... | |
double | mass_function_fR (const double Mass, const double redshift, const std::string model_MF, const double f_R0=0., const bool store_output=true, const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool default_delta=true, const double delta_t=1.686) |
the mass function of dark matter haloes in f(R) cosmologies (see Hu & Sawicki 2007) computed with the Boltzmann solver MGCAMB More... | |
double | mass_function_fast (const double Mass, const double redshift, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the mass function of dark matter haloes (filaments and sheets) computed quickly using a grid More... | |
double | mass_function (const double Mass, const double Sigma, const double Dln_Sigma, const double redshift, const std::string model_MF, const bool store_output=true, const std::string output_root="test", const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string method_SS="CAMB", const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the mass function of dark matter haloes (filaments and sheets) computed quickly passing directly the mass variance and its derivative as inputs More... | |
double | mass_function (const double Mass, const double Sigma, const double Dln_Sigma, const double redshift, const double D_N, const std::string model_MF, const bool store_output=true, const std::string output_root="test", const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string method_SS="CAMB", const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the mass function of dark matter haloes (filaments and sheets) computed quickly passing directly the mass variance and its derivative as inputs More... | |
std::vector< double > | mass_function (const std::vector< double > Mass, const std::vector< double > Sigma, const std::vector< double > Dln_Sigma, const double redshift, const std::string model_MF, const bool store_output=true, const std::string output_root="test", const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string method_SS="CAMB", const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the mass function of dark matter haloes (filaments and sheets) computed quickly passing directly the mass variance and its derivative as inputs. This function takes vector in input and compute the mass function for the input masses More... | |
double | n_haloes (const double Mass_min, const double Mass_max, const double z_min, const double z_max, const bool angle_rad, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
number of dark matter haloes per steradian or square degree, for a given redshift range More... | |
double | n_haloes (const double Mass_min, const double Mass_max, const double Volume, const double redshift, const std::string model_MF, const std::string method_SS, const int nbin_mass=0, const bool store_output=true, const std::string output_root="test", const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool default_delta=true, const double delta_t=1.686) |
number of dark matter haloes per volume at fixed redshift More... | |
double | n_haloes_selection_function (const double Mass_min, const double Mass_max, const double z_min, const double z_max, const bool angle_rad, const std::string model_MF, const std::string method_SS, const std::string selection_function_file, const std::vector< int > column={}, const bool store_output=true, const std::string output_root="test", const double Delta=200, const bool isDelta_critical=false, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
number of dark matter haloes per steradian or square degree, for a given redshift range and with selection function defined on a grid More... | |
std::vector< double > | mass_function (const std::vector< double > mass, const double z_min, const double z_max, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200, const bool isDelta_critical=false, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
mass function for a range of masses More... | |
std::vector< double > | mass_function_selection_function_vector (const std::vector< double > mass, const double z_min, const double z_max, const std::string model_MF, const std::string method_SS, const std::string selection_function_file, const std::vector< int > column={}, const bool store_output=true, const std::string output_root="test", const double Delta=200, const bool isDelta_critical=false, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
mass function given a selection function More... | |
std::vector< double > | redshift_distribution_haloes (const double z_min, const double z_max, const int step_z, const double Area_degrees, const double Mass_min, const double Mass_max, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200, const bool isDelta_critical=false, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
redshift distribution of dark matter haloes More... | |
std::vector< double > | redshift_distribution_haloes_selection_function (const std::vector< double > redshift, const double Area_degrees, const double Mass_min, const double Mass_max, const std::string model_MF, const std::string method_SS, const std::string selection_function_file, const std::vector< int > column={}, const bool store_output=true, const std::string output_root="test", const double Delta=200, const bool isDelta_critical=false, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
redshift distribution of dark matter haloes, given a selection function More... | |
double | mean_redshift_haloes_selection_function (const double z_min, const double z_max, const double Mass_min, const double Mass_max, const std::string model_MF, const std::string method_SS, const std::string selection_function_file, const std::vector< int > column={}, const bool store_output=true, const std::string output_root="test", const double Delta=200, const bool isDelta_critical=false, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the mean redshift of a dark matter haloe sample, given a selection function More... | |
double | MhaloMin (const int n_halo, const double Area, const bool angle_rad, const double z_min, const double z_max, const double Mmax, const double lgM1_guess, const double lgM2_guess, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200, const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
minimum halo mass, given the number of haloes in a given region of sky More... | |
double | converted_mass (const double mass, const cosmology::Cosmology cosmology, const double redshift, const double redshift_source=-1.) const |
convert a cluster mass estimated in a different cosmology More... | |
Functions to estimate the cosmic mass accretion history | |
double | pw (const double ww, const double ff, const std::string author) const |
differential distribution More... | |
double | pz (const double m0, const double z0, const double frac, const double redshift, const std::string model_model, const std::string method_SS, const bool store_output=true, const std::string output_root="test") const |
formation probability More... | |
double | cumPw (const double ww, const double ff, const std::string author) const |
cumulative distribution More... | |
void | medianwf (const double ff, const std::string model_model, std::vector< double > &wf) const |
median formation w More... | |
void | medianzf (const double ff, const double mass, const double z0, const std::string model_model, const std::string method_SS, std::vector< double > &zf, const bool store_output=true, const std::string output_root="test") const |
median formation z More... | |
double | wf (const double mm, const double redshift, const double ff, const double zf, const std::string method_SS, const bool store_output=true, const std::string output_root="test") const |
rescaled variable w as in Lacey and Coles 1993 More... | |
double | unevolved_mass_function (const double mass_accr) const |
the unevolved mass function More... | |
Functions to estimate the power spectrum and related quantities | |
double | As (const double sigma8) const |
amplitude of the curvature perturbations More... | |
double | sigma8_interpolated (const double redshift) const |
σ8 More... | |
std::string | Pk_output_file (const std::string code, const bool NL, const double redshift, const bool run=0, const bool store_output=true, const std::string output_root="test", const double k_max=100., const std::string file_par=par::defaultString) |
return the path to the power spectrum output More... | |
void | run_CAMB (const bool NL, const double redshift, const std::string output_root=par::defaultString, const std::string output_dir=par::defaultString, const double k_max=100., const std::string file_par=par::defaultString) const |
run CAMB [http://camb.info/] More... | |
void | run_CAMB (std::vector< double > &lgkk, std::vector< double > &lgPk, const bool NL, const double redshift, const std::string output_root="test", const std::string output_dir=par::defaultString, const double k_max=100., const std::string file_par=par::defaultString) const |
run CAMB [http://camb.info/] and read the matter power spectrum More... | |
void | Table_PkCodes (const std::string code, const bool NL, std::vector< double > &lgkk, std::vector< double > &lgPk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100., const std::string file_par=par::defaultString) const |
write or read the table where the dark matter power spectrum is stored More... | |
void | Table_PkCodes (const std::string code, const bool NL, std::vector< std::vector< double >> &lgkk, std::vector< std::vector< double >> &lgPk, const std::vector< double > redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100., const std::string file_par=par::defaultString) const |
write or read the table where the dark matter power spectrum is stored More... | |
void | Table_XiCodes (const std::string code, const bool NL, std::vector< double > &rr, std::vector< double > &xi, const double redshift, const bool store_output, const std::string output_root, const double k_max, std::string file_par) const |
write or read the table where the dark matter two-point correlation function is stored More... | |
void | Pk_0 (const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
normalisation of the power spectrum More... | |
std::vector< double > | Pk_matter (const std::vector< double > kk, const std::string method_Pk, const bool NL, const double redshift, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString, const bool unit1=false) |
the dark matter power spectrum More... | |
std::vector< std::vector< double > > | Pk_matter (const std::vector< double > kk, const std::string method_Pk, const bool NL, const std::vector< double > redshift, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString, const bool unit1=false) |
the dark matter power spectrum More... | |
std::vector< double > | Pk_matter_Linear (const std::string method, const std::vector< double > kk, const double redshift, const bool store_output=true, const std::string output_root="test", const bool norm=1, const double prec=1.e-4) |
the dark matter linear power spectrum. More... | |
std::vector< double > | Pk_matter_NoWiggles_gaussian (const std::vector< double > kk, const std::vector< double > PkLin, const std::vector< double > PkApprox, const double lambda, const std::string method) |
the dark matter power spectrum without BAO wiggles. More... | |
std::vector< double > | Pk_matter_NoWiggles_bspline (const std::vector< double > kk, const std::vector< double > PkLin, const std::vector< double > PkApprox, const int order, const int nknots) |
the dark matter power spectrum without BAO wiggles. More... | |
std::vector< double > | Pk_matter_NoWiggles (const std::string method, const std::vector< double > kk, const double redshift, const std::string linear_method="CAMB", const int order=4, const int nknots=10, const double lambda=0.25, const bool store_output=true, const std::string output_root="test", const bool norm=1, const double prec=1.e-4) |
the dark matter power spectrum without BAO wiggles More... | |
std::vector< double > | Pk_matter_DeWiggled (const std::string linear_method, const std::string nowiggles_method, const std::vector< double > kk, const double redshift, const double sigma_NL, const int order=4, const int nknots=10, const double lambda=0.25, const bool store_output=true, const std::string output_root="test", const bool norm=1, const double prec=1.e-4) |
the dark matter power spectrum, de-wiggled (see e.g. Anderson et al 2014) More... | |
void | remove_output_Pk_tables (const std::string code, const bool NL, const double redshift, const std::string output_root="test") const |
remove the output generated by the methods CAMB, MPTbreeze or CLASS More... | |
double | sigma2R (const double radius, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool unit1=false) const |
the mass variance, \(\sigma^2(R)\) More... | |
double | sigma2M (const double mass, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool unit1=false) const |
the mass variance, \(\sigma^2(M)\) More... | |
double | dnsigma2R (const int nd, const double radius, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool unit1=false) const |
the nth-order derivative of the mass variance, \({\rm d}^n\sigma^2(R)/{\rm d}R^n\) More... | |
double | dnsigma2M (const int nd, const double mass, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool unit1=false) const |
the first derivative of the mass variance, \({\rm d}^n\sigma^2(M)/{\rm d}M^n\) More... | |
Functions to estimate the halo density profile | |
double | concentration_NFW_Duffy (const double Mass, const double redshift, const std::string halo_def="vir") const |
the halo concentration-mass relation for NFW prfile and Duffy model More... | |
double | c_vir (const double c200, const double redshift, const std::string author="BryanNorman") const |
virial halo concentration given \(c_{200}\) More... | |
Functions to estimate the two-point correlation function, bias and related quantities | |
double | xi_matter (const double rr, const std::string method_Pk, const bool NL, const double redshift, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double aa=0., const bool GSL=false, const double prec=1.e-2, const std::string file_par=par::defaultString) |
the dark matter two-point correlation function More... | |
double | wtheta_DM (const double theta, const std::vector< double > zz, const std::vector< double > phiz, const std::string interpolationMethod, const CoordinateUnits coordUnits=CoordinateUnits::_degrees_, const bool GSL=false, const std::string method_Pk="CAMB", const bool NL=false, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=1.e-4, const double k_max=100, const double prec=1.e-2, const std::string file_par=par::defaultString) |
the dark matter angular two-point correlation function More... | |
double | wtheta_DM (const double theta, const std::vector< double > kk, const std::vector< double > Pk, const std::vector< double > zz, const std::vector< double > nz, const std::vector< double > phiz, const std::string interpolationType="Spline", const CoordinateUnits coordUnits=CoordinateUnits::_degrees_, const bool GSL=false, const double redshift_Pk=0) |
the dark matter angular two-point correlation function More... | |
std::vector< double > | C_l_DM (const int lmax, const std::vector< double > zz, const std::vector< double > phiz, const std::string interpolationMethod, const std::string method_Pk="CAMB", const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=1.e-4, const double k_max=100, const double prec=1.e-2, const std::string file_par=par::defaultString) |
the dark matter angular linear power spectrum \(C_l\). More... | |
double | xi_matter_DeWiggle (const double rr, const double redshift, const double sigma_NL, const bool store_output=true, const std::string output_root="test", const bool norm=1, const double k_min=0.001, const double k_max=100., const double aa=1., const double prec=1.e-2) |
the dark matter two-point correlation function, de-wiggled (see e.g. Anderson et al 2014) More... | |
void | get_xi (std::vector< double > &rr, std::vector< double > &Xi, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const bool xiType=0, const double k_star=-1., const bool xiNL=0, const int norm=-1, const double r_min=0.1, const double r_max=150., const double k_min=0.001, const double k_max=100., const double aa=0., const bool GSL=false, const double prec=1.e-2, const std::string file_par=par::defaultString) |
get the dark matter two-point correlation function More... | |
void | get_barred_xi (std::vector< double > rr, std::vector< double > Xi, std::vector< double > &Xi_, std::vector< double > &Xi__, const std::string method_Pk, const double redshift, const bool xiType=0, const double k_star=-1., const bool xiNL=0, const int norm=-1, const double r_min=0.1, const double r_max=150., const double k_min=0.001, const double k_max=100., const double aa=0., const double prec=1.e-2, const std::string file_par=par::defaultString) const |
get the barred dark matter correlation functions More... | |
double | wp_DM (const double rp, const std::string method_Pk, const bool NL, const double redshift, const double pimax, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double r_min=1.e-3, const double r_max=350., const double k_min=0.001, const double k_max=100., const double aa=0., const bool GSL=false, const double prec=1.e-2, const std::string file_par=cbl::par::defaultString) |
the dark matter projected correlation function More... | |
double | k_star (const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100., const std::string file_par=par::defaultString) const |
the k* parameter More... | |
double | sigmaR_DM (const double RR, const int corrType, const std::string method_Pk, const double redshift, const double pimax=40, const bool store_output=true, const std::string output_root="test", const bool NL=1, const int norm=-1, const double r_min=1.e-3, const double r_max=350., const double k_min=0.001, const double k_max=100., const double aa=0., const bool GSL=false, const double prec=1.e-2, const std::string file_par=par::defaultString) |
the dark matter rms mass fluctuation More... | |
double | sigma8_Pk (const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const bool NL=0, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) const |
the dark matter rms mass fluctuation within 8 Mpc/h More... | |
double | bias_halo (const double Mass, const double redshift, const std::string author, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double Delta=200., const double kk=-1., const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
bias of dark matter haloes More... | |
double | bias_halo (const double Mass, const double Sigma, const double redshift, const std::string model_bias, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double Delta=200., const double kk=-1., const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string method_SS="CAMB", const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
bias of dark matter haloes More... | |
double | bias_halo (const double Mass, const double Sigma, const double redshift, const double DN, const std::string model_bias, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double Delta=200., const double kk=-1., const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string method_SS="CAMB", const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
bias of dark matter haloes More... | |
std::vector< double > | bias_halo (const std::vector< double > Mass, const std::vector< double > Sigma, const double redshift, const std::string model_bias, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double Delta=200., const double kk=-1., const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string method_SS="CAMB", const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
bias of dark matter haloes, for a vector of masses More... | |
double | bias_eff (const double Mass_min, const double Mass_max, const double redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the effective bias of dark matter haloes, with masses in a given range and at a given mean redshift More... | |
double | bias_eff (const std::vector< double > MM, const std::vector< double > MF, const double redshift, const std::string model_bias, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed by averaging over the bias of a given set of haloes More... | |
std::vector< double > | bias_eff_mass_grid (const std::vector< double > MM, const std::vector< double > redshift, const std::string model_bias, const std::string method_SS, const std::string meanType="mean_bias", const bool store_output=true, const std::string output_root="test", const double Delta_crit=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes, with the mass variance estimated from a grid More... | |
std::vector< double > | bias_eff_mass (const std::vector< double > MM, const std::vector< double > redshift, const std::string model_bias, const std::string method_SS, const std::string meanType="mean_bias", const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes More... | |
std::vector< double > | bias_eff_mass (const std::vector< double > mass, const std::vector< double > mass_grid, const std::vector< double > redshift, const std::string model_bias, const std::string method_SS, const std::string meanType="mean_bias", const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes, interpolating the mass variance on a grid More... | |
void | generate_bias_eff_grid_one_cosmopar (std::vector< double > ¶meter, std::vector< double > &bias_eff, const std::string dir_output, const std::string file_bias_eff_grid, const cbl::cosmology::CosmologicalParameter cosmoPar, const double min_par, const double max_par, const int nbin_par, const std::vector< double > mass, const std::vector< double > mass_grid, const std::vector< double > redshift, const std::string model_bias, const std::string method_SS, const std::string meanType="mean_bias", const bool store_output=true, const std::string output_root="test", const double Delta_crit=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true, const cbl::cosmology::Cosmology cosmology_mass={}, const std::vector< double > redshift_source={}) |
compute the effective bias of dark matter haloes, by averaging the bias of a set of haloes, interpolating the mass variance on a grid of masses and of one input cosmological parameter; this function is used when modelling the two-point correlation function More... | |
void | generate_bias_eff_grid_one_cosmopar (std::vector< double > ¶meter, std::vector< double > &bias_eff, const std::string dir_output, const std::string file_bias_eff_grid, const cbl::cosmology::CosmologicalParameter cosmoPar, const double min_par, const double max_par, const int nbin_par, const double redshift, const double Mass_min, const double Mass_max, const std::string model_bias, const std::string model_MF, const std::string method_SS, const std::string selection_function_file, const std::vector< int > column={}, const double alpha=1., const bool store_output=true, const std::string output_root="test", const double Delta_crit=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed by weighting on the selection function on a grid of one input cosmological parameter; this function is used when modelling the two-point correlation function More... | |
void | generate_bias_eff_grid_two_cosmopars (std::vector< double > ¶meter1, std::vector< double > ¶meter2, std::vector< std::vector< double >> &bias_eff, const std::string dir_output, const std::string file_bias_eff_grid, const cbl::cosmology::CosmologicalParameter cosmoPar1, const double min_par1, const double max_par1, const int nbin_par1, const cbl::cosmology::CosmologicalParameter cosmoPar2, const double min_par2, const double max_par2, const int nbin_par2, const std::vector< double > mass, const std::vector< double > mass_grid, const std::vector< double > redshift, const std::string model_bias, const std::string method_SS, const std::string meanType="mean_bias", const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true, const cbl::cosmology::Cosmology cosmology_mass={}, const std::vector< double > redshift_source={}) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes, interpolating the mass variance on a grid of masses and two input cosmological parameters; this function is used when modelling the two-point correlation function More... | |
std::vector< double > | bias_eff_selection_function (const glob::FuncGrid interp_sigma, const glob::FuncGrid interp_DnSigma, const glob::FuncGrid interp_SF, const double Mass_min, const double Mass_max, const std::vector< double > redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const double alpha=1., const bool store_output=true, const std::string output_root="test", const double Delta_crit=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed using a given selection function; σ(mass) and dlnσ/dM are provided in input More... | |
std::vector< double > | bias_eff_selection_function (const glob::FuncGrid interp_sigma, const glob::FuncGrid interp_DnSigma, const glob::FuncGrid2D interp_SF, const double Mass_min, const double Mass_max, const std::vector< double > redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const double alpha=1., const bool store_output=true, const std::string output_root="test", const double Delta_crit=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed using a given selection function; σ(mass) and dlnσ/dM are provided in input More... | |
std::vector< double > | bias_eff_selection_function (const double Mass_min, const double Mass_max, const std::vector< double > redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const std::string selection_function_file, const std::vector< int > column={}, const double alpha=1., const bool store_output=true, const std::string output_root="test", const double Delta_crit=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
effective bias of dark matter haloes, computed using a given selection function More... | |
Functions to model redshift-space distortions | |
double | linear_growth_rate (const double redshift, const double prec=1.e-4) const |
the linear growth rate at a given redshift, \(f(z)\) More... | |
double | fsigma8 (const double redshift, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const bool NL=false, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) const |
f*σ8: the linear growth rate times the dark matter rms mass fluctuation within 8 Mpc/h More... | |
double | beta (const double redshift, const double bias) const |
the specific growth rate β More... | |
double | error_beta (const double redshift, const double bias, const double err_bias) const |
the error on the specific growth rate β More... | |
double | beta (const double Mass_min, const double Mass_max, const double redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the error on the specific growth rate β More... | |
double | error_beta (const double Mass_min, const double Mass_max, const double redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const double err_bias, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the specific growth rate β More... | |
double | beta (const std::vector< double > MM, const std::vector< double > MF, const double redshift, const std::string model_bias, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the specific growth rate β More... | |
double | error_beta (const std::vector< double > MM, const std::vector< double > MF, const double redshift, const std::string model_bias, const std::string method_SS, const double err_bias, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the error on the specific growth rate β More... | |
double | error_beta_measured (const double Volume, const double density, const double Mass_min, const double Mass_max, const double redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the error on the specific growth rate β from Bianchi et al. 2012 More... | |
double | quadrupole (const double Mass_min, const double Mass_max, const double redshift, const std::string model_bias, const std::string model_MF, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the normalised quadrupole Q More... | |
double | quadrupole (const std::vector< double > MM, const std::vector< double > MF, const double redshift, const std::string model_bias, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const double Delta=200., const double kk=-1., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the normalised quadrupole Q More... | |
double | square_bulk_flow (const double rr, const double k_int_min, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
the mean square bulk flow More... | |
double | square_bulk_flow_Table (const double rr, const double k_int_min, const std::vector< double > lgkk, const std::vector< double > lgPk, const double redshift) const |
the mean square bulk flow More... | |
double | square_velocity_dispersion (const double rr, const double k_int_min, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
the mean square velocity dispersion More... | |
double | CMN (const double rr, const double k_int_min, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100., const std::string file_par=par::defaultString) const |
the Cosmic Mach Number More... | |
double | Sn_PT (const int nn, const double RR, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
the hierarchical moments Sn More... | |
double | Sigman_PT (const int nn, const double RR, const std::string method_SS, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
the deprojected hierarchical moments Σn More... | |
double | xi0_Kaiser (const double rad, const double f_sigma8, const double bias_sigma8, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const bool xiType=0, const double k_star=-1., const bool NL=false, const int norm=-1, const double r_min=0.1, const double r_max=150., const double k_min=0.001, const double k_max=100., const double aa=0., const bool GSL=false, const double prec=1.e-2, const std::string file_par=par::defaultString) |
monopole of the redshift-space two-point correlation function in the Kaiser limit More... | |
std::vector< double > | xi0_Kaiser (const std::vector< double > rad, const double bias, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const bool NL=false, const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
monopole of the redshift-space two-point correlation function in the Kaiser limit More... | |
double | xi2D_dispersionModel (const double rp, const double pi, const double f_sigma8, const double bias_sigma8, const double sigmav, const std::string method_Pk, const double redshift, const int FV, const bool NL, std::vector< double > rr, std::vector< double > &Xi, std::vector< double > &Xi_, std::vector< double > &Xi__, const bool store_output=true, const std::string output_root="test", const int index=-1, const bool bias_nl=0, const double bA=-1., const bool xiType=0, const double k_star=-1., const bool xiNL=0, const double v_min=-3000., const double v_max=3000., const int step_v=500, const int norm=-1, const double r_min=0.1, const double r_max=150., const double k_min=0.001, const double k_max=100., const double aa=0., const bool GSL=false, const double prec=1.e-2, const std::string file_par=par::defaultString) |
2D correlation function, ξ(rp,π), predicted by the dispersion model More... | |
double | xi_star (const double rr, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_star=-1., const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
the function ξ* of the Chuang & Wang 2012 model More... | |
double | xisnl_gnw (const double rp, const double pi, const double f_sigma8, const double bias_sigma8, const double bA, const double redshift, std::vector< double > rr, std::vector< double > Xi, std::vector< double > &Xi_, std::vector< double > &Xi__, const bool store_output=true, const std::string output_root="test") |
the function ξg,nw(s) of the Chuang & Wang 2012 model More... | |
double | xis_gBAO (const double rp, const double pi, const double f_sigma8, const double bias_sigma8, const double redshift, std::vector< double > rr, std::vector< double > Xi, std::vector< double > &Xi_, std::vector< double > &Xi__, const bool store_output=true, const std::string output_root="test", const double k_star=-1., const double x_min=-3000., const double x_max=3000., const int step_x=500) |
the function ξg,BAO(s) of the Chuang & Wang 2012 model More... | |
double | xi2D_CW (const double rp, const double pi, const double beta, const double bias_lin, const double bA, const double sigmav0, const double cmu, const double cs1, const double cs2, const double redshift, std::vector< double > rr1, std::vector< double > Xi1, std::vector< double > rr2, std::vector< double > Xi2, std::vector< double > &Xi1_, std::vector< double > &Xi1__, std::vector< double > &Xi2_, std::vector< double > &Xi2__, const bool store_output=true, const std::string output_root="test", const bool BAO=1, const bool xiType=0, const double k_star=-1, const bool xiNL=0, const double r_min=0.1, const double r_max=150., const double v_min=-3000., const double v_max=3000., const int step_v=500, const double k_min=0.001, const double k_max=100., const double x_min=-3000., const double x_max=3000., const int step_x=500, const double aa=0., const bool GSL=false, const double prec=1.e-2, const std::string file_par=par::defaultString) |
2D correlation function, ξ(rp,π), predicted by the Chuang & Wang model More... | |
Functions to model baryon acoustic oscillations | |
double | rs (const std::string method_Pk, const double T_CMB=par::TCMB) const |
the sound horizon at the drag epoch rs(zd), valid choices for method_Pk are: EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html], CAMB [http://camb.info/] More... | |
double | rs_EH (const double T_CMB=par::TCMB) const |
the sound horizon at the drag epoch predicted by Eisentein & Hu 1998 More... | |
double | rs_CAMB () const |
the sound horizon at the drag epoch estimated with CAMB [http://camb.info/], analytical formula by Aubourg et al. 2014 More... | |
double | ys (const double redshift, const std::string method_Pk, const double T_CMB=par::TCMB) const |
the fiducial cosmology independent ratio rs/DV, valid choices for method_Pk are: EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html], CAMB [http://camb.info/] More... | |
double | Az (const double redshift) const |
the acoustic parameter More... | |
std::vector< double > | linear_point (const double redshift, const double rmin=60., const double rmax=150., const int nbinr=100, const std::string interpType="Spline") |
the linear point More... | |
Functions to model cosmological quantities in non-Gaussian cosmologies | |
double | Am (const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
the amplitude of the matter power spectrum More... | |
double | potential_spectral_amplitude (const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
the potential spectral amplitude More... | |
double | bispectrum (const std::vector< double > kk, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
the bispectrum More... | |
double | mrk (const double kk, const double mass, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString) |
auxiliary function to estimate cosmological quantities in non-Gaussian cosmologies More... | |
double | frk (const double kk, const double mass, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
auxiliary function to estimate cosmological quantities in non-Gaussian cosmologies More... | |
double | bias_correction (const double kk, const double mass, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
correction to the halo bias in non-Gaussian cosmologies More... | |
double | skewness (const double mass, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the skewness More... | |
double | dskewnessdM (const double mass, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the derivative of the skewness, ds/dM More... | |
double | MF_correction (const double mass, const double redshift, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
correction to the halo mass in non-Gaussian cosmologies More... | |
Functions to estimate the void size function | |
double | f_nu (const double SS, const double del_v, const double del_c) const |
\(f_{\ln \sigma}(\sigma)\) (approximation) More... | |
double | size_function (const double RV, const double redshift, const std::string model, const double b_eff, double slope=0.854, double offset=0.420, const double deltav_NL=-0.795, const double del_c=1.69, const std::string method_Pk="EisensteinHu", const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
the void size function More... | |
std::vector< double > | size_function (const std::vector< double > RV, const double redshift, const std::string model, const double b_eff, double slope=0.854, double offset=0.420, const double deltav_NL=-0.795, const double del_c=1.69, const std::string method_Pk="EisensteinHu", const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
the void size function More... | |
std::vector< std::vector< double > > | Nvoids (const double min_r, const double max_r, const int num_bins, const double mean_z, const double Volume, const std::string model, const double b_eff, double slope=0.854, double offset=0.420, const double deltav_NL=-0.795, const double del_c=1.69, const std::string method_Pk="EisensteinHu", const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
number of voids computed from the void size function model for bins of radii spaced in log scale and for a specified survey/simulation volume More... | |
std::vector< std::vector< double > > | Nvoids (const double min_r, const double max_r, const int num_bins, const double min_z, const double max_z, const double mean_z, const double Area, const std::string model, const double b_eff, double slope=0.854, double offset=0.420, const double deltav_NL=-0.795, const double del_c=1.69, const std::string method_Pk="EisensteinHu", const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true) const |
number of voids computed from the void size function model for bins of radii spaced in log scale. The considered volume is computed from a (fraction of) a sphere shell, included in between two different redshifts More... | |
double | size_function (const double RV, const double redshift, const std::string model_mf, const double del_v, const std::string model_sf, const std::string method_Pk="EisensteinHu", const bool store_output=true, const std::string output_root="test", const double Delta=200., const std::string interpType="Linear", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string input_file=par::defaultString, const bool is_parameter_file=true) |
the void size function More... | |
std::vector< double > | AP_corr (const cbl::cosmology::Cosmology cosm_true, const std::vector< double > redshift) |
Supplementary function to compute a correction factor to apply to the void size function, to predict the measured abundance of voids affected by geometrical distortions (Alcock-Paczyński change of volume). These are caused by the assumption of a fiducial cosmology different from the true one, see Correa et al. 2020 (https://arxiv.org/pdf/2007.12064.pdf) More... | |
Functions to estimate the multipoles/wedges covariance matrix | |
std::vector< std::vector< double > > | XiMultipoles (const int nbins, const double rMin, const double rMax, const std::vector< double > kk, const std::vector< double > Pk0, const std::vector< double > Pk2, const std::vector< double > Pk4, const int IntegrationMethod=1) |
the first three non-null multipoles of the two-point correlation function More... | |
std::vector< std::vector< double > > | XiMonopole_covariance (const int nbins, const double rMin, const double rMax, const double nn, const double Volume, const std::vector< double > kk, const std::vector< double > Pk0, const int IntegrationMethod=1) |
the covariance matrix of the first three non-null multipoles of the two-point correlation function More... | |
std::vector< std::vector< double > > | XiMultipoles_covariance (const int nbins, const double rMin, const double rMax, const double nn, const double Volume, const std::vector< double > kk, const std::vector< double > Pk0, const std::vector< double > Pk2, const std::vector< double > Pk4, const int IntegrationMethod=1) |
the covariance matrix of the first three non-null multipole moments of the two-point correlation function More... | |
Functions to estimate the non-linear power spectrum | |
double | F2 (const double k, const double q, const double kq) |
function used to estimate the non-linear power spectrum More... | |
double | G2 (const double k, const double q, const double kq) |
function used to estimate the non-linear power spectrum More... | |
double | f_k (const double k, const std::shared_ptr< cbl::glob::FuncGrid > PkLin, const double qmin, const double qmax, const double prec=1.e-3) |
function used to estimate the non-linear power spectrum More... | |
double | g_k (const double k, const std::shared_ptr< cbl::glob::FuncGrid > PkLin, const double qmin, const double qmax, const double prec=1.e-3) |
function used to estimate the non-linear power spectrum More... | |
double | Pk_1loop (const double kk, const std::shared_ptr< cbl::glob::FuncGrid > PkLin, const int corrtype, const double qmin, const double qmax, const double prec=1.e-3) |
the one-loop power spectrum More... | |
double | Pk_DeltaDelta (const double kk, const std::shared_ptr< cbl::glob::FuncGrid > Pk, const double qmin, const double qmax, const double prec=1.e-3) |
the real-space matter non-linear power spectrum \(P_{\delta\delta}(k)\), computed at 1-loop More... | |
std::vector< double > | Pk_DeltaDelta (const std::vector< double > kk, const double redshift, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString, const bool unit1=false) |
the real-space matter non-linear power spectrum \(P_{\delta\delta}(k)\), computed at 1-loop More... | |
double | Pk_DeltaTheta (const double kk, const std::shared_ptr< cbl::glob::FuncGrid > Pk, const double qmin, const double qmax, const double prec=1.e-3) |
the real-space matter non-linear power spectrum \(P_{\delta\theta}(k)\), computed at 1-loop More... | |
std::vector< double > | Pk_DeltaTheta (const std::vector< double > kk, const double redshift, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString, const bool unit1=false) |
the real-space matter non-linear power spectrum \(P_{\delta\theta}(k)\), computed at 1-loop More... | |
double | Pk_ThetaTheta (const double kk, const std::shared_ptr< cbl::glob::FuncGrid > Pk, const double qmin, const double qmax, const double prec=1.e-3) |
the real-space matter non-linear power spectrum \(P_{\theta\theta}(k)\), computed at 1-loop More... | |
std::vector< double > | Pk_ThetaTheta (const std::vector< double > kk, const double redshift, const std::string method_Pk, const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const double prec=1.e-2, const std::string file_par=par::defaultString, const bool unit1=false) |
the real-space matter non-linear power spectrum \(P_{\theta\theta}(k)\), computed at 1-loop More... | |
double | Pk_DeltaDelta_fitting_function (const double kk, const std::string method_Pk, const double redshift, const std::string author, const bool store_output, const std::string output_root, const int norm, double k_min, double k_max, const double prec, const std::string file_par, const bool unit1) |
the non-linear dark matter power spectrum using fitting functions given by Bel et. al (2019) More... | |
double | Pk_DeltaTheta_fitting_function (const double kk, const std::string method_Pk, const double redshift, const std::string author, const bool store_output, const std::string output_root, const bool NL, const int norm, double k_min, double k_max, const double prec, const std::string file_par, const bool unit1) |
the dark matter cross power spectrum More... | |
double | Pk_ThetaTheta_fitting_function (const double kk, const std::string method_Pk, const double redshift, const std::string author, const bool store_output, const std::string output_root, const bool NL, const int norm, double k_min, double k_max, const double prec, const std::string file_par, const bool unit1) |
the dark matter velocity divergence power spectrum More... | |
double | sigma_v (const double redshift=0., const std::string method_Pk="CAMB", const bool store_output=true, const std::string output_root="test", const int norm=-1, const double k_min=0.001, const double k_max=100., const int bin_k=512, const double prec=1.e-2, const std::string file_par=par::defaultString, const bool unit1=false) |
the linear-order one-dimensional pairwise velocity dispersion, \(\sigma_{\mathrm{v}, \mathrm{lin}}\) More... | |
std::vector< std::vector< double > > | Pk_TNS_AB_multipoles (std::vector< double > kk, const std::string method, const double redshift, const bool store_output, const std::string output_root, const int norm, const double k_min, const double k_max, const double prec) |
the multipoles of the A and B correction terms for the TNS model More... | |
std::vector< std::vector< double > > | Pk_TNS_AB_1loop (std::vector< double > kk, const double mu, const std::string method, const double redshift, const bool store_output, const std::string output_root, const int norm, const double k_min, const double k_max, const double prec) |
the A and B correction terms for the TNS model at 1-loop from the multipole expansion More... | |
std::vector< std::vector< double > > | Pk_TNS_AB_terms_1loop (std::vector< double > kk, const std::string method, const double redshift, const bool store_output, const std::string output_root, const int norm, const double k_min=0.001, const double k_max=100., const double prec=1.e-2) |
the expanded A and B correction terms for the TNS model More... | |
std::vector< std::vector< double > > | Pk_eTNS_terms_1loop (std::vector< double > kk, const std::string method, const double redshift, const bool store_output, const std::string output_root, const int norm, const double k_min=0.001, const double k_max=100., const double prec=1.e-2) |
The expanded correction terms for the extended TNS model (eTNS) More... | |
std::vector< std::vector< double > > | Pk_TNS_AB_1loop (std::vector< double > kk, const double mu, const double linear_growth_rate, const double bias, const std::string method, const double redshift, const bool store_output, const std::string output_root, const int norm, const double k_min=0.001, const double k_max=100., const double prec=1.e-2) |
the expanded A and B correction terms for the TNS model More... | |
std::vector< std::vector< double > > | Pk_TNS_dd_dt_tt (std::vector< double > kk, const std::string method, const double redshift, const bool store_output, const std::string output_root, const int norm, const double k_min=0.001, const double k_max=100., const double prec=1.e-2) |
the non-linear \(\delta-\delta\), \(\delta-\theta\), \(\theta-\theta\) matter power spectra More... | |
Functions to estimate the three-point correlation function | |
double | denominator_Q (const double r1, const double r2, const double theta, const std::vector< double > rr, const std::vector< double > xi_matter) const |
the normalization factor for reduced three-point correlation function More... | |
void | integrals_Q_nonLocal (std::vector< double > &xi_matter, std::vector< double > &Phi, const std::vector< double > rr, const std::vector< double > kk, const std::vector< double > Pk_matter, const double prec) const |
integral functions for the three-point correlation model More... | |
double | Gamma_3PCF (const double r1, const double r2, const double theta, const std::vector< double > xi, const std::vector< double > dPhi) const |
function to compute non-local contribution to three-point correlation function; specifically, it implements Eq. 20 of Bel el et al. 2015, MNRAS, 453, 259: More... | |
double | Q_nonLocal (const double r1, const double r2, const double theta, std::vector< double > &rr, std::vector< double > &xi_matter, std::vector< double > &Phi, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the non-local contribution to the reduced dark matter three-point correlation function More... | |
std::vector< double > | Q_nonLocal (const double r1, const double r2, const std::vector< double > theta, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
all the non-local contribution terms of the reduced dark matter three-point correlation function More... | |
void | integrals_zeta_Slepian (std::vector< double > &xi_matter, std::vector< double > &xi_matter_m1, std::vector< double > &xi_matter_p1, std::vector< double > &xi_matter_2, const std::vector< double > rr, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
integrals used to compute the Slepian et al. 2015 three-point correlation function model More... | |
double | zeta_precyclic_Slepian (const double r1, const double r2, const double mu, const double b1, const double b2, const glob::FuncGrid interp_xi_matter, const glob::FuncGrid interp_xi_matter_m1, const glob::FuncGrid interp_xi_matter_p1, const glob::FuncGrid interp_xi_matter_2) const |
the pre-cyclic three-point correlation function as described in Slepian et al. 2015 More... | |
double | zeta_precyclic_Slepian (const double r1, const double r2, const double r3, const double deltaR, const double b1, const double b2, const glob::FuncGrid interp_xi_matter, const glob::FuncGrid interp_xi_matter_m1, const glob::FuncGrid interp_xi_matter_p1, const glob::FuncGrid interp_xi_matter_2) const |
the pre-cyclic three-point correlation function as described in Slepian et al. 2015, for a triangle averaging in the bin More... | |
std::vector< double > | zeta_expansion_Slepian (const double r1, const double r2, const double b1, const double b2, std::vector< double > &rr, std::vector< double > &xi_matter, std::vector< double > &xi_matter_m1, std::vector< double > &xi_matter_p1, std::vector< double > &xi_matter_2, const int norders=9, const double prec=1.e-3) const |
the terms of the \(\zeta(r_1, r_2)\) expansion More... | |
double | zeta_DM_Slepian (const double r1, const double r2, const double theta, std::vector< double > &rr, std::vector< double > &xi_matter, std::vector< double > &xi_matter_m1, std::vector< double > &xi_matter_p1, std::vector< double > &xi_matter_2, const std::vector< double > kk, const std::vector< double > Pk_matter, const int norders=9, const double prec=1.e-3) const |
the dark matter three-point correlation function model by Slepian et al. 2015 More... | |
double | Q_DM_Slepian (const double r1, const double r2, const double theta, std::vector< double > &rr, std::vector< double > &xi_matter, std::vector< double > &xi_matter_m1, std::vector< double > &xi_matter_p1, std::vector< double > &xi_matter_2, const std::vector< double > kk, const std::vector< double > Pk_matter, const int norders=9, const double prec=1.e-3) const |
the dark matter reduced three-point correlation function model by Slepian et al. 2015 More... | |
void | integrals_zeta_BarrigaGatzanaga (std::vector< double > &xi_matter, std::vector< double > &Phi, const std::vector< double > rr, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
integrals used to compute the Barriga & Gatzanaga al. 2002 three-point correlation function model More... | |
double | zeta_single_BarrigaGatzanaga (const double r1, const double r2, const double theta, const std::vector< double > xi, const std::vector< double > dxi, const std::vector< double > dPhi) const |
the single term of the dark matter three-point correlation function model by Barriga & Gatzanaga et al. 2002 More... | |
double | zeta_DM_BarrigaGatzanaga (const double r1, const double r2, const double theta, std::vector< double > &rr, std::vector< double > &xi_matter, std::vector< double > &Phi, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the dark matter three-point correlation function model by Barriga & Gatzanaga et al. 2002 More... | |
double | Q_DM_BarrigaGatzanaga (const double r1, const double r2, const double theta, std::vector< double > &rr, std::vector< double > &xi_matter, std::vector< double > &Phi, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the dark matter reduced three-point correlation function model by Barriga & Gatzanaga et al. 2002 More... | |
std::vector< double > | zeta_DM (const double r1, const double r2, const std::vector< double > theta, const std::string model, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the dark matter three-point correlation function More... | |
std::vector< double > | Q_DM (const double r1, const double r2, const std::vector< double > theta, const std::string model, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the dark matter reduced three-point correlation function More... | |
std::vector< double > | zeta_halo (const double r1, const double r2, const std::vector< double > theta, const double b1, const double b2, const std::string model, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the local-bias model of the three-point correlation function of dark matter haloes More... | |
std::vector< double > | Q_halo (const double r1, const double r2, const std::vector< double > theta, const double b1, const double b2, const std::string model, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the local-bias model of the reduced three-point correlation function of dark matter haloes More... | |
std::vector< double > | Q_halo (const double r1, const double r2, const std::vector< double > theta, const double b1, const double b2, const double g2, const std::string model, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the non-local-bias model of the three-point correlation function of dark matter haloes More... | |
std::vector< double > | zeta_DM_eq (const std::vector< double > rr, const std::string model, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the dark matter equilateral three-point correlation function More... | |
std::vector< double > | Q_DM_eq (const std::vector< double > rr, const std::string model, const std::vector< double > kk, const std::vector< double > Pk_matter) const |
the dark matter equilateral reduced three-point correlation function More... | |
double | zeta_multipoles_covariance (const double Volume, const double nObjects, const int l, const int l_prime, const double r1, const double r2, const double r1_prime, const double r2_prime, const double deltaR, const std::vector< double > kk, const std::vector< double > Pk, const std::vector< double > rr, const std::vector< double > Xi, const double prec=1.e-3) |
the dark matter three-point correlation function multipoles covariance model, by Slepian et al. 2015 More... | |
std::vector< std::vector< double > > | zeta_covariance (const double Volume, const double nObjects, const std::vector< double > theta, const double r1, const double r2, const double deltaR, const std::vector< double > kk, const std::vector< double > Pk, const int norders=10, const double prec=1.e-3, const bool method=false, const int nExtractions=10000, const std::vector< double > mean={}, const int seed=543) |
the dark matter three-point correlation function covariance model More... | |
void | xi_r_n (std::vector< double > &xi_n, const std::vector< double > rr, const int nn, const std::vector< double > kk, const std::vector< double > Pk) |
compute the power spectrum integral transform More... | |
void | xi_r_n_pm (std::vector< double > &xi_n_p, std::vector< double > &xi_n_m, const std::vector< double > rr, const int nn, const std::vector< double > kk, const std::vector< double > Pk) |
compute the power spectrum integral transform More... | |
void | eff_l_l1 (std::vector< std::vector< double >> &eff, const std::vector< double > rr, const int l, const int l1, const std::vector< double > kk, const std::vector< double > Pk) |
compute the power spectrum integral transform More... | |
void | I_ELL_ell (std::vector< std::vector< double >> &II, const std::vector< double > rr, const int ll, const int LL, const std::vector< double > kk, const std::vector< double > Pk) |
compute the quantity \( I_{\mathcal{L} l} (r_1, r_2)\) More... | |
void | k_ell (std::vector< std::vector< double >> &KK, const std::vector< double > rr, const int ll, const std::vector< double > kk, const std::vector< double > Pk) |
compute the quantity \( k_l (r_1, r_2) \) More... | |
double | zeta_ell_0_factor (const double b1, const double gamma, const double beta) |
the multiplicative factor for \( \zeta_0 \), with local bias More... | |
double | zeta_ell_1_factor (const double b1, const double beta) |
the multiplicative factor for \( \zeta_1 \), with local bias More... | |
double | zeta_ell_2_factor (const double b1, const double gamma, const double beta) |
the multiplicative factor for \( \zeta_2 \), with local bias More... | |
double | zeta_ell_3_factor (const double b1, const double beta) |
the multiplicative factor for \( \zeta_3 \), with local bias More... | |
double | zeta_ell_4_factor (const double b1, const double beta) |
the multiplicative factor for \( \zeta_4 \), with local bias More... | |
double | zeta_ell_k_factor (const double b1, const double beta) |
the multiplicative factor for \( \zeta_l, l>4 \), with local bias More... | |
double | zeta_ell_0_factor_tidal (const double gamma_t, const double beta) |
the multiplicative factor for \( \zeta_l, l=0 \), with non-local bias More... | |
double | zeta_ell_2_factor_tidal (const double gamma_t, const double beta) |
the multiplicative factor for \( \zeta_l, l=2 \), with non-local bias More... | |
double | zeta_ell_4_factor_tidal (const double gamma_t, const double beta) |
the multiplicative factor for \( \zeta_l, l=4 \), with non-local bias More... | |
double | zeta_ell_precyclic (const double r1, const double r2, const int ell, const double b1, const double b2, const double bt, const double beta, std::vector< std::shared_ptr< glob::FuncGrid >> interp_xi_ell, const bool use_k, std::shared_ptr< glob::FuncGrid2D > interp_k_ell) |
the pre-cyclic \( \zeta_l \) More... | |
std::vector< double > | zeta_RSD (const double r1, const double r2, const int ntheta, const double b1, const double b2, const double bt, const double beta, const std::vector< double > rr, const std::vector< double > kk, const std::vector< double > Pk, const bool include_limits=false, const int max_ll=4, const bool use_k=false) |
the \( \zeta (r_1, r_2, \theta) \) More... | |
std::vector< double > | zeta_RSD (const double r1, const double r2, const int ntheta, const double b1, const double b2, const double bt, const double redshift, const std::string method_Pk, const int step_r, const int step_k, const bool store_output=true, const std::string output_root="test", const bool force_RealSpace=false, const bool include_limits=false, const int max_ll=4, const bool use_k=false) |
the \( \zeta (r_1, r_2, \theta) \) More... | |
Private Member Functions | |
Auxiliary functions of internal usage | |
void | set_default () |
internal function to set default values | |
double | m_func_sigma (const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true, std::function< double(double)> filter={}, const bool unit1=false) const |
function to compute the not-yet-normalised mass variances and their derivatives More... | |
double | m_sigma2R_notNormalised (const double radius, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool unit1=false) const |
the not-yet-normalised mass variance, \(\sigma^2(R)\) More... | |
double | m_sigma2M_notNormalised (const double mass, const std::string method_Pk, const double redshift, const bool store_output=true, const std::string output_root="test", const std::string interpType="Linear", const double k_max=100., const std::string input_file=par::defaultString, const bool is_parameter_file=true, const bool unit1=false) const |
the not-yet-normalised mass variance, \(\sigma^2(M)\) More... | |
double | m_mass_function (const double Mass, std::shared_ptr< void > mass_function_params) |
auxiliary function to compute the mass function of dark matter haloes (filaments and sheets) More... | |
double | m_MF_generator (const double Mass, const double Sigma, const double Dln_Sigma, const double redshift, const std::string model_MF, const double Delta=200., const bool default_delta=true, const double delta_t=1.686) |
auxiliary function to compute the mass function More... | |
double | m_MF_generator (const double Mass, const double Sigma, const double Dln_Sigma, const double redshift, const double D_N, const std::string model_MF, const double Delta=200., const bool default_delta=true, const double delta_t=1.686) |
auxiliary function to compute the mass function More... | |
double | m_bias_halo_generator (const double Sigma, const double redshift, const std::string author, const double Delta=200.) const |
auxiliary function to compute the halo bias More... | |
double | m_bias_halo_generator (const double Sigma, const double redshift, const double D_N, const std::string author, const double Delta=200.) const |
auxiliary function to compute the halo bias More... | |
double | m_elf_dz (const double phi) const |
the incomplete elliptic integral More... | |
double | m_acn_dz (const double cc) const |
the inverse cosine amplitude of the Jacobian elliptic function More... | |
double | m_asn_dz (const double ss) const |
the inverse sine amplitude of the Jacobian elliptic function More... | |
double | m_serf_dz (const double yy) const |
the inverse truncated series necessary to compute sn-1(s|m) in ASN_DZ More... | |
void | m_Table_Pk_CAMB_MPTbreeze (const std::string code, const bool NL, std::vector< double > &lgkk, std::vector< double > &lgPk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100.) const |
write and read the table where the dark matter power spectrum, computed with either CAMB or MPTbreeze, is stored More... | |
void | m_Table_Pk_CAMB_MPTbreeze (const std::string code, const bool NL, std::vector< std::vector< double >> &lgkk, std::vector< std::vector< double >> &lgPk, const std::vector< double > redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100.) const |
write and read the table where the dark matter power spectrum, computed with either CAMB or MPTbreeze, is stored More... | |
void | m_Table_Pk_CLASS (const bool NL, std::vector< double > &lgkk, std::vector< double > &lgPk, const double redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100.) const |
write and read the table where the dark matter power spectrum computed with CLASS is stored More... | |
void | m_Table_Pk_CLASS (const bool NL, std::vector< std::vector< double >> &lgkk, std::vector< std::vector< double >> &lgPk, const std::vector< double > redshift, const bool store_output=true, const std::string output_root="test", const double k_max=100.) const |
write and read the table where the dark matter power spectrum computed with CLASS is stored More... | |
void | m_Table_Pk_parameterFile (const std::string code, const std::string file_par, const bool NL, std::vector< double > &lgkk, std::vector< double > &lgPk, const double redshift, const std::string output_root="test") const |
write and read the table where the dark matter power spectrum is stored; it is used when a parameter file is provided in input More... | |
Private Attributes | |
double | m_Omega_matter |
\(\Omega_M\): the density of baryons, cold dark matter and massive neutrinos (in units of the critical density) at z=0 in the LCDM case | |
double | m_Omega_baryon |
\(\Omega_b\): the baryon density at z=0 | |
double | m_Omega_neutrinos |
\(\Omega_\nu\): the density of massive neutrinos at z=0 | |
double | m_massless_neutrinos |
\(N_{eff}\): the effective number (for QED + non-instantaneous decoupling) | |
int | m_massive_neutrinos |
the number of degenerate massive neutrino species | |
double | m_Omega_DE |
\(\Omega_{DE}\): the dark energy density at z=0 | |
double | m_Omega_radiation |
\(\Omega_{rad}\): the radiation density at z=0 | |
double | m_Omega_k |
\(\Omega_k\): the density of curvature energy | |
double | m_Omega_CDM |
\(Omega_{CDM}\): the cold dark matter density at z=0 | |
double | m_H0 |
\(H_0\): the Hubble constant at z=0 [km/sec/Mpc] | |
double | m_hh |
\(h\): the Hubble parameter, \(H_0/100\) | |
double | m_t_H |
\(t_H\): the Hubble time | |
double | m_D_H |
\(D_H\): the Hubble distance | |
double | m_sigma8 |
\(sigma_8\): the power spectrum normalisation | |
double | m_scalar_amp |
\(A_s\): the initial scalar amplitude of the power spectrum | |
double | m_scalar_pivot |
the scalar pivot k in \(Mpc^{-1}\) | |
double | m_n_spec |
\(n_{spec}\): the primordial spectral index | |
double | m_w0 |
\(w_0\): the parameter of the dark energy equation of state (CPL parameterisation) | |
double | m_wa |
\(w_a\): the parameter of the dark energy equation of state (CPL parameterisation) | |
double | m_RhoZero |
\(\rho_0\): the mean density of the Universe at z=0 [Msun*Mpc^-3] | |
double | m_fNL |
\(f_{NL}\): the non-Gaussian amplitude | |
int | m_type_NG |
the non-Gaussian shape (type=1 local, type=2 equilateral, type=3 enfolded, type=4 orthogonal) | |
double | m_tau |
\(\tau\): Thomson scattering optical depth due to reionization | |
double | m_rs |
\(r_s\) the sound horizon | |
double | m_Pk0_EH |
the normalisation of the power spectrum for Eisenstein & Hu [http://background.uchicago.edu/~whu/transfer/transferpage.html] | |
double | m_Pk0_CAMB |
the normalisation of the power spectrum for CAMB [http://camb.info/] | |
double | m_Pk0_MPTbreeze |
the normalisation of the power spectrum for MPTbreeze [http://arxiv.org/abs/1207.1465] | |
double | m_Pk0_CLASS |
the normalisation of the power spectrum for CLASS [http://class-code.net/] | |
std::string | m_model |
the cosmologial model used to compute distances | |
bool | m_unit |
false \(\rightarrow\) quantities are provided in phyical units; true \(\rightarrow\) quantities are provided in cosmological units (i.e. in units of h, e.g. Mpc/h) | |
The class Cosmology.
This class is used to handle objects of type cosmology . It can be used to estimate i) any kind of cosmic distances and volumes, ii) the halo mass function and bias, iii) the real-space and redshift-space dark matter power spectrum and correlation function (with both CAMB, CLASS, MPTbreeze and the analytic fitting forms by Eisenstein & Hu), iv) the accreted mass function, v) several BAO parameters, and vi) the halo mass function and bias in different non-Gaussian cosmological frameworks.
Definition at line 277 of file Cosmology.h.
cbl::cosmology::Cosmology::Cosmology | ( | const double | Omega_matter = 0.27 , |
const double | Omega_baryon = 0.046 , |
||
const double | Omega_neutrinos = 0. , |
||
const double | massless_neutrinos = 3.04 , |
||
const int | massive_neutrinos = 0 , |
||
const double | Omega_DE = 0.73 , |
||
const double | Omega_radiation = 0. , |
||
const double | hh = 0.7 , |
||
const double | scalar_amp = 2.46e-9 , |
||
const double | scalar_pivot = 0.05 , |
||
const double | n_spec = 0.96 , |
||
const double | w0 = -1. , |
||
const double | wa = 0. , |
||
const double | fNL = 0. , |
||
const int | type_NG = 1 , |
||
const double | tau = 0.09 , |
||
const std::string | model = "LCDM" , |
||
const bool | unit = true |
||
) |
constructor
Omega_matter | \(\Omega_M\): the density of baryons, cold dark matter and massive neutrinos (in units of the critical density) at z=0 |
Omega_baryon | \(\Omega_b\): the density of baryons at z=0 |
Omega_neutrinos | \(\Omega_\nu\): the density of massive neutrinos at z=0 |
massless_neutrinos | the effective number (for QED + non-instantaneous decoupling) |
massive_neutrinos | the number of degenerate massive neutrino species |
Omega_DE | \(\Omega_{DE}\): the density of dark energy at z=0 |
Omega_radiation | \(\Omega_{rad}\): the density of radiation at z=0 |
hh | h: the Hubble parameter, \(H_0/100\) |
scalar_amp | \(A_s\): the initial scalar amplitude of the power spectrum |
scalar_pivot | the scalar pivot k in \(Mpc^{-1}\) |
n_spec | \(n_{spec}\): the primordial spectral index |
w0 | \(w_0\): one of the two parameters of the dark energy equation of state (CPL parameterisation) |
wa | \(w_a\): one of the two parameters of the dark energy equation of state (CPL parameterisation) |
fNL | \(f_{NL}\): the non-Gaussian amplitude |
type_NG | the non-Gaussian shape (type=1 local, type=2 equilateral, type=3 enfolded, type=4 orthogonal) |
tau | \(\tau\): Thomson scattering optical depth due to reionization |
model | the cosmologial model used to compute distances |
unit | false \(\rightarrow\) quantities are provided in phyical units; true \(\rightarrow\) quantities are provided in cosmological units (i.e. in units of h, e.g. Mpc/h) |
Definition at line 165 of file Cosmology.cpp.
cbl::cosmology::Cosmology::Cosmology | ( | const CosmologicalModel | cosmoModel, |
const std::string | model = "LCDM" , |
||
const bool | unit = true |
||
) |
constructor using built-in cosmological models
by default: \(\Omega_k = 1-\Omega_M-\Omega_{rad}-\Omega_{DM}\), \(\Omega_{CDM} = \Omega_M-\Omega_b-\Omega_\nu\), \(t_H = 1-H_0\) \(D_H = c/t_H\) \(\rho_0 = \rho_0(\Omega_M, \Omega_nu)\)
cosmoModel | the built-in cosmological model |
model | the cosmologial model used to compute distances |
unit | false \(\rightarrow\) quantities are provided in phyical units; true \(\rightarrow\) quantities are provided in cosmological units (i.e. in units of h, e.g. Mpc/h) |
Definition at line 173 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Am | ( | const std::string | method_Pk, |
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the amplitude of the matter power spectrum
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
vector< double > cbl::cosmology::Cosmology::AP_corr | ( | const cbl::cosmology::Cosmology | cosm_true, |
const std::vector< double > | redshift | ||
) |
Supplementary function to compute a correction factor to apply to the void size function, to predict the measured abundance of voids affected by geometrical distortions (Alcock-Paczyński change of volume). These are caused by the assumption of a fiducial cosmology different from the true one, see Correa et al. 2020 (https://arxiv.org/pdf/2007.12064.pdf)
cosm_true | the true cosmology of the catalogue |
redshift | the vector of redshifts of different samples of voids |
Definition at line 96 of file SizeFunction.cpp.
double cbl::cosmology::Cosmology::As | ( | const double | sigma8 | ) | const |
amplitude of the curvature perturbations
this function provides an approximate value of As, for a fiven value of σ8, from Eq.(3) by Vikhlinin et al. 2009, ApJ, 692, 1060; it is valid only without massive neutrinos! (see also Hu & Jain 2004)
sigma8 | σ8 the power spectrum normalisation |
double cbl::cosmology::Cosmology::Az | ( | const double | redshift | ) | const |
double cbl::cosmology::Cosmology::beta | ( | const double | Mass_min, |
const double | Mass_max, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the error on the specific growth rate β
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::beta | ( | const double | redshift, |
const double | bias | ||
) | const |
double cbl::cosmology::Cosmology::beta | ( | const std::vector< double > | MM, |
const std::vector< double > | MF, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the specific growth rate β
MM | vector of halo masses |
MF | vector of mass function values, dΦ/dM=dn(M)/dM |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::bias_correction | ( | const double | kk, |
const double | mass, | ||
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
correction to the halo bias in non-Gaussian cosmologies
kk | wave vector module |
mass | halo mass |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::bias_eff | ( | const double | Mass_min, |
const double | Mass_max, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the effective bias of dark matter haloes, with masses in a given range and at a given mean redshift
this function computes the effective bias of dark matter haloes:
\[ b_{eff}(z) = \frac{\int_{M_{min}}^{M_{max}} {\rm d}M\, b(M, z) \Phi(M, z)}{\int_{M_{min}}^{M_{max}} {\rm d}M\,\Phi(M, z)} \]
in the current implementation, the integral is actually replaced by the Riemann sum, as follows:
\[ b_{eff}(z) \simeq \frac{\sum_{i_{min}}^{i_{max}} b(M, z) \Phi(M, z) (M_{i+1}-M_i)}{\sum_{i_{min}}^{i_{max}} \Phi(M, z) (M_{i+1}-M_i)} \]
where the halo mass function, \(\Phi(M, z)\), is computed by cbl::cosmology::Cosmology::mass_function and the linear bias, \(b(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::bias_eff | ( | const std::vector< double > | MM, |
const std::vector< double > | MF, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed by averaging over the bias of a given set of haloes
this function computes the effective bias of dark matter haloes as follows:
\[ b_{eff}(z) = \frac{\int_{M_{min}}^{M_{max}} {\rm d}M\, b(M, z) \Phi(M, z)}{\int_{M_{min}}^{M_{max}} {\rm d}M\,\Phi(M, z)} \]
in the current implementation, the integral is actually replaced by the Riemann sum, as follows:
\[ b_{eff}(z) \simeq \frac{\sum_{i_{min}}^{i_{max}} b(M, z) \Phi(M, z) (M_{i+1}-M_i)}{\sum_{i_{min}}^{i_{max}} \Phi(M, z) (M_{i+1}-M_i)} \]
where the halo mass function is provided in input and the linear bias, \(b(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo
MM | vector of halo masses |
MF | vector of mass function values, dΦ/dM=dn(M)/dM |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
vector< double > cbl::cosmology::Cosmology::bias_eff_mass | ( | const std::vector< double > | mass, |
const std::vector< double > | mass_grid, | ||
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const std::string | meanType = "mean_bias" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes, interpolating the mass variance on a grid
this function computes the effective bias of dark matter haloes by either averaging the bias of a set of haloes with a given mass:
\[b_{eff}(z) = \frac{1}{N_{halo}}\sum_{i=1}^{N_{halo}} b(M_i, z_i) \; , \; (1)\]
or by averaging over halo pairs:
\[b_{eff}(z) = \sqrt{ \frac{2}{N_{halo}(N_{halo}-1)} \sum_{i=1}^{N_{halo}}\sum_{j=i+1}^{N_{halo}} b(M_i, z_i)b(M_j, z_j)} \; , \; (2)\]
where the linear bias of the \(i\)-th halo, \(b^{i}(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo; the mass variance is computed by cbl::cosmology::Cosmology::sigma2M
mass | vector containing the halo masses |
mass_grid | vector containing the halo masses on the grid used to interpolate the mass variance |
redshift | vector containing the redshifts; if it has size=1, it will be considered as the main redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
meanType | meanType="mean_bias" \(\rightarrow\) the effective bias is computed with Eq.(1); meanType="mean_pair_bias" \(\rightarrow\) the effective bias is computed with Eq.(2) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\): the background overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
vector< double > cbl::cosmology::Cosmology::bias_eff_mass | ( | const std::vector< double > | MM, |
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const std::string | meanType = "mean_bias" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes
this function computes the effective bias of dark matter haloes by either averaging the bias of a set of haloes with a given mass:
\[b_{eff}(z) = \frac{1}{N_{halo}}\sum_{i=1}^{N_{halo}} b(M_i, z_i) \; , \; (1)\]
or by averaging over halo pairs:
\[b_{eff}(z) = \sqrt{ \frac{2}{N_{halo}(N_{halo}-1)} \sum_{i=1}^{N_{halo}}\sum_{j=i+1}^{N_{halo}} b(M_i, z_i)b(M_j, z_j)} \; , \; (2)\]
where the linear bias of the \(i\)-th halo, \(b^{i}(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo; the mass variance is computed by cbl::cosmology::Cosmology::sigma2M
MM | vector containing the halo masses |
redshift | vector containing the redshifts; if it has size=1, it will be considered as the main redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
meanType | meanType="mean_bias" \(\rightarrow\) the effective bias is computed with Eq.(1); meanType="mean_pair_bias" \(\rightarrow\) the effective bias is computed with Eq.(2) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\): the background overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
vector< double > cbl::cosmology::Cosmology::bias_eff_mass_grid | ( | const std::vector< double > | MM, |
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const std::string | meanType = "mean_bias" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta_crit = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes, with the mass variance estimated from a grid
this function computes the effective bias of dark matter haloes by either averaging the bias of a set of haloes with a given mass:
\[b_{eff}(z) = \frac{1}{N_{halo}}\sum_{i=1}^{N_{halo}} b(M_i, z_i) \; , \; (1)\]
or by averaging over halo pairs:
\[b_{eff}(z) = \sqrt{ \frac{2}{N_{halo}(N_{halo}-1)} \sum_{i=1}^{N_{halo}}\sum_{j=i+1}^{N_{halo}} b(M_i, z_i)b(M_j, z_j)} \; , \; (2)\]
where the linear bias of the \(i\)-th halo, \(b^{i}(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo; the mass variance is estimated from a grid by cbl::cosmology::Cosmology::create_grid_sigmaM
MM | vector containing the halo masses |
redshift | vector containing the redshifts; if it has size=1, it will be considered as the main redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
meanType | meanType="mean_bias" \(\rightarrow\) the effective bias is computed with Eq.(1); meanType="mean_pair_bias" \(\rightarrow\) the effective bias is computed with Eq.(2) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta_crit | \(\Delta_{crit}\): the critical overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
vector< double > cbl::cosmology::Cosmology::bias_eff_selection_function | ( | const double | Mass_min, |
const double | Mass_max, | ||
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const std::string | selection_function_file, | ||
const std::vector< int > | column = {} , |
||
const double | alpha = 1. , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta_crit = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed using a given selection function
this function computes the effective bias of dark matter haloes:
\[ b_{eff}(z) = \frac{\int_{M_{min}}^{M_{max}} {\rm d}M\, b(M, z) \Phi(M, z) f(M, z)}{\int_{M_{min}}^{M_{max}} {\rm d}M\,\Phi(M, z) f(M, z)} \]
in the current implementation, the integral is actually replaced by the Riemann sum, as follows:
\[ b_{eff}(z) \simeq \frac{\sum_{i_{min}}^{i_{max}} b(M, z) \Phi(M, z) f(M, z) (M_{i+1}-M_i)}{\sum_{i_{min}}^{i_{max}} \Phi(M, z) f(M, z) (M_{i+1}-M_i)} \]
where the halo mass function, \(\Phi(M, z)\), is computed by cbl::cosmology::Cosmology::mass_function, the linear bias, \(b(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo, and f(M, z) is the selection function
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | vector containing the input redshifts |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
selection_function_file | input file with the selection functon |
column | vector containing the three columns of the selection function file to be read |
alpha | the \(\alpha\) parameter of the cluster mass scaling relation |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta_crit | \(\Delta_{crit}\): the critical overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
vector< double > cbl::cosmology::Cosmology::bias_eff_selection_function | ( | const glob::FuncGrid | interp_sigma, |
const glob::FuncGrid | interp_DnSigma, | ||
const glob::FuncGrid | interp_SF, | ||
const double | Mass_min, | ||
const double | Mass_max, | ||
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const double | alpha = 1. , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta_crit = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed using a given selection function; σ(mass) and dlnσ/dM are provided in input
this function computes the effective bias of dark matter haloes:
\[ b_{eff}(z) = \frac{\int_{M_{min}}^{M_{max}} {\rm d}M\, b(M, z) \Phi(M, z) f(M, z)}{\int_{M_{min}}^{M_{max}} {\rm d}M\,\Phi(M, z) f(M, z)} \]
in the current implementation, the integral is actually replaced by the Riemann sum, as follows:
\[ b_{eff}(z) \simeq \frac{\sum_{i_{min}}^{i_{max}} b(M, z) \Phi(M, z) f(M, z) (M_{i+1}-M_i)}{\sum_{i_{min}}^{i_{max}} \Phi(M, z) f(M, z) (M_{i+1}-M_i)} \]
where the halo mass function, \(\Phi(M, z)\), is computed by cbl::cosmology::Cosmology::mass_function, the linear bias, \(b(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo, and f(M, z) is the selection function
interp_sigma | FuncGrid object containing the values of σ(mass) computed on a grid, used by interpolation |
interp_DnSigma | FuncGrid object containing the values of dlnσ/dM computed on a grid, used by interpolation |
interp_SF | FuncGrid object containing the values of the selection function computed on a grid in mass, at the mean redshift, used by interpolation |
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | vector containing the input redshifts |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
alpha | the \(\alpha\) parameter of the cluster mass scaling relation |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta_crit | \(\Delta_{crit}\): the critical overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
vector< double > cbl::cosmology::Cosmology::bias_eff_selection_function | ( | const glob::FuncGrid | interp_sigma, |
const glob::FuncGrid | interp_DnSigma, | ||
const glob::FuncGrid2D | interp_SF, | ||
const double | Mass_min, | ||
const double | Mass_max, | ||
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const double | alpha = 1. , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta_crit = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed using a given selection function; σ(mass) and dlnσ/dM are provided in input
this function computes the effective bias of dark matter haloes:
\[ b_{eff}(z) = \frac{\int_{M_{min}}^{M_{max}} {\rm d}M\, b(M, z) \Phi(M, z) f(M, z)}{\int_{M_{min}}^{M_{max}} {\rm d}M\,\Phi(M, z) f(M, z)} \]
in the current implementation, the integral is actually replaced by the Riemann sum, as follows:
\[ b_{eff}(z) \simeq \frac{\sum_{i_{min}}^{i_{max}} b(M, z) \Phi(M, z) f(M, z) (M_{i+1}-M_i)}{\sum_{i_{min}}^{i_{max}} \Phi(M, z) f(M, z) (M_{i+1}-M_i)} \]
where the halo mass function, \(\Phi(M, z)\), is computed by cbl::cosmology::Cosmology::mass_function, the linear bias, \(b(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo, and f(M, z) is the selection function
interp_sigma | FuncGrid object containing the values of σ(mass) computed on a grid, used by interpolation |
interp_DnSigma | FuncGrid object containing the values of dlnσ/dM computed on a grid, used by interpolation |
interp_SF | FuncGrid2D object containing the values of the selection function computed on a grid in mass and redshift, used by interpolation |
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | vector containing the input redshifts |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
alpha | the \(\alpha\) parameter of the cluster mass scaling relation |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta_crit | \(\Delta_{crit}\): the critical overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::bias_halo | ( | const double | Mass, |
const double | redshift, | ||
const std::string | author, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
bias of dark matter haloes
Mass | halo mass |
redshift | the redshift |
author | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::bias_halo | ( | const double | Mass, |
const double | Sigma, | ||
const double | redshift, | ||
const double | DN, | ||
const std::string | model_bias, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | method_SS = "CAMB" , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
bias of dark matter haloes
Mass | halo mass |
Sigma | σ(mass, z=0): the mass variance at z=0 |
redshift | the redshift |
DN | normalised amplitude of the growing mode at a given redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::bias_halo | ( | const double | Mass, |
const double | Sigma, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | method_SS = "CAMB" , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
bias of dark matter haloes
Mass | halo mass |
Sigma | σ(mass, z=0): the mass variance at z=0 |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
vector< double > cbl::cosmology::Cosmology::bias_halo | ( | const std::vector< double > | Mass, |
const std::vector< double > | Sigma, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | method_SS = "CAMB" , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
bias of dark matter haloes, for a vector of masses
Mass | halo mass |
Sigma | σ(mass, z=0): the mass variance at z=0 |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 44 of file Bias_vector.cpp.
double cbl::cosmology::Cosmology::bispectrum | ( | const std::vector< double > | kk, |
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the bispectrum
kk | wave vector module |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
std::vector< double > cbl::cosmology::Cosmology::C_l_DM | ( | const int | lmax, |
const std::vector< double > | zz, | ||
const std::vector< double > | phiz, | ||
const std::string | interpolationMethod, | ||
const std::string | method_Pk = "CAMB" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 1.e-4 , |
||
const double | k_max = 100 , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the dark matter angular linear power spectrum \(C_l\).
this function provides the angular linear power spectrum using the Limber approximation up to a given \(l_{max}\):
\[ C_l = \int_{z_{min}}^{z_{max}}\phi^2(z) D^2(z) P(\frac{l}{D_C(z)}) \frac{H(z)}{c \cdot D_c(z)} dz \]
where l is the multipole order, \(\phi(z)\) is the tracers redshift distribution, \(P\) is the \(z=0\) power spectrum and \(D(z)\) is the growth factor. \(D_C(z)\) and \(H(z)\) are respectively the comoving function and the Hubble parameter.
lmax | the maximum multipole order |
zz | the redshift range |
phiz | the number density |
interpolationMethod | the method in interpolation |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalize the power spectrum; 1 \(\rightarrow\) normalize the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::c_vir | ( | const double | c200, |
const double | redshift, | ||
const std::string | author = "BryanNorman" |
||
) | const |
virial halo concentration given \(c_{200}\)
this function provides an approximate conversion to compute \(c_{vir}\) from \(c_{200}\) (from Coe 2010):
\[c_{vir}\simeq a\,c_{200}+b\]
\[a\simeq-1.119\log\Delta_c(z)+3.537\]
\[b\simeq-0.967\log\Delta_c(z)+2.181\]
where \(\Delta_c(z)\) is computed by cbl::cosmology::Cosmology::Delta_c
c200 | \(c_{200}\) |
redshift | the redshift |
author | the author of the \(\Delta_c(z)\) equation (see cbl::cosmology::Cosmology::Delta_c) |
Definition at line 1340 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::CMN | ( | const double | rr, |
const double | k_int_min, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_max = 100. , |
||
const std::string | file_par = par::defaultString |
||
) | const |
the Cosmic Mach Number
rr | comoving radius |
k_int_min | minimum wave vector module up to which the integral is computed |
method_Pk | method used to compute the power spectrum and σ(mass) (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_max | maximum wave vector module up to which the power spectrum is computed |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 132 of file Velocities.cpp.
double cbl::cosmology::Cosmology::concentration_NFW_Duffy | ( | const double | Mass, |
const double | redshift, | ||
const std::string | halo_def = "vir" |
||
) | const |
the halo concentration-mass relation for NFW prfile and Duffy model
This function computes the concentration of a dark matter halo of a given a mass, at a given redshift following Duffy et al. 2008 model:
\[c(M_h, z) = A(M_h/M_{pivot})^B\,(1+z)^C\]
Mass | the halo mass. |
redshift | the redshift (must be < 2). |
halo_def | the halo definition; available options are: "vir" \(\rightarrow\) all matter withing the radius \(r_{vir}\) for which the mean internal density is \(\Delta\) times the critical density \(\rho_{crit}=3H^2/8\pi G\); "200" \(\rightarrow\) all matter withing the radius \(r_{200}\) for which the mean internal density is 200 times the critical density; "mean" \(\rightarrow\) all matter withing the radius \(r_{200}\) for which the mean internal density is 200 times the critical mean background density. |
Definition at line 1461 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::converted_mass | ( | const double | mass, |
const cosmology::Cosmology | cosmology, | ||
const double | redshift, | ||
const double | redshift_source = -1. |
||
) | const |
convert a cluster mass estimated in a different cosmology
this function converts a cluster mass estimated assuming a different cosmology, following Eq.C4 of Sereno & Ettori 2015 (https://arxiv.org/abs/1407.7868)
\[ M^{(2)} = M^{(1)} \left( \frac{D_{ds}^{(1)}}{D_s^{(1)}} \right)^{3/2} H^{(1)} \left( \frac{D_{ds}^{(2)}}{D_s^{(2)}}\right)^{-3/2} H^{(2) -1} \]
where and \(D_s\) and \(D_{ds}\) are the source and the lens-source angular diameter distances, respectively
mass | the cluster mass to be converted (since estimated in a different cosmology), \(M^{(1)}\) |
cosmology | the cosmology assumed to measure the cluster mass |
redshift | redshift of the cluster |
redshift_source | redshift of the source, if the cluster mass is estimated from weak lensing, -1 otherwise |
Definition at line 962 of file MassFunction.cpp.
double cbl::cosmology::Cosmology::cosmic_time | ( | const double | redshift = 0. | ) | const |
cosmic time at a given redshift
redshift | the redshift |
Definition at line 947 of file Cosmology.cpp.
std::string cbl::cosmology::Cosmology::create_grid_sigmaM | ( | const std::string | method_SS, |
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
auxiliary function to create a grid file with σ(M)
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::cumPw | ( | const double | ww, |
const double | ff, | ||
const std::string | author | ||
) | const |
cumulative distribution
this function provides the cumulative rescaled and generalized formation redshift distribution
ww | rescaled variable w as in Lacey and Coles 1993 |
ff | assembled fraction |
author | valid authors are: NS (Nusser and Sheth), GTS (Giocoli et al. 2012) |
Definition at line 97 of file MassGrowth.cpp.
double cbl::cosmology::Cosmology::D_A | ( | const double | redshift | ) | const |
the angular diameter distance at a given redshift
redshift | the redshift |
Definition at line 848 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::D_A | ( | const double | z1, |
const double | z2 | ||
) | const |
the angular diameter distance between objects at two redshifts
this function provides the angular diameter distance \(D_{A,12}\) between two objects at redshifts \(z_1\) and \(z_2\), as follows:
\[ D_{A,12} = \frac{1}{1+z_2} \left[ D_M(z_2)\sqrt{1+\Omega_k\frac{D_M^2(z_1)}{D_H^2}} - D_M(z_1)\sqrt{1+\Omega_k\frac{D_M^2(z_2)}{D_H^2}} \right] \]
(e.g. Eq.19 of Hogg 2000)
z1 | the redshift of the first object |
z2 | the redshift of the second object |
Definition at line 857 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::D_C | ( | const double | redshift | ) | const |
the comoving line-of-sight distance at a given redshift
for demonstration, see distances.cpp
redshift | the redshift |
Definition at line 741 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::D_C_LCDM | ( | const double | redshift | ) | const |
the comoving line-of-sight distance at a given redshift
this method provides the comoving distance for a given redshift using elliptic integrals (see Numer. Math. (2010) 116:687–719, T. Fukushima "Fast computation of incomplete elliptic integral of first kind by half argument transformation")
d(z) is computed using the following formula, taken from A. Meszaros & J. Ripa 2013, arXiv:1306.4736,
d(z) = C*[F(φ0,m)-F(φ1,m)]
where
C = 3-1/4 / (ΩM1/3*ΩΛ1/6)
φ0 = arccos( [1+(1-30.5)*(ΩΛ/ΩM)1/3] / [1+(1+30.5)*(ΩΛ/ΩM)1/3] )
φ1 = arccos( [1+(1-30.5)*(ΩΛ/ΩM)1/3*(1+z)] / [1+(1+30.5)*(ΩΛ/ΩM)1/3*(1+z)] )
F(φ, m) is the incomplete elliptic integral of the first kind, with argument φ
m = (2+30.5)/4 is the elliptic integral shape parameter
for demonstration, see distances.cpp
redshift | the redshift |
Definition at line 1351 of file Cosmology.cpp.
void cbl::cosmology::Cosmology::D_C_table | ( | const std::string | file_table, |
const double | z_min, | ||
const double | z_max, | ||
const int | step, | ||
std::vector< double > & | Redshift, | ||
std::vector< double > & | dc | ||
) | const |
create a table of [redshift, comoving line-of-sight distance]
this function is used to create a table of [redshift, comoving line-of-sight distance], useful to speed up the analysis
[in] | file_table | name of the file where the table is stored |
[in] | z_min | minimum redshift of the table |
[in] | z_max | maximum redshift of the table |
[in] | step | redshift step |
[out] | Redshift | vector of redshifts |
[out] | dc | vector of comoving line-of-sight distances |
Definition at line 794 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_D_H
Definition at line 1205 of file Cosmology.h.
double cbl::cosmology::Cosmology::D_L | ( | const double | redshift | ) | const |
the luminosity distance at a given redshift
redshift | the redshift |
Definition at line 875 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::D_M | ( | const double | redshift | ) | const |
the comoving transverse distance at a given redshift
redshift | the redshift |
Definition at line 832 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::D_V | ( | const double | redshift | ) | const |
the average distance at a given redshift, used to rescale the correlation function
redshift | the redshift |
Definition at line 884 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::DD | ( | const double | redshift | ) | const |
the amplitude of the growing mode at a given redshift, \(D(z)\)
this function computes the following quantity (see Eq.(15) by Percival (2005), A&A 443, 819):
\[ D(z) = \frac{5 \Omega_{M,0} }{2} E(a) \int_0^a \frac{{\rm d}\,a'}{[a' E(a')]^3} \]
where \(a=1/(1+z)\)
redshift | the redshift |
Definition at line 702 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Delta_c | ( | const double | redshift, |
const std::string | author = "BryanNorman" |
||
) | const |
the critical overdensity
this function computes the critical overdensity, \(\Delta_c(z)\equiv\Delta^{vir}_c(z)\), using approximated equations valid only for a flat Universe (see e.g. Coe 2010), where \(\rho_{vir} = \Delta^{vir}_c\rho_c = \Delta^{vir}_b\rho_m = \Delta^{vir}_b\Omega_M\rho_c\):
Bryan & Norman (1998)
\[\Delta_c\simeq18\pi^2+60x-32x^2\, \mbox{for}\, \Omega_\Lambda=0\]
\[\Delta_c\simeq18\pi^2+82x-39x^2\, \mbox{for}\, \Omega_k=0\]
\[x=\Omega_M(z)-1\]
Eke et al. (1998)
\[\Delta_c\simeq178\Omega_M(z)^{0.3}\, \mbox{for}\, \Omega_\Lambda=0\]
\[\Delta_c\simeq178\Omega_M(z)^{0.45}\, \mbox{for}\, \Omega_k=0\]
Nakamura & Suto (1998)
\[\Delta_c\simeq18\pi^2(1+0.4093x^{2.7152})\Omega_M(z)\]
\[x=(1-\Omega_{M,0})^{1/3}(1+z)^{-1}\]
redshift | the redshift |
author | the author of the equation implemented; available options are: "BryanNorman", "Eke", "NakamuraSuto" |
Definition at line 1283 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::deltac | ( | const double | redshift | ) | const |
spherical collapse density threshold at a given redshift
this function computes the spherical collapse density threshold, \(\delta_c\), by using the approximated equation (C.28) provided by Nakamura & Suto (1997)
\[\delta_c(z) \simeq \frac{3}{20}(12\pi)^{2/3} \{1.+0.012299\log[\Omega_M(z)]\}\]
redshift | the redshift |
Definition at line 1248 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::deltav_L | ( | const double | deltav_NL, |
const double | b_eff, | ||
double | slope = 0.854 , |
||
double | offset = 0.420 |
||
) | const |
Linear (under)density contrast.
deltav_NL | the non linear density contrast: \(\rho_v/\rho_m\) (default value set to \(-0.795\)) |
b_eff | the effective bias of the sample |
slope | first coefficent to convert the effective bias (default value set to \(0.854\)) |
offset | second coefficent to convert the effective bias (default value set to \(0.420\)) |
Definition at line 44 of file SizeFunction.cpp.
double cbl::cosmology::Cosmology::deltav_NL | ( | const double | deltav = -2.71 | ) | const |
Non-Linear (under)density contrast.
deltav | the linear density contrast: \(\delta_v\) (default value set to \(-2.71\)) |
Definition at line 56 of file SizeFunction.cpp.
double cbl::cosmology::Cosmology::denominator_Q | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
const std::vector< double > | rr, | ||
const std::vector< double > | xi_matter | ||
) | const |
the normalization factor for reduced three-point correlation function
this function computes the normalization factor for reduced three-point correlation function:
\[ \xi(r_1)\cdot\xi(r_2) + \xi(r_2)\cdot\xi(r_3) + \xi(r_3)\cdot\xi(r_1) \]
with \( r_3 = \sqrt{r_1^2+r_2^2-2 r_1 r_2 \cos(\theta)} \)
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | the angle between r1 and r2 |
rr | vector containing the scales at which the two-point correlation function is computed |
xi_matter | vector containing the dark matter two-point correlation function values, estimated at the scales given in rr |
double cbl::cosmology::Cosmology::Distance | ( | const double | redshift, |
const std::string | distance_type | ||
) | const |
the distance at a given redshift
The distances available are: DC,DL,DA,DV, DV/rs, rs/DV
redshift | the redshift |
distance_type | the type of distance to return |
Definition at line 902 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::DN | ( | const double | redshift, |
const double | redshift_norm = 0. , |
||
const double | prec = 1.e-4 |
||
) | const |
the normalised amplitude of the growing mode at a given redshift, \(D(z)/D(0)\)
this function computes the following quantity:
\[ \frac{D(z)}{D(z_{norm})} = \exp{\int_{a_{norm}}^{a} \frac{f}{a'} {\rm d}a'} \]
where \(a=1/(1+z)\), \(a_{norm}=1/(1+z_{norm})\), and \(f\) is the linear growth rate computed by cbl::cosmology::Cosmology::linear_growth_rate
redshift | the redshift |
redshift_norm | the redshift at with the amplitude of the growing mode is normalised |
prec | precision used for the resolution of the differential equation when the the normalised growth factor is computed |
Definition at line 691 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::dnsigma2M | ( | const int | nd, |
const double | mass, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const bool | unit1 = false |
||
) | const |
the first derivative of the mass variance, \({\rm d}^n\sigma^2(M)/{\rm d}M^n\)
nd | the derivative order, \(n\) |
mass | the mass, \(M\) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
unit1 | true \(\rightarrow\) force cosmological units |
double cbl::cosmology::Cosmology::dnsigma2R | ( | const int | nd, |
const double | radius, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const bool | unit1 = false |
||
) | const |
the nth-order derivative of the mass variance, \({\rm d}^n\sigma^2(R)/{\rm d}R^n\)
nd | the derivative order, \(n\) |
radius | the radius, \(R\) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
unit1 | true \(\rightarrow\) force cosmological units |
double cbl::cosmology::Cosmology::dskewnessdM | ( | const double | mass, |
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the derivative of the skewness, ds/dM
mass | halo mass |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::dV_dZdOmega | ( | const double | redshift, |
const bool | angle_rad | ||
) | const |
the derivative of the comoving volume, d2V/(dz*dΩ) at a given redshift
redshift | the redshift |
angle_rad | false \(\rightarrow\) Ω in square degrees; true \(\rightarrow\) Ω in steradians |
Definition at line 1236 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::EE | ( | const double | redshift = 0. | ) | const |
auxiliary function used to compute the Hubble function
redshift | the redshift |
Definition at line 561 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::EE2 | ( | const double | redshift = 0. | ) | const |
auxiliary function used to compute the deceleration parameter
redshift | the redshift |
Definition at line 964 of file Cosmology.cpp.
|
inline |
inverse of the auxiliary function used to compute the Hubble function integrand of the comoving distance
redshift | the redshift |
Definition at line 1910 of file Cosmology.h.
|
inline |
inverse of the auxiliary function used to compute the Hubble function, integrand of the lookback time
redshift | the redshift |
Definition at line 1919 of file Cosmology.h.
|
inline |
inverse of the auxiliary function used to compute the Hubble function integrand of the cosmic time
aa | 1/(1+z) |
Definition at line 1928 of file Cosmology.h.
void cbl::cosmology::Cosmology::eff_l_l1 | ( | std::vector< std::vector< double >> & | eff, |
const std::vector< double > | rr, | ||
const int | l, | ||
const int | l1, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk | ||
) |
compute the power spectrum integral transform
this function computes the power spectrum integral transform:
\[ f_{l, l_1} (r_i;r)= \int \frac{k^2\mathrm{d}k}{2\pi^2} j_l(kr_i) j_{l_1} (kr) k P(k) \]
where \(l, l_1\) are the orders of the transform.
eff | the power spectrum transform \( f_{l, l_1} (r_i;r) \) |
rr | vector of scales |
l | the order \(l\) |
l1 | the order \(l_1\) |
kk | vector of wavevector modules |
Pk | dark matter power spectrum |
double cbl::cosmology::Cosmology::error_beta | ( | const double | Mass_min, |
const double | Mass_max, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const double | err_bias, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the specific growth rate β
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
err_bias | error on the bias |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::error_beta | ( | const double | redshift, |
const double | bias, | ||
const double | err_bias | ||
) | const |
double cbl::cosmology::Cosmology::error_beta | ( | const std::vector< double > | MM, |
const std::vector< double > | MF, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const double | err_bias, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the error on the specific growth rate β
MM | vector of halo masses |
MF | vector of mass function values, dΦ/dM=dn(M)/dM |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
err_bias | error on the bias |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::error_beta_measured | ( | const double | Volume, |
const double | density, | ||
const double | Mass_min, | ||
const double | Mass_max, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the error on the specific growth rate β from Bianchi et al. 2012
Volume | comoving volume |
density | comoving density |
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::F2 | ( | const double | k, |
const double | q, | ||
const double | kq | ||
) |
function used to estimate the non-linear power spectrum
this function computes the following equation, which is used to estimate the non-linear power spectrum estimate the non-linear power spectrum following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ F_2 = \frac{5}{7} + \frac{kq}{2}\left(\frac{k}{q} + \frac{q}{k}\right) + \frac{2}{7}(kq)^2 \]
k | the wavevector module |
q | |
kq |
Definition at line 77 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::F_AP | ( | const double | redshift | ) | const |
F_AP, the ALCOCK-PACZYNSKI distortion parameter.
redshift | the redshift |
Definition at line 893 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::f_DE | ( | const double | redshift = 0. | ) | const |
auxiliary function used to compute the Hubble function
this function returns fDE(z), a parameter that multiplies ΩDE in the Hubble function (see e.g. Bassett & Hlozek 2010)
redshift | the redshift |
Definition at line 544 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::f_k | ( | const double | k, |
const std::shared_ptr< cbl::glob::FuncGrid > | PkLin, | ||
const double | qmin, | ||
const double | qmax, | ||
const double | prec = 1.e-3 |
||
) |
function used to estimate the non-linear power spectrum
this function computes the following integral, which is used to estimate the non-linear power spectrum estimate the non-linear power spectrum following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ f(k) = \int_{q_{min}}^{q_{max}} \mathrm{d}q\, q^2P(k)\frac{1}{504k^3q^5}\left[ 6k^7q-79k^5q^3+50k^3q^5-21kq^7+\frac{3}{4}\left(k^2-q^2\right)^3 \left(2k^2+7q^2\right)\ln\left(\frac{(k-q)^2}{(k+q)^2}\right) \right] \]
k | the wavevector module |
PkLin | linear power spectrum |
qmin | |
qmax | |
prec | the integral precision |
Definition at line 47 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::f_nu | ( | const double | SS, |
const double | del_v, | ||
const double | del_c | ||
) | const |
\(f_{\ln \sigma}(\sigma)\) (approximation)
SS | variance of the linear density field ( \(\sigma^2(R)\)) |
del_v | linear density contrast defining a void |
del_c | critical value of the linear density field |
Definition at line 74 of file SizeFunction.cpp.
|
inline |
get the private member Cosmology::m_fNL
Definition at line 1265 of file Cosmology.h.
double cbl::cosmology::Cosmology::frk | ( | const double | kk, |
const double | mass, | ||
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
auxiliary function to estimate cosmological quantities in non-Gaussian cosmologies
kk | wave vector module |
mass | halo mass |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::fsigma8 | ( | const double | redshift, |
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | NL = false , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) | const |
f*σ8: the linear growth rate times the dark matter rms mass fluctuation within 8 Mpc/h
redshift | the redshift |
method_Pk | method used to compute the power spectrum and σ(mass) (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
NL | false \(\rightarrow\) linear power spectrum; false \(\rightarrow\) non-linear power spectrum |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::G2 | ( | const double | k, |
const double | q, | ||
const double | kq | ||
) |
function used to estimate the non-linear power spectrum
this function computes the following equation, which is used to estimate the non-linear power spectrum estimate the non-linear power spectrum following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ G_2 = \frac{3}{7} + \frac{kq}{2}\left(\frac{k}{q} + \frac{q}{k}\right) + \frac{4}{7}(kq)^2 \]
k | the wavevector module |
q | |
kq |
Definition at line 86 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::g_k | ( | const double | k, |
const std::shared_ptr< cbl::glob::FuncGrid > | PkLin, | ||
const double | qmin, | ||
const double | qmax, | ||
const double | prec = 1.e-3 |
||
) |
function used to estimate the non-linear power spectrum
this function computes the following integral, which is used to estimate the non-linear power spectrum estimate the non-linear power spectrum following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ f(k) = \int_{q_{min}}^{q_{max}} \mathrm{d}q\, q^2P(k)\frac{1}{168k^3q^5}\left[ 6k^7q-41k^5q^3+2k^3q^5-3kq^7+\frac{3}{4}\left(k^2-q^2\right)^3 \left(2k^2+q^2\right)\ln\left(\frac{(k-q)^2}{(k+q)^2}\right) \right] \]
k | the wavevector module |
PkLin | linear power spectrum |
qmin | |
qmax | |
prec | the integral precision |
Definition at line 62 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::Gamma_3PCF | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
const std::vector< double > | xi, | ||
const std::vector< double > | dPhi | ||
) | const |
function to compute non-local contribution to three-point correlation function; specifically, it implements Eq. 20 of Bel el et al. 2015, MNRAS, 453, 259:
\[ \Gamma_{123} = \left[ \xi(r_1)+3\frac{\Phi^\prime(r_1)}{r1}\right] \left[ \xi(r_2)+3\frac{\Phi^\prime(r_2)}{r_2}\right]P_2(\cos\theta) \]
where the prime indicates the derivative with respect to \(r\), \(P_2\) is the second Legandre polynomial computed by cbl::legendre_polynomial, and \(\xi(r), \Phi(r)\) are the integrals of the power spectrum computed by cbl::cosmology::Cosmology::integrals_Q_nonLocal
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | the angle betwee r1 and r2 |
xi | vector containing the value of xi at r1, r2 |
dPhi | vector containing the value of the derivative of Phi at r1, r2 |
void cbl::cosmology::Cosmology::generate_bias_eff_grid_one_cosmopar | ( | std::vector< double > & | parameter, |
std::vector< double > & | bias_eff, | ||
const std::string | dir_output, | ||
const std::string | file_bias_eff_grid, | ||
const cbl::cosmology::CosmologicalParameter | cosmoPar, | ||
const double | min_par, | ||
const double | max_par, | ||
const int | nbin_par, | ||
const double | redshift, | ||
const double | Mass_min, | ||
const double | Mass_max, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const std::string | selection_function_file, | ||
const std::vector< int > | column = {} , |
||
const double | alpha = 1. , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta_crit = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
effective bias of dark matter haloes, computed by weighting on the selection function on a grid of one input cosmological parameter; this function is used when modelling the two-point correlation function
this function computes the effective bias of dark matter haloes:
\[ b_{eff}(z) = \frac{\int_{M_{min}}^{M_{max}} {\rm d}M\, b(M, z) \Phi(M, z) f(M, z)}{\int_{M_{min}}^{M_{max}} {\rm d}M\,\Phi(M, z) f(M, z)} \]
where the linear bias of the \(i\)-th halo, \(b^{i}(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo; the mass variance is computed by cbl::cosmology::Cosmology::sigma2M
parameter | vector containing the grid of the cosmological parameters on which the effective bias grid is computed |
bias_eff | vector containing the effective bias grid |
dir_output | the directory where the effective bias grid is stored |
file_bias_eff_grid | the file there the effective bias grid is stored |
cosmoPar | the cosmological parameter for which the effective bias grid is computed |
min_par | the minimum value for the parameter where the effective bias is computed |
max_par | the maximum value for the parameter where the effective bias is computed |
nbin_par | the number of points for the parameter where the effective bias is computed |
redshift | vector containing the redshifts; if it has size=1, it will be considered as the main redshift |
Mass_min | minimum cluster mass |
Mass_max | maximum cluster mass |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
alpha | the \(\alpha\) parameter of the cluster mass scaling relation |
selection_function_file | the input selection function file |
column | vector containing the columns with {mass, redshift, selection function} |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta_crit | \(\Delta_{crit}\): the critical overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
void cbl::cosmology::Cosmology::generate_bias_eff_grid_one_cosmopar | ( | std::vector< double > & | parameter, |
std::vector< double > & | bias_eff, | ||
const std::string | dir_output, | ||
const std::string | file_bias_eff_grid, | ||
const cbl::cosmology::CosmologicalParameter | cosmoPar, | ||
const double | min_par, | ||
const double | max_par, | ||
const int | nbin_par, | ||
const std::vector< double > | mass, | ||
const std::vector< double > | mass_grid, | ||
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const std::string | meanType = "mean_bias" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta_crit = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const cbl::cosmology::Cosmology | cosmology_mass = {} , |
||
const std::vector< double > | redshift_source = {} |
||
) |
compute the effective bias of dark matter haloes, by averaging the bias of a set of haloes, interpolating the mass variance on a grid of masses and of one input cosmological parameter; this function is used when modelling the two-point correlation function
this function computes the effective bias of dark matter haloes by either averaging the bias of a set of haloes with a given mass:
\[b_{eff}(z) = \frac{1}{N_{halo}}\sum_{i=1}^{N_{halo}} b(M_i, z_i) \; , \; (1)\]
or by averaging over halo pairs:
\[b_{eff}(z) = \sqrt{ \frac{2}{N_{halo}(N_{halo}-1)} \sum_{i=1}^{N_{halo}}\sum_{j=i+1}^{N_{halo}} b(M_i, z_i)b(M_j, z_j)} \; , \; (2)\]
where the linear bias of the \(i\)-th halo, \(b^{i}(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo; the mass variance is computed by cbl::cosmology::Cosmology::sigma2M
parameter | vector containing the grid of the cosmological parameters on which the effective bias grid is computed |
bias_eff | vector containing the effective bias grid |
dir_output | the directory where the effective bias grid is stored |
file_bias_eff_grid | the file there the effective bias grid is stored |
cosmoPar | the cosmological parameter for which the effective bias grid is computed |
min_par | the minimum value for the parameter where the effective bias is computed |
max_par | the maximum value for the parameter where the effective bias is computed |
nbin_par | the number of points for the parameter where the effective bias is computed |
mass | vector containing the halo masses |
mass_grid | vector containing the halo masses on the grid used to interpolate the mass variance |
redshift | vector containing the redshifts; if it has size=1, it will be considered as the main redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
meanType | meanType="mean_bias" \(\rightarrow\) the effective bias is computed with Eq.(1); meanType="mean_pair_bias" \(\rightarrow\) the effective bias is computed with Eq.(2) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta_crit | \(\Delta_{crit}\): the critical overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
cosmology_mass | cosmology used to measure the cluster masses |
redshift_source | vector containing the redshifts of the source galaxies, in case the cluster masses are estimated from weak lensing |
void cbl::cosmology::Cosmology::generate_bias_eff_grid_two_cosmopars | ( | std::vector< double > & | parameter1, |
std::vector< double > & | parameter2, | ||
std::vector< std::vector< double >> & | bias_eff, | ||
const std::string | dir_output, | ||
const std::string | file_bias_eff_grid, | ||
const cbl::cosmology::CosmologicalParameter | cosmoPar1, | ||
const double | min_par1, | ||
const double | max_par1, | ||
const int | nbin_par1, | ||
const cbl::cosmology::CosmologicalParameter | cosmoPar2, | ||
const double | min_par2, | ||
const double | max_par2, | ||
const int | nbin_par2, | ||
const std::vector< double > | mass, | ||
const std::vector< double > | mass_grid, | ||
const std::vector< double > | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const std::string | meanType = "mean_bias" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const cbl::cosmology::Cosmology | cosmology_mass = {} , |
||
const std::vector< double > | redshift_source = {} |
||
) |
effective bias of dark matter haloes, computed by averaging the bias of a set of haloes, interpolating the mass variance on a grid of masses and two input cosmological parameters; this function is used when modelling the two-point correlation function
this function computes the effective bias of dark matter haloes by either averaging the bias of a set of haloes with a given mass:
\[b_{eff}(z) = \frac{1}{N_{halo}}\sum_{i=1}^{N_{halo}} b(M_i, z_i) \; , \; (1)\]
or by averaging over halo pairs:
\[b_{eff}(z) = \sqrt{ \frac{2}{N_{halo}(N_{halo}-1)} \sum_{i=1}^{N_{halo}}\sum_{j=i+1}^{N_{halo}} b(M_i, z_i)b(M_j, z_j)} \; , \; (2)\]
where the linear bias of the \(i\)-th halo, \(b^{i}(M, z)\), is computed by cbl::cosmology::Cosmology::bias_halo; the mass variance is computed by cbl::cosmology::Cosmology::sigma2M
parameter1 | vector containing the grid of the first cosmological parameters on which the effective bias grid is computed |
parameter2 | vector containing the grid of the second cosmological parameters on which the effective bias grid is computed |
bias_eff | vector containing the effective bias grid |
dir_output | the directory where the effective bias grid is stored |
file_bias_eff_grid | the file there the effective bias grid is stored |
cosmoPar1 | the first cosmological parameter for which the effective bias grid is computed |
min_par1 | the minimum value for the first parameter where the effective bias is computed |
max_par1 | the maximum value for the first parameter where the effective bias is computed |
nbin_par1 | the number of points for the first parameter where the effective bias is computed |
cosmoPar2 | the second cosmological parameter for which the effective bias grid is computed |
min_par2 | the minimum value for the second parameter where the effective bias is computed |
max_par2 | the maximum value for the second parameter where the effective bias is computed |
nbin_par2 | the number of points for the second parameter where the effective bias is computed |
mass | vector containing the halo masses |
mass_grid | vector containing the halo masses on the grid used to interpolate the mass variance |
redshift | vector containing the redshifts; if it has size=1, it will be considered as the main redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
meanType | meanType="mean_bias" \(\rightarrow\) the effective bias is computed with Eq.(1); meanType="mean_pair_bias" \(\rightarrow\) the effective bias is computed with Eq.(2) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
cosmology_mass | cosmology used to measure the cluster masses |
redshift_source | vector containing the redshifts of the source galaxies, in case the cluster masses are estimated from weak lensing |
void cbl::cosmology::Cosmology::get_barred_xi | ( | std::vector< double > | rr, |
std::vector< double > | Xi, | ||
std::vector< double > & | Xi_, | ||
std::vector< double > & | Xi__, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | xiType = 0 , |
||
const double | k_star = -1. , |
||
const bool | xiNL = 0 , |
||
const int | norm = -1 , |
||
const double | r_min = 0.1 , |
||
const double | r_max = 150. , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 0. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) | const |
get the barred dark matter correlation functions
this function provides the dark matter barred correlation functions, used to model the two-point correlation function in redshift-space
[in] | rr | vector of r, the module of the comoving separation |
[in] | Xi | vector of ξ(r), the two-point correlation function of dark matter |
[out] | Xi_ | vector of barred ξ(r), |
[out] | Xi__ | vector of double-barred ξ(r) |
[in] | method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
[in] | redshift | redshift |
[in] | xiType | 0 \(\rightarrow\) standard; 1 \(\rightarrow\) Chuang & Wang model |
[in] | k_star | k* of the Chuang & Wang model |
[in] | xiNL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
[in] | norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
[in] | r_min | minimum separation up to which the correlation function is computed |
[in] | r_max | maximum separation up to which the correlation function is computed |
[in] | k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
[in] | aa | parameter a of Eq. 24 of Anderson et al. 2012 |
[in] | prec | accuracy of the integration |
[in] | file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
void cbl::cosmology::Cosmology::get_xi | ( | std::vector< double > & | rr, |
std::vector< double > & | Xi, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | xiType = 0 , |
||
const double | k_star = -1. , |
||
const bool | xiNL = 0 , |
||
const int | norm = -1 , |
||
const double | r_min = 0.1 , |
||
const double | r_max = 150. , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 0. , |
||
const bool | GSL = false , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
get the dark matter two-point correlation function
this function provides the dark matter correlation function, obtained by Fourier transforming the matter power spectrum
[out] | rr | vector of r, the module of the comoving separation |
[out] | Xi | vector of ξ(r), the two-point correlation function of dark matter |
[in] | method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
[in] | redshift | redshift |
[in] | store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | xiType | 0 \(\rightarrow\) standard; 1 \(\rightarrow\) Chuang & Wang model |
[in] | k_star | k* of the Chuang & Wang model |
[in] | xiNL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
[in] | norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
[in] | r_min | minimum separation up to which the correlation function is computed |
[in] | r_max | maximum separation up to which the correlation function is computed |
[in] | k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
[in] | aa | parameter a of Eq. 24 of Anderson et al. 2012 |
[in] | GSL | false \(\rightarrow\) FFTlog is used; true \(\rightarrow\) the GSL libraries are used |
[in] | prec | accuracy of the integration |
[in] | file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, const ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::gg | ( | const double | redshift = 0. | ) | const |
the linear growth factor at a given redshift, \(g(z)\)
this function computes the following quantity (e.g. Eq.(1) by Hamilton 2001):
\[ g(z) \equiv \tilde{D}(z)(1+z) \]
where \(a=1/(1+z)\) and \(D(z)\) is computed by cbl::cosmology::Cosmology::DD
redshift | the redshift |
Definition at line 720 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_H0
Definition at line 1184 of file Cosmology.h.
double cbl::cosmology::Cosmology::Hdot | ( | const double | redshift = 0. | ) | const |
derivative of the Hubble function at a given redshift
redshift | the redshift |
Definition at line 985 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_hh
Definition at line 1191 of file Cosmology.h.
double cbl::cosmology::Cosmology::HH | ( | const double | redshift = 0. | ) | const |
the Hubble function
redshift | the redshift |
Definition at line 570 of file Cosmology.cpp.
void cbl::cosmology::Cosmology::I_ELL_ell | ( | std::vector< std::vector< double >> & | II, |
const std::vector< double > | rr, | ||
const int | ll, | ||
const int | LL, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk | ||
) |
compute the quantity \( I_{\mathcal{L} l} (r_1, r_2)\)
This function computes the quantity \( I_{\mathcal{L} l} (r_1, r_2)\):
\[ I_{\mathcal{L} l} (r_1, r_2) = \sum_{l_1} (-1)^{l_1+l}(2l_1+1)(2l+1) \begin{pmatrix} l_1 & l & \mathcal{L} \\ 0 & 0 & 0 \end{pmatrix}^2 \\ \times \int \mathrm{d} r \;r\;f_{l, l_1}(r_1;r) f_{l, l_1} (r_2; r) \]
where \( f_{l, l_1} (r_i;r) \) is computed by cbl::cosmology::Cosmology::eff_l_l1 This quantity is used the compute the tree-level theoretical prediction for the biased and redshift space the three-point correlation function, following Slepian&Eisenstein, 2017
II | the quantity \( I_{\mathcal{L} l} (r_1, r_2) \) |
rr | vector of scales |
ll | the order \(l\) |
LL | the order \( \mathcal{L} \) |
kk | vector of wavevector modules |
Pk | dark matter power spectrum |
void cbl::cosmology::Cosmology::integrals_Q_nonLocal | ( | std::vector< double > & | xi_matter, |
std::vector< double > & | Phi, | ||
const std::vector< double > | rr, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter, | ||
const double | prec | ||
) | const |
integral functions for the three-point correlation model
this function computes and store functons used to model the three-point correlation model; specifically, it implements Eq. 21, in polar coordinates, of Bel et al. 2015, MNRAS, 453, 259):
\[ \xi_{DM}(r) = \frac{1}{2\pi^2}\int_0^\infty \mathrm{d} k\, k^2 P_{DM}(k) j_0(k r), \\\ \Phi(r) = \frac{1}{2\pi^2}\int_0^\infty \mathrm{d} k\, P_{DM}(k) W^2(kr) j_0(k r), \\ \]
where \(j_0(k r)=\sin(k r)/(kr)\) is the l=0 spherical Bessel function, and \(W(kr)\) is the top-hat window function computed by cbl::TopHat_WF
[out] | xi_matter | vector containing the dark matter two-point correlation function values |
[out] | Phi | vector containing the \( \Phi(r)\) values, estimated at the scales given in rr |
[in] | rr | vector or scales at which the dark matter two-point correlation function (xi_matter) will be computed |
[in] | kk | vector of the wave vector modules at which the power spectrum is computed |
[in] | Pk_matter | vector of containing the dark matter power spectrum values, estimated at the wave vector modules given in kk |
prec | the integral precision |
void cbl::cosmology::Cosmology::integrals_zeta_BarrigaGatzanaga | ( | std::vector< double > & | xi_matter, |
std::vector< double > & | Phi, | ||
const std::vector< double > | rr, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
integrals used to compute the Barriga & Gatzanaga al. 2002 three-point correlation function model
this function computes the integrals used to model the three-point correlation as described in Barriga & Gatzanaga 2002:
\[ \xi_{DM}(r) = \frac{1}{2\pi^2}\int_0^\infty \mathrm{d} k\, k^2 P_{DM}(k) j_0(k r), \]
\[ \Phi(r) = \frac{1}{2\pi^2}\int_0^\infty \mathrm{d} k\, P_{DM}(k) j_0(k r). \]
[out] | xi_matter | vector containing the dark matter two-point correlation function |
[out] | Phi | vector containing \( \Phi(r)\) |
[in] | rr | vector or scales |
[in] | kk | vector of the wave vector modules |
[in] | Pk_matter | the dark matter power spectrum |
void cbl::cosmology::Cosmology::integrals_zeta_Slepian | ( | std::vector< double > & | xi_matter, |
std::vector< double > & | xi_matter_m1, | ||
std::vector< double > & | xi_matter_p1, | ||
std::vector< double > & | xi_matter_2, | ||
const std::vector< double > | rr, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
integrals used to compute the Slepian et al. 2015 three-point correlation function model
this function computes the integrals used to model the three-point correlation as described in Slepian et. al 2015:
\[ \xi_{DM}(r) = \frac{1}{2\pi^2}\int_0^\infty \mathrm{d} k k^2 P_{DM}(k) j_0(k r), \\\ \xi^{[1\pm]}_{DM}(r) = \frac{1}{2\pi^2}\int_0^\infty \mathrm{d} k k^2 P_{DM}(k) k^{\pm 1} j_1(k r), \\ \xi^{[2]}_{DM}(r) = \frac{1}{2\pi^2}\int_0^\infty \mathrm{d} k k^2 P_{DM}(k) j_2(k r) . \]
[out] | xi_matter | vector containing the dark matter two-point correlation function |
[out] | xi_matter_m1 | vector containing \(\xi^{[1-]}_{DM}(r)\) |
[out] | xi_matter_p1 | vector containing \(\xi^{[1+]}_{DM}(r)\) |
[out] | xi_matter_2 | vector containing \(\xi^{[2]}_{DM}(r)\) |
[in] | rr | vector or scales |
[in] | kk | vector of the wave vector modules |
[in] | Pk_matter | the dark matter power spectrum |
void cbl::cosmology::Cosmology::k_ell | ( | std::vector< std::vector< double >> & | KK, |
const std::vector< double > | rr, | ||
const int | ll, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk | ||
) |
compute the quantity \( k_l (r_1, r_2) \)
This function computes the quantity \( k_l (r_1, r_2) \):
\[ k_l (r_1, r_2) = \frac{64}{77175} \left[9I_{1,l}(r_1, r_2)- 14I_{3,l}(r_1, r_2) +5I_{5,l}(r_1, r_2) \right] \]
where \( I_{\mathcal{L}l} \) is computed by cbl::cosmology::Cosmology::I_ELL_ell This quantity is used the compute the tree-level theoretical prediction for the biased and redshift space three-point correlation function, following Slepian&Eisenstein, 2017
KK | the quantity \( k_l (r_1, r_2) \) |
rr | vector of scales |
ll | the order \(l\) |
kk | vector of wavevector modules |
Pk | dark matter power spectrum |
double cbl::cosmology::Cosmology::k_star | ( | const std::string | method_Pk, |
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_max = 100. , |
||
const std::string | file_par = par::defaultString |
||
) | const |
the k* parameter
this function provides the k* parameter used to model the BAO (see e.g. Chuang & Wang 2012, Crocce et al. 2006, Matsubara 2008)
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_max | maximum wave vector module up to which the power spectrum is computed |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::linear_growth_rate | ( | const double | redshift, |
const double | prec = 1.e-4 |
||
) | const |
the linear growth rate at a given redshift, \(f(z)\)
this function computes the following function:
\[ f(z) = \frac{{\rm d}\,\ln D}{{\rm d}\,\ln a} \]
redshift | the redshift |
prec | precision used for the resolution of the differential equation in the case wa different than 0 |
Definition at line 662 of file Cosmology.cpp.
vector< double > cbl::cosmology::Cosmology::linear_point | ( | const double | redshift, |
const double | rmin = 60. , |
||
const double | rmax = 150. , |
||
const int | nbinr = 100 , |
||
const std::string | interpType = "Spline" |
||
) |
the linear point
see Anselmi et al. 2016
redshift | the redshift |
rmin | the minimum scale |
rmax | the maximum scale |
nbinr | the number of scale bins |
interpType | the interpolation type |
double cbl::cosmology::Cosmology::lookback_time | ( | const double | redshift = 0. | ) | const |
lookback time at a given redshift
redshift | the redshift |
Definition at line 932 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Lum_bol | ( | const double | redshift = 0. , |
const double | flux = 1. |
||
) | const |
bolometric luminosity
redshift | the redshift |
flux | flux |
Definition at line 1036 of file Cosmology.cpp.
|
private |
the inverse cosine amplitude of the Jacobian elliptic function
this method computes the inverse cosine amplitude of the Jacobian elliptic function cn-1(c|m), with shape parameter fixed to m=(2+30.5)/4; namely cn-1(s|m) = F(arccos(c)|m); it is used to compute the relation between comoving distance and redshift (see Numer. Math. (2010) 116:687–719, T. Fukushima "Fast computation of incomplete elliptic integral of first kind by half argument transformation")
cc | scalar, argument |
Definition at line 1409 of file Cosmology.cpp.
|
private |
the inverse sine amplitude of the Jacobian elliptic function
this method computes the inverse sine amplitude of the Jacobian elliptic function sn-1(s|m), with shape parameter fixed to m=(2+30.5)/4, namely sn-1(s|m) = F(arcsin(s)|m); it is used to compute the relation between comoving distance and redshift (see Numer. Math. (2010) 116:687–719, T. Fukushima "Fast computation of incomplete elliptic integral of first kind by half argument transformation")
ss | scalar, argument |
Definition at line 1428 of file Cosmology.cpp.
|
private |
auxiliary function to compute the halo bias
Sigma | σ(mass, z=0): the mass variance at z=0 |
redshift | the redshift |
D_N | the amplitude of the growing mode |
author | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
Delta | \(\Delta\), the overdensity |
|
private |
auxiliary function to compute the halo bias
Sigma | σ(mass, z=0): the mass variance at z=0 |
redshift | the redshift |
author | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
Delta | \(\Delta\), the overdensity |
|
private |
the incomplete elliptic integral
this method computes the incomplete elliptic integral of the first kind F(φ|m), with shape parameter fixed to m=(2+30.5)/4; it is used to compute the relation between comoving distance and redshift (see Numer. Math. (2010) 116:687–719, T. Fukushima "Fast computation of incomplete elliptic integral of first kind by half argument transformation")
phi | φ scalar, argument |
Definition at line 1375 of file Cosmology.cpp.
|
private |
function to compute the not-yet-normalised mass variances and their derivatives
this function computes the not-yet-normalised mass variances and their derivatives:
\[ \sigma^2(R) = \frac{1}{2\pi^2}\int_0^\infty {\rm d}k\, k^2 P_{lin}(k, z) F^2(k, R)\]
where \(F(x)\) is a generic filter
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
filter | the filter |
unit1 | true \(\rightarrow\) force cosmological units |
|
private |
auxiliary function to compute the mass function of dark matter haloes (filaments and sheets)
Mass | mass |
mass_function_params | function to a container of the mass function parameters |
Definition at line 105 of file MassFunction.cpp.
|
private |
auxiliary function to compute the mass function
Mass | mass |
Sigma | σ(mass): the mass variance |
Dln_Sigma | dlnσ/dM: the derivative of the mass variance |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
D_N | the growth factor, precomputed. |
Delta | \(\Delta\), the overdensity |
default_delta | true = using function cbl::cosmology::deltac; false = using delta_t*growth factor |
delta_t | user defined density contrast at \(z = 0\) |
Definition at line 211 of file MassFunction.cpp.
|
private |
auxiliary function to compute the mass function
Mass | mass |
Sigma | σ(mass): the mass variance |
Dln_Sigma | dlnσ/dM: the derivative of the mass variance |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
Delta | \(\Delta\), the overdensity |
default_delta | true = using function cbl::cosmology::deltac; false = using delta_t*growth factor |
delta_t | user defined density contrast at \(z = 0\) |
Definition at line 200 of file MassFunction.cpp.
|
private |
the inverse truncated series necessary to compute sn-1(s|m) in ASN_DZ
this method computes the inverse truncated series necessary to compute sn-1(s|m) in ASN_DZ; the shape parameter is fixed to m=(2+30.5)/4; it is used to compute the relation between comoving distance and redshift (see Numer. Math. (2010) 116:687–719, T. Fukushima "Fast computation of incomplete elliptic integral of first kind by half argument transformation"; the output of the function corresponds to the second factor of eq. (23))
yy | scalar, argument |
Definition at line 1452 of file Cosmology.cpp.
|
private |
the not-yet-normalised mass variance, \(\sigma^2(M)\)
this function computes the not-yet-normalised variance of the linear density field:
\[ \sigma^2(M) = \frac{1}{2\pi^2}\int_0^\infty {\rm d}k\, k^2 P_{lin}(k, z) W^2(k, R)\]
where \(W(x)=(3/x)^3(\sin x-x\cos x)\) and \(R=(3M/4\pi\rho_m)^{1/3}\)
mass | the mass |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
unit1 | true \(\rightarrow\) force cosmological units |
|
private |
the not-yet-normalised mass variance, \(\sigma^2(R)\)
this function computes the not-yet-normalised variance of the linear density field:
\[ \sigma^2(R) = \frac{1}{2\pi^2}\int_0^\infty {\rm d}k\, k^2 P_{lin}(k, z) W^2(k, R)\]
where \(W(x)=(3/x)^3(\sin x-x\cos x)\) and \(R=(3M/4\pi\rho_m)^{1/3}\)
radius | the radius, \(R\) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
unit1 | true \(\rightarrow\) force cosmological units |
|
private |
write and read the table where the dark matter power spectrum, computed with either CAMB or MPTbreeze, is stored
[in] | code | method used to compute the power spectrum; valid codes are: CAMB [http://camb.info/] or MPTbreeze-v1 [http://arxiv.org/abs/1207.1465] |
[in] | NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
[out] | lgkk | vector of log(k) |
[out] | lgPk | vector of log(P(k)) |
[in] | redshift | redshift |
[in] | store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
|
private |
write and read the table where the dark matter power spectrum, computed with either CAMB or MPTbreeze, is stored
[in] | code | method used to compute the power spectrum; valid codes are: CAMB [http://camb.info/] or MPTbreeze-v1 [http://arxiv.org/abs/1207.1465] |
[in] | NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
[out] | lgkk | vector of vectors containing the log(k) at each redshift |
[out] | lgPk | vector of vectors containing the log(P(k)) at each redshift |
[in] | redshift | vector of redshifts |
[in] | store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
|
private |
write and read the table where the dark matter power spectrum computed with CLASS is stored
[in] | NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
[out] | lgkk | vector of log(k) |
[out] | lgPk | vector of log(P(k)) |
[in] | redshift | redshift |
[in] | store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
|
private |
write and read the table where the dark matter power spectrum computed with CLASS is stored
[in] | NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
[out] | lgkk | vector of vectors containing the log(k) at each redshift |
[out] | lgPk | vector of vectors containing the log(P(k)) at each redshift |
[in] | redshift | vector of redshifts |
[in] | store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
|
private |
write and read the table where the dark matter power spectrum is stored; it is used when a parameter file is provided in input
[in] | code | method used to compute the power spectrum; valid codes are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465] |
[in] | file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
[in] | NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
[out] | lgkk | vector of log(k) |
[out] | lgPk | vector of log(P(k)) |
[in] | redshift | redshift |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
double cbl::cosmology::Cosmology::M_vir | ( | const double | r_vir, |
const double | redshift, | ||
const std::string | author = "BryanNorman" , |
||
const bool | unit1 = false |
||
) | const |
the virial mass, given the virial radius and the redshift
this function computes the virial halo mass as follows:
\[M_{vir}(z) = \frac{4}{3}\pi r_{vir}^3\Delta_c(z)\rho_{crit}(z) = \frac{r_{vir}^3\Delta_c(z)H^2(z)}{2G}\]
where \(\Delta_c(z)\) is computed by cbl::cosmology::Cosmology::Delta_c and \(\rho_{crit}(z)\) is computed by cbl::cosmology::Cosmology::rho_crit
r_vir | the virial radius |
redshift | the redshift |
author | the author of the \(\Delta_c(z)\) equation (see cbl::cosmology::Cosmology::Delta_c) |
unit1 | true \(\rightarrow\) force cosmological units |
Definition at line 1322 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Mag_Volume_limited | ( | const double | z_max = 1. , |
const double | mag_lim = -20. |
||
) | const |
maximum absolute magnitude to have a volume-limited catalogue
z_max | maximum redshift |
mag_lim | magnitude limit |
Definition at line 1027 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::mass_function | ( | const double | Mass, |
const double | redshift, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const bool | default_delta = true , |
||
const double | delta_t = 1.686 |
||
) |
the mass function of dark matter haloes (filaments and sheets)
Mass | mass |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
default_delta | true = using function cbl::cosmology::deltac; false = using delta_t*growth factor |
delta_t | user defined density contrast at \(z = 0\) |
Definition at line 45 of file MassFunction.cpp.
double cbl::cosmology::Cosmology::mass_function | ( | const double | Mass, |
const double | Sigma, | ||
const double | Dln_Sigma, | ||
const double | redshift, | ||
const double | D_N, | ||
const std::string | model_MF, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | method_SS = "CAMB" , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the mass function of dark matter haloes (filaments and sheets) computed quickly passing directly the mass variance and its derivative as inputs
Mass | mass |
Sigma | σ(mass): the mass variance |
Dln_Sigma | dlnσ/dM: the derivative of the mass variance |
redshift | the redshift |
D_N | the amplitude of the growing mode |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; this parameter is used only if norm=1 |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 184 of file MassFunction.cpp.
double cbl::cosmology::Cosmology::mass_function | ( | const double | Mass, |
const double | Sigma, | ||
const double | Dln_Sigma, | ||
const double | redshift, | ||
const std::string | model_MF, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | method_SS = "CAMB" , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the mass function of dark matter haloes (filaments and sheets) computed quickly passing directly the mass variance and its derivative as inputs
Mass | mass |
Sigma | σ(mass): the mass variance |
Dln_Sigma | dlnσ/dM: the derivative of the mass variance |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; this parameter is used only if norm=1 |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 168 of file MassFunction.cpp.
std::vector< double > cbl::cosmology::Cosmology::mass_function | ( | const std::vector< double > | mass, |
const double | z_min, | ||
const double | z_max, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const bool | isDelta_critical = false , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
mass function for a range of masses
mass | vector of mass |
z_min | minimum redshift |
z_max | maximum redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
isDelta_critical | \(\rightarrow\) \(\Delta\) is the overdensity defined with respect to the critical density |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 655 of file MassFunction.cpp.
vector< double > cbl::cosmology::Cosmology::mass_function | ( | const std::vector< double > | Mass, |
const std::vector< double > | Sigma, | ||
const std::vector< double > | Dln_Sigma, | ||
const double | redshift, | ||
const std::string | model_MF, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | method_SS = "CAMB" , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the mass function of dark matter haloes (filaments and sheets) computed quickly passing directly the mass variance and its derivative as inputs. This function takes vector in input and compute the mass function for the input masses
Mass | mass |
Sigma | σ(mass): the mass variance |
Dln_Sigma | dlnσ/dM: the derivative of the mass variance |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; this parameter is used only if norm=1 |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 45 of file MassFunction_vector.cpp.
double cbl::cosmology::Cosmology::mass_function_fast | ( | const double | Mass, |
const double | redshift, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the mass function of dark matter haloes (filaments and sheets) computed quickly using a grid
Mass | mass |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. . If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 130 of file MassFunction.cpp.
double cbl::cosmology::Cosmology::mass_function_fR | ( | const double | Mass, |
const double | redshift, | ||
const std::string | model_MF, | ||
const double | f_R0 = 0. , |
||
const bool | store_output = true , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const bool | default_delta = true , |
||
const double | delta_t = 1.686 |
||
) |
the mass function of dark matter haloes in f(R) cosmologies (see Hu & Sawicki 2007) computed with the Boltzmann solver MGCAMB
Mass | the mass |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
f_R0 | value of the parameter \(f_\mathrm{R0}\) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
default_delta | true = using function cbl::cosmology::deltac; false = using delta_t*growth factor |
delta_t | user defined density contrast at \(z = 0\) |
Definition at line 67 of file MassFunction.cpp.
std::vector< double > cbl::cosmology::Cosmology::mass_function_selection_function_vector | ( | const std::vector< double > | mass, |
const double | z_min, | ||
const double | z_max, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const std::string | selection_function_file, | ||
const std::vector< int > | column = {} , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const bool | isDelta_critical = false , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
mass function given a selection function
mass | vector of mass |
z_min | minimum redshift |
z_max | maximum redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
selection_function_file | input file where the selection function is stored |
column | the columns to be read |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
isDelta_critical | \(\rightarrow\) \(\Delta\) is the overdensity defined with respect to the critical density |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
wrapper::gsl::GSL_integrate_qag(funcD, z_min, z_max);
Definition at line 703 of file MassFunction.cpp.
|
inline |
get the private member Cosmology::m_massive_neutrinos
Definition at line 1149 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_massless_neutrinos
Definition at line 1142 of file Cosmology.h.
double cbl::cosmology::Cosmology::max_redshift | ( | const double | Volume, |
const double | Area, | ||
const double | z_min | ||
) | const |
maximum redshift for a given volume, sky area and minimum redshift
Volume | volume |
Area | sky area |
z_min | minimum redshift |
Definition at line 1223 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::mean_redshift_haloes_selection_function | ( | const double | z_min, |
const double | z_max, | ||
const double | Mass_min, | ||
const double | Mass_max, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const std::string | selection_function_file, | ||
const std::vector< int > | column = {} , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const bool | isDelta_critical = false , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the mean redshift of a dark matter haloe sample, given a selection function
z_min | minimum redshift |
z_max | maximum redshift |
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
selection_function_file | input file where the selection function is stored |
column | the columns to be read |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
isDelta_critical | \(\rightarrow\) \(\Delta\) is the overdensity defined with respect to the critical density |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 890 of file MassFunction.cpp.
void cbl::cosmology::Cosmology::medianwf | ( | const double | ff, |
const std::string | model_model, | ||
std::vector< double > & | wf | ||
) | const |
median formation w
[in] | ff | assembled fraction |
[in] | model_model | valid authors are: NS (Nusser and Sheth), GTS (Giocoli et al. 2012) |
[out] | wf | vector of w(f) |
Definition at line 118 of file MassGrowth.cpp.
void cbl::cosmology::Cosmology::medianzf | ( | const double | ff, |
const double | mass, | ||
const double | z0, | ||
const std::string | model_model, | ||
const std::string | method_SS, | ||
std::vector< double > & | zf, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" |
||
) | const |
median formation z
[in] | ff | assembled fraction |
[in] | mass | halo mass |
[in] | z0 | redshift when the halo has a mass mass |
[in] | model_model | valid authors are: NS (Nusser and Sheth), GTS (Giocoli et al. 2012) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] | |
[out] | zf | vector of z(f) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed | |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Definition at line 192 of file MassGrowth.cpp.
double cbl::cosmology::Cosmology::MF_correction | ( | const double | mass, |
const double | redshift, | ||
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
correction to the halo mass in non-Gaussian cosmologies
mass | the halo mass |
redshift | the redshift |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::MhaloMin | ( | const int | n_halo, |
const double | Area, | ||
const bool | angle_rad, | ||
const double | z_min, | ||
const double | z_max, | ||
const double | Mmax, | ||
const double | lgM1_guess, | ||
const double | lgM2_guess, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
minimum halo mass, given the number of haloes in a given region of sky
n_halo | number density of dark matter haloes |
Area | sky area |
angle_rad | 0 \(\rightarrow\) Ω in square degrees; 1 \(\rightarrow\) Ω in steradians |
z_min | minimum redshift |
z_max | maximum redshift |
Mmax | maximum mass |
lgM1_guess | logarithm of the minimum mass used by the root finder |
lgM2_guess | logarithm of the maximum mass used by the root finder |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 564 of file MassFunction.cpp.
|
inline |
get the private member Cosmology::m_model
Definition at line 1328 of file Cosmology.h.
double cbl::cosmology::Cosmology::mrk | ( | const double | kk, |
const double | mass, | ||
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
auxiliary function to estimate cosmological quantities in non-Gaussian cosmologies
kk | wave vector module |
mass | halo mass |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::n_haloes | ( | const double | Mass_min, |
const double | Mass_max, | ||
const double | Volume, | ||
const double | redshift, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const int | nbin_mass = 0 , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const bool | default_delta = true , |
||
const double | delta_t = 1.686 |
||
) |
number of dark matter haloes per volume at fixed redshift
this function computes the number of dark matter haloes per volume at fixed redshift as follows:
\[ N_h = \int_{M_{min}}^{M_{max}} d M \Phi(M)\]
Mass_min | minimum mass |
Mass_max | maximum mass |
Volume | the volume |
redshift | the redshift |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
nbin_mass | number of bin for the mass function computation |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; this parameter is used only if norm=1 |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
default_delta | true = using function cbl::cosmology::deltac; false = using delta_t*growth factor |
delta_t | user defined density contrast at \(z = 0\) |
Definition at line 514 of file MassFunction.cpp.
double cbl::cosmology::Cosmology::n_haloes | ( | const double | Mass_min, |
const double | Mass_max, | ||
const double | z_min, | ||
const double | z_max, | ||
const bool | angle_rad, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
number of dark matter haloes per steradian or square degree, for a given redshift range
Mass_min | minimum mass |
Mass_max | maximum mass |
z_min | minimum redshift |
z_max | maximum redshift |
angle_rad | 0 \(\rightarrow\) Ω in square degrees; 1 \(\rightarrow\) Ω in steradians |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 469 of file MassFunction.cpp.
double cbl::cosmology::Cosmology::n_haloes_selection_function | ( | const double | Mass_min, |
const double | Mass_max, | ||
const double | z_min, | ||
const double | z_max, | ||
const bool | angle_rad, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const std::string | selection_function_file, | ||
const std::vector< int > | column = {} , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const bool | isDelta_critical = false , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
number of dark matter haloes per steradian or square degree, for a given redshift range and with selection function defined on a grid
Mass_min | minimum mass |
Mass_max | maximum mass |
z_min | minimum redshift |
z_max | maximum redshift |
angle_rad | 0 \(\rightarrow\) Ω in square degrees; 1 \(\rightarrow\) Ω in steradians |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
selection_function_file | input file where the selection function is stored |
column | the columns to be read |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
isDelta_critical | \(\rightarrow\) \(\Delta\) is the overdensity defined with respect to the critical density |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 592 of file MassFunction.cpp.
|
inline |
get the private member Cosmology::m_n_spec
Definition at line 1234 of file Cosmology.h.
double cbl::cosmology::Cosmology::neutrino_mass | ( | ) | const |
the total neutrino mass
this function computes the neutrino mass as follows:
\[\sum m_\nu = \Omega_\nu\cdot94\, h^2 eV\]
Definition at line 652 of file Cosmology.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Nvoids | ( | const double | min_r, |
const double | max_r, | ||
const int | num_bins, | ||
const double | mean_z, | ||
const double | Volume, | ||
const std::string | model, | ||
const double | b_eff, | ||
double | slope = 0.854 , |
||
double | offset = 0.420 , |
||
const double | deltav_NL = -0.795 , |
||
const double | del_c = 1.69 , |
||
const std::string | method_Pk = "EisensteinHu" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
number of voids computed from the void size function model for bins of radii spaced in log scale and for a specified survey/simulation volume
min_r | the minimum void radius |
max_r | the maximum void radius |
num_bins | number of bins of void radius |
mean_z | the mean redshift of the sample |
Volume | the volume of the survey/simulation in units of \((Mpc/h)^3\) |
model | size function model name; valid choices for model name are SvdW (Sheth and van de Weygaert, 2004), linear and Vdn (Jennings et al., 2013) |
b_eff | the effective bias of the sample |
slope | first coefficent to convert the effective bias (default value set to \(0.854\)) |
offset | second coefficent to convert the effective bias (default value set to \(0.420\)) |
deltav_NL | the non linear density contrast: \(\rho_v/\rho_m\) (default value set to \(-0.795\)) |
del_c | critical value of the linear density field (default value set to \(1.06\)) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 194 of file SizeFunction.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Nvoids | ( | const double | min_r, |
const double | max_r, | ||
const int | num_bins, | ||
const double | min_z, | ||
const double | max_z, | ||
const double | mean_z, | ||
const double | Area, | ||
const std::string | model, | ||
const double | b_eff, | ||
double | slope = 0.854 , |
||
double | offset = 0.420 , |
||
const double | deltav_NL = -0.795 , |
||
const double | del_c = 1.69 , |
||
const std::string | method_Pk = "EisensteinHu" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
number of voids computed from the void size function model for bins of radii spaced in log scale. The considered volume is computed from a (fraction of) a sphere shell, included in between two different redshifts
min_r | the minimum void radius |
max_r | the maximum void radius |
num_bins | number of bins of void radius |
min_z | the minimum redshift of the shell |
max_z | the maximum redshift of the shell |
mean_z | the mean redshift of the sample |
Area | sky area in units of squares degrees |
model | size function model name; valid choices for model name are SvdW (Sheth and van de Weygaert, 2004), linear and Vdn (Jennings et al., 2013) |
b_eff | the effective bias of the sample |
slope | first coefficent to convert the effective bias (default value set to \(0.854\)) |
offset | second coefficent to convert the effective bias (default value set to \(0.420\)) |
deltav_NL | the non linear density contrast: \(\rho_v/\rho_m\) (default value set to \(-0.795\)) |
del_c | critical value of the linear density field (default value set to \(1.06\)) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 249 of file SizeFunction.cpp.
double cbl::cosmology::Cosmology::Omega | ( | const double | redshift = 0. | ) | const |
the cosmic density at a given redshift
redshift | the redshift |
Definition at line 633 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_Omega_baryon
Definition at line 1126 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Omega_CDM
Definition at line 1177 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Omega_DE
Definition at line 1156 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Omega_k
Definition at line 1170 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Omega_matter
Definition at line 1119 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Omega_neutrinos
Definition at line 1134 of file Cosmology.h.
double cbl::cosmology::Cosmology::Omega_neutrinos | ( | const double | Mnu | ) | const |
the density of massive neutrinos, given the neutrino mass
this function computes the density of massive neutrinos as follows:
\[\Omega_\nu = \frac{\sum m_\nu}{93.8h^2 eV}\]
Mnu | \(\sum m_\nu\) in eV |
Definition at line 642 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_Omega_radiation
Definition at line 1163 of file Cosmology.h.
double cbl::cosmology::Cosmology::OmegaDE | ( | const double | redshift = 0. | ) | const |
the dark energy density at a given redshift
redshift | the redshift |
Definition at line 588 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::OmegaK | ( | const double | redshift = 0. | ) | const |
the density of curvature energy at a given redshift
redshift | the redshift |
Definition at line 615 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::OmegaM | ( | const double | redshift = 0. | ) | const |
the matter density at a given redshift
redshift | the redshift |
Definition at line 579 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::OmegaNu | ( | const double | redshift = 0. | ) | const |
the neutrino density at a given redshift
redshift | the redshift |
Definition at line 624 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::OmegaR | ( | const double | redshift = 0. | ) | const |
the radiation density at a given redshift
redshift | the redshift |
Definition at line 597 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::OmegaR_zeq | ( | const double | z_eq = 3395. | ) | const |
the radiation density, as a function of the redshift of radiation-matter equality
z_eq | the redshift of radiation-matter equality |
Definition at line 606 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_Pk0_CAMB
Definition at line 1306 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Pk0_CLASS
Definition at line 1321 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Pk0_EH
Definition at line 1298 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_Pk0_MPTbreeze
Definition at line 1314 of file Cosmology.h.
void cbl::cosmology::Cosmology::Pk_0 | ( | const std::string | method_Pk, |
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
normalisation of the power spectrum
this function sets the value of the private member m_Pk0_*, i.e. the normalisation of the power spectrum
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CAMB_wrapper (running CAMB wrapper), CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_min | minimum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; |
k_max | maximum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::Pk_1loop | ( | const double | kk, |
const std::shared_ptr< cbl::glob::FuncGrid > | PkLin, | ||
const int | corrtype, | ||
const double | qmin, | ||
const double | qmax, | ||
const double | prec = 1.e-3 |
||
) |
the one-loop power spectrum
this function computes the one-loop power spectrum corrections (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ P^{1loop}(k; f_1, f_2) = 4\pi\int_{q_{min}}^{q_{max}} \mathrm{d} q\, q^2P(q) \int_{-1}^{1} \mathrm{d} x\, f_1(kq, q, akq) \, f_2(kq, q, akq) \, P(kq) \]
where
\[ kq = \sqrt{k^2+q^2-2kqx} \]
\[ akq = \frac{kx-q}{kq} \]
and \(f_1\), \(f_2\) can be compute by either cbl::cosmology::Cosmology::F2 or cbl::cosmology::Cosmology::G2
kk | the wavevector module |
PkLin | linear power spectrum |
corrtype | 0 \(\rightarrow\) \(f_1=f_2=F_2\); 1 \(\rightarrow\) \(f_1=F_2\), \(f_2=G_2\); 2 \(\rightarrow\) \(f_1=f_2=G_2\) |
qmin | minimum q value in the integration |
qmax | maximum q value in the integration |
prec | the integral precision |
Definition at line 95 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::Pk_DeltaDelta | ( | const double | kk, |
const std::shared_ptr< cbl::glob::FuncGrid > | Pk, | ||
const double | qmin, | ||
const double | qmax, | ||
const double | prec = 1.e-3 |
||
) |
the real-space matter non-linear power spectrum \(P_{\delta\delta}(k)\), computed at 1-loop
this function computes the real-space non-linear matter power spectrum \(P_{\delta\delta}(k)\) at 1-loop, following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ P_{\delta\delta}(k) = \left(2\pi\right)^3\left(\exp(f(k)\right)^2 (P^{lin}(k)+P^{1loop}(k; F_2, F_2)) \]
where \(P^{lin}(k)\) is the linear power spectrum, \(f(k)\) is the second-order correction of the non-linear propagator computed by cbl::cosmology::Cosmology::f_k, and \(P^{1loop}\) is the one-loop power spectrum correction, computed by cbl::cosmology::Cosmology::Pk_1loop
kk | the wavevector module |
Pk | pointer to a FuncGrid object to interpolate the linear power spectrum |
qmin | the lower integration limit |
qmax | the upper integration limit |
prec | the integral precision |
Definition at line 133 of file PkXiNonLinear.cpp.
std::vector< double > cbl::cosmology::Cosmology::Pk_DeltaDelta | ( | const std::vector< double > | kk, |
const double | redshift, | ||
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString , |
||
const bool | unit1 = false |
||
) |
the real-space matter non-linear power spectrum \(P_{\delta\delta}(k)\), computed at 1-loop
this function computes the real-space non-linear matter power spectrum \(P_{\delta\delta}(k)\) at 1-loop, following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ P_{\delta\delta}(k) = \left(2\pi\right)^3\left(\exp(f(k)\right)^2 (P^{lin}(k)+P^{1loop}(k; F_2, F_2)) \]
where \(P^{lin}(k)\) is the linear power spectrum, \(f(k)\) is the second-order correction of the non-linear propagator computed by cbl::cosmology::Cosmology::f_k, and \(P^{1loop}\) is the one-loop power spectrum correction, computed by cbl::cosmology::Cosmology::Pk_1loop
kk | the wavevector module |
redshift | the redshift |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
Definition at line 162 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::Pk_DeltaDelta_fitting_function | ( | const double | kk, |
const std::string | method_Pk, | ||
const double | redshift, | ||
const std::string | author, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const int | norm, | ||
double | k_min, | ||
double | k_max, | ||
const double | prec, | ||
const std::string | file_par, | ||
const bool | unit1 | ||
) |
the non-linear dark matter power spectrum using fitting functions given by Bel et. al (2019)
the non-linear dark matter power spectrum, Pδδ, is computed using the fitting functions given by Bel et. al (2019) [https://arxiv.org/abs/1809.09338].
kk | the wave vector module |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
author | author(s) who proposed the fitting functions; valid authors are: Pezzotta (Pezzotta, et.al, 2017), Bel (Bel et.al., 2019) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
double cbl::cosmology::Cosmology::Pk_DeltaTheta | ( | const double | kk, |
const std::shared_ptr< cbl::glob::FuncGrid > | Pk, | ||
const double | qmin, | ||
const double | qmax, | ||
const double | prec = 1.e-3 |
||
) |
the real-space matter non-linear power spectrum \(P_{\delta\theta}(k)\), computed at 1-loop
this function computes the real-space non-linear matter power spectrum \(P_{\delta\delta}(k)\) at 1-loop, following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ P_{\delta\theta}(k) = \left(2\pi\right)^3\left(\exp(f(k)\right)^2 (P^{lin}(k)+P^{1loop}(k; F_2, G_2)) \]
where \(P^{lin}(k)\) is the linear power spectrum, \(f(k)\) is the second-order correction of the non-linear propagator computed by cbl::cosmology::Cosmology::f_k, and \(P^{1loop}\) is the one-loop power spectrum correction, computed by cbl::cosmology::Cosmology::Pk_1loop
kk | the wavevector module |
Pk | pointer to a FuncGrid object to interpolate the linear power spectrum |
qmin | the lower integration limit |
qmax | the upper integration limit |
prec | the integral precision |
Definition at line 143 of file PkXiNonLinear.cpp.
std::vector< double > cbl::cosmology::Cosmology::Pk_DeltaTheta | ( | const std::vector< double > | kk, |
const double | redshift, | ||
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString , |
||
const bool | unit1 = false |
||
) |
the real-space matter non-linear power spectrum \(P_{\delta\theta}(k)\), computed at 1-loop
this function computes the real-space non-linear matter power spectrum \(P_{\delta\delta}(k)\) at 1-loop, following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ P_{\delta\theta}(k) = \left(2\pi\right)^3\left(\exp(f(k)\right)^2 (P^{lin}(k)+P^{1loop}(k; F_2, G_2)) \]
where \(P^{lin}(k)\) is the linear power spectrum, \(f(k)\) is the second-order correction of the non-linear propagator computed by cbl::cosmology::Cosmology::f_k, and \(P^{1loop}\) is the one-loop power spectrum correction, computed by cbl::cosmology::Cosmology::Pk_1loop
kk | the wavevector module |
redshift | the redshift |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
Definition at line 183 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::Pk_DeltaTheta_fitting_function | ( | const double | kk, |
const std::string | method_Pk, | ||
const double | redshift, | ||
const std::string | author, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const bool | NL, | ||
const int | norm, | ||
double | k_min, | ||
double | k_max, | ||
const double | prec, | ||
const std::string | file_par, | ||
const bool | unit1 | ||
) |
the dark matter cross power spectrum
the dark matter cross power spectrum, Pδθ, is computed using the fitting functions given by Bel et. al (2019) [https://arxiv.org/abs/1809.09338].
\[ P_{\delta\theta} (k) = \left(P_{\delta\delta}(k)P_{\theta\theta}^{Lin}(k)\right)^{1/2}e^{-k/k_\delta-bk^6} \]
with \(b = 0.091 + 0.702*\sigma8^2\)
kk | the wave vector module |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
author | author(s) who proposed the fitting functions; valid authors are: Pezzotta (Pezzotta, et.al, 2017), Bel (Bel et.al., 2019) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Pk_eTNS_terms_1loop | ( | std::vector< double > | kk, |
const std::string | method, | ||
const double | redshift, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const int | norm, | ||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 |
||
) |
The expanded correction terms for the extended TNS model (eTNS)
the expanded correction terms for the eTNS model are computed at 1-loop using the Standard Perturbation Theory implemented in the CAMB-integrated version by Shun Saito. [http://www2.yukawa.kyoto-u.ac.jp/~atsushi.taruya/cpt_pack.html]. Details can be found in Saito et al. (2014) and Beutler et al. (2014) [https://arxiv.org/abs/1405.1447 and https://arxiv.org/abs/1312.4611v2].
\[ P(k, \mu) = D_{FoG}(k', \mu', f, \sigma_v)\left[P_{\mathrm{g}, \delta \delta}(k) +2 f \mu^{2} P_{\mathrm{g}, \delta \theta}(k)+f^{2} \mu^{4} P_{\theta \theta}(k) + b_{1}^{3} A(k, \mu, \beta)+b_{1}^{4} B(k, \mu, \beta)\right] \]
where
\[ P_{\mathrm{g}, \delta \delta}(k) = b_{1}^{2} P_{\delta \delta}(k)+2 b_{2} b_{1} P_{b 2, \delta}(k)+2 b_{s 2} b_{1} P_{b s 2, \delta}(k) \\ +2 b_{3 \mathrm{nl}} b_{1} \sigma_{3}^{2}(k) P_{\mathrm{m}}^{\mathrm{lin}}(k)+b_{2}^{2} P_{b 22}(k) \\ +2 b_{2} b_{s 2} P_{b 2 s 2}(k)+b_{s 2}^{2} P_{b s 22}(k)+N \]
\[ P_{\mathrm{g}, \delta \theta}(k) = b_{1} P_{\delta \theta}(k)+b_{2} P_{b 2, \theta}(k)+b_{s 2} P_{b s 2, \theta}(k) \\ +b_{3 \mathrm{nl}} \sigma_{3}^{2}(k) P_{\mathrm{m}}^{\mathrm{lin}}(k) \]
kk | the wave vector module |
method | method used to compute the linear power spectrum; valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by CAMB are stored; if false the output files created by CAMB are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
Definition at line 573 of file PkXiNonLinear.cpp.
std::vector< double > cbl::cosmology::Cosmology::Pk_matter | ( | const std::vector< double > | kk, |
const std::string | method_Pk, | ||
const bool | NL, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString , |
||
const bool | unit1 = false |
||
) |
the dark matter power spectrum
this function provides the dark matter power spectrum; it can use either CAMB, CLASS, MPTbreeze or the analytic approximation by Eisenstein & Hu
kk | vector of wave vector modules |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CAMB_wrapper (running CAMB wrapper), CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; this parameter is used only if norm=1 |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Pk_matter | ( | const std::vector< double > | kk, |
const std::string | method_Pk, | ||
const bool | NL, | ||
const std::vector< double > | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString , |
||
const bool | unit1 = false |
||
) |
the dark matter power spectrum
this function provides the dark matter power spectrum; it can use either CAMB, CLASS, MPTbreeze or the analytic approximation by Eisenstein & Hu
kk | vector of wave vector modules |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
redshift | vector of redshifts |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; this parameter is used only if norm=1 |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
vector< double > cbl::cosmology::Cosmology::Pk_matter_DeWiggled | ( | const std::string | linear_method, |
const std::string | nowiggles_method, | ||
const std::vector< double > | kk, | ||
const double | redshift, | ||
const double | sigma_NL, | ||
const int | order = 4 , |
||
const int | nknots = 10 , |
||
const double | lambda = 0.25 , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | norm = 1 , |
||
const double | prec = 1.e-4 |
||
) |
the dark matter power spectrum, de-wiggled (see e.g. Anderson et al 2014)
this function provides the De-Wiggled dark matter power spectrum
linear_method | method to obtain linear power spectrum |
nowiggles_method | method to obtain power spectrum with no wiggles |
kk | array containing the wave vector module |
redshift | the redshift |
sigma_NL | the non linear BAO damping |
order | basis spline order. This is used only when method=="bspline" |
nknots | number of knots This is used only when method=="bspline" |
lambda | width of the gaussian filter This is used only when method=="gaussian_3d" or "gaussian_1d" |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
prec | accuracy of the integration |
vector< double > cbl::cosmology::Cosmology::Pk_matter_Linear | ( | const std::string | method, |
const std::vector< double > | kk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | norm = 1 , |
||
const double | prec = 1.e-4 |
||
) |
the dark matter linear power spectrum.
This function provides the linear dark matter power spectrum. Valid choices are: CAMB [http://camb.info/], CLASS [http://class-code.net/]
method | method to obtain power spectrum with no wiggles. It can be "CAMB" or "CLASS" |
kk | array containing the wave vector module |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name␓ |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
prec | accuracy of the integration |
vector< double > cbl::cosmology::Cosmology::Pk_matter_NoWiggles | ( | const std::string | method, |
const std::vector< double > | kk, | ||
const double | redshift, | ||
const std::string | linear_method = "CAMB" , |
||
const int | order = 4 , |
||
const int | nknots = 10 , |
||
const double | lambda = 0.25 , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | norm = 1 , |
||
const double | prec = 1.e-4 |
||
) |
the dark matter power spectrum without BAO wiggles
This function provides the No Wiggles dark matter power spectrum. It can be computed with:
method | method to obtain power spectrum with no wiggles. It can be "EisensteinHu", "bspline" "gaussian_3d" or "gaussian_1d" |
kk | array containing the wave vector module |
redshift | the redshift |
linear_method | method to compute the linear power spectrum. It can be "CAMB" or "CLASS" This is used only when method=="bspline" |
order | basis spline order. This is used only when method=="bspline" |
nknots | number of knots This is used only when method=="bspline" |
lambda | width of the gaussian filter This is used only when method=="gaussian_3d" or "gaussian_1d" |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
prec | accuracy of the integration |
vector< double > cbl::cosmology::Cosmology::Pk_matter_NoWiggles_bspline | ( | const std::vector< double > | kk, |
const std::vector< double > | PkLin, | ||
const std::vector< double > | PkApprox, | ||
const int | order, | ||
const int | nknots | ||
) |
the dark matter power spectrum without BAO wiggles.
This function provides the No Wiggles dark matter power spectrum. It follows the method proposed in Vlah et al. 2015 (https://arxiv.org/abs/1509.02120, Appendix A). The no wiggles power spectrum is obtained by interpolating the oscillatory part of the linear power spectrum with a basis spline of a given order and number of knots.
kk | array containing the wave vector module |
PkLin | array that contains the linear power spectrum |
PkApprox | array that contains the approximated no-wiggle power spectrum |
order | basis spline order |
nknots | number of knots |
vector< double > cbl::cosmology::Cosmology::Pk_matter_NoWiggles_gaussian | ( | const std::vector< double > | kk, |
const std::vector< double > | PkLin, | ||
const std::vector< double > | PkApprox, | ||
const double | lambda, | ||
const std::string | method | ||
) |
the dark matter power spectrum without BAO wiggles.
This function provides the No Wiggles dark matter power spectrum. It follows the method proposed in Vlah et al. 2015 (https://arxiv.org/abs/1509.02120, Appendix A). The no wiggles power spectrum is obtained by smoothing the oscillatory part of the linear power spectrum with gaussian filter.
It implements two methods:
Gaussian 3D:
\[ P_{\mathrm{nw}}(k) &=\int d^{3} q P(q) \mathcal{F}_{G}(|\mathbf{k}-\mathbf{q}|) \\ &=\frac{\sqrt{2}}{\sqrt{\pi} \lambda} \int d q q^{2} P(q) \exp \left(-\frac{1}{2 \lambda^{2}}\left(q^{2}+k^{2}\right)\right) \frac{\sinh \left(k q / \lambda^{2}\right)}{k q} \]
Gaussian 1D:
\[ P_{\mathrm{nw}}\left(10^{k_{\mathrm{log}}}\right)=\frac{1}{\sqrt{2 \pi} \lambda} \int d q_{\mathrm{log}} P\left(10^{q_{\mathrm{log}}}\right) \exp \left(-\frac{1}{2 \lambda^{2}}\left(k_{\mathrm{log}}-q_{\mathrm{log}}\right)^{2}\right) \]
kk | array containing the wave vector module |
PkLin | array that contains the linear power spectrum |
PkApprox | array that contains the approximated no-wiggle power spectrum |
lambda | size of the kernel |
method | gaussian smoothing method; it can be "gaussian_1d" or "gaussian_3d" |
std::string cbl::cosmology::Cosmology::Pk_output_file | ( | const std::string | code, |
const bool | NL, | ||
const double | redshift, | ||
const bool | run = 0 , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_max = 100. , |
||
const std::string | file_par = par::defaultString |
||
) |
return the path to the power spectrum output
code | method used to compute the power spectrum |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
redshift | the redshift |
run | true \(\rightarrow\) write or read the table where the dark matter power spectrum is stored |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_max | the maximum wave vector module up to which the power spectrum is computed |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::Pk_ThetaTheta | ( | const double | kk, |
const std::shared_ptr< cbl::glob::FuncGrid > | Pk, | ||
const double | qmin, | ||
const double | qmax, | ||
const double | prec = 1.e-3 |
||
) |
the real-space matter non-linear power spectrum \(P_{\theta\theta}(k)\), computed at 1-loop
this function computes the real-space non-linear matter power spectrum \(P_{\delta\delta}(k)\) at 1-loop, following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ P_{\theta\theta} (k) = \left(\exp(g(k)\right)^2 (P^{lin}(k)+P^{1loop}(k; G_2, G_2)) \]
where \(P^{lin}(k)\) is the linear power spectrum, \(f(k)\) is the second-order correction of the non-linear propagator computed by cbl::cosmology::Cosmology::g_k, and \(P^{1loop}\) is the one-loop power spectrum correction, computed by cbl::cosmology::Cosmology::Pk_1loop
kk | the wavevector module |
Pk | pointer to a FuncGrid object to interpolate the linear power spectrum |
qmin | the lower integration limit |
qmax | the upper integration limit |
prec | the integral precision |
Definition at line 153 of file PkXiNonLinear.cpp.
std::vector< double > cbl::cosmology::Cosmology::Pk_ThetaTheta | ( | const std::vector< double > | kk, |
const double | redshift, | ||
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString , |
||
const bool | unit1 = false |
||
) |
the real-space matter non-linear power spectrum \(P_{\theta\theta}(k)\), computed at 1-loop
this function computes the real-space non-linear matter power spectrum \(P_{\delta\delta}(k)\) at 1-loop, following the MPTbreeze scheme (Crocce et al. 2012, https://arxiv.org/pdf/1207.1465.pdf):
\[ P_{\theta \theta}(k) = \left(2\pi\right)^3\left(\exp(g(k)\right)^2 (P^{lin}(k)+P^{1loop}(k; G_2, G_2)) \]
where \(P^{lin}(k)\) is the linear power spectrum, \(g(k)\) is the second-order correction of the non-linear propagator computed by cbl::cosmology::Cosmology::g_k, and \(P^{1loop}\) is the one-loop power spectrum correction, computed by cbl::cosmology::Cosmology::Pk_1loop
kk | vector of wavevector modules |
redshift | the redshift |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
Definition at line 203 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::Pk_ThetaTheta_fitting_function | ( | const double | kk, |
const std::string | method_Pk, | ||
const double | redshift, | ||
const std::string | author, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const bool | NL, | ||
const int | norm, | ||
double | k_min, | ||
double | k_max, | ||
const double | prec, | ||
const std::string | file_par, | ||
const bool | unit1 | ||
) |
the dark matter velocity divergence power spectrum
the dark matter velocity divergence power spectrum, Pθθ, is computed using the fitting functions given by Bel et. al (2019) [https://arxiv.org/abs/1809.09338].
\[ P_{\theta\theta}(k) = P^{Lin}_{\theta\theta}(k)e^{-k(a_1+a_2k+a_3k^2)} \]
with
\[a_1 = -0.817 + 3.198*\sigma_8\]
\[a_2 = 0.877 - 4.191*\sigma_8\]
\[a_3 = -1.199 + 4.629*\sigma_8\]
kk | the wave vector module |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
author | author(s) who proposed the fitting functions; valid authors are: Pezzotta (Pezzotta, et.al, 2017), Bel (Bel et.al., 2019) |
store_output | if true the output files created by CAMB are stored; if false the output files created by CAMB are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Pk_TNS_AB_1loop | ( | std::vector< double > | kk, |
const double | mu, | ||
const double | linear_growth_rate, | ||
const double | bias, | ||
const std::string | method, | ||
const double | redshift, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const int | norm, | ||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 |
||
) |
the expanded A and B correction terms for the TNS model
the expanded A and B correction terms are computed at 1-loop using (Standard) Perturbation Theory implemented in the CPT Library [http://www2.yukawa.kyoto-u.ac.jp/~atsushi.taruya/cpt_pack.html]. Details can be found in (Taruya et.al, 2010) [https://arxiv.org/abs/1006.0699].
\[ A(k,\mu,\beta) = \beta\mu^2A_{11} + \beta^2(\mu^2A_{12} + \mu^4A_{22}) + \beta^3(\mu^4A_{23} + \mu^6A_{33}) \]
\[ B(k,\mu,\beta) = \mu^2(\beta^2B_{12} + \beta^3B_{13} + \beta^4B_{14}) + \mu^4(\beta^2B_{22} + \beta^3B_{23} + \beta^4B_{24}) + \mu^6(\beta^3B_{33} + \beta^4B_{34}) + \mu^8\beta^4B_{44} \]
kk | the wave vector module |
mu | the cosine of the angle between the separation and the line of sight |
linear_growth_rate | the linear growth rate |
bias | the bias |
method | method used to compute the power spectrum; valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by CAMB are stored; if false the output files created by CAMB are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
Definition at line 460 of file PkXiNonLinear.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Pk_TNS_AB_1loop | ( | std::vector< double > | kk, |
const double | mu, | ||
const std::string | method, | ||
const double | redshift, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const int | norm, | ||
const double | k_min, | ||
const double | k_max, | ||
const double | prec | ||
) |
the A and B correction terms for the TNS model at 1-loop from the multipole expansion
the A and B correction terms for the TNS model at 1-loop from the multipole expansion are computed using the Standard Perturbation Theory implemented in the CPT Library [http://www2.yukawa.kyoto-u.ac.jp/~atsushi.taruya/cpt_pack.html]. Details can be found in Taruya et al. (2010) [https://arxiv.org/abs/1006.0699].
\[ A(k,\mu) = A_0(k)L_0(\mu) + A_2(k)L_2(\mu) + A_4(k)L_4(\mu) \]
\[ B(k,\mu) = B_0(k)L_0(\mu) + B_2(k)L_2(\mu) + B_4(k)L_4(\mu) \]
where \(L_l\) represents the Legendre polynomial of order \(l\).
kk | the wave vector module |
mu | the cosine of the angle between the separation and the line of sight |
method | method used to compute the power spectrum; valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by CAMB are stored; if false the output files created by CAMB are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
Definition at line 305 of file PkXiNonLinear.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Pk_TNS_AB_multipoles | ( | std::vector< double > | kk, |
const std::string | method, | ||
const double | redshift, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const int | norm, | ||
const double | k_min, | ||
const double | k_max, | ||
const double | prec | ||
) |
the multipoles of the A and B correction terms for the TNS model
the multipoles of the A and B correction terms for the TNS model are computed at 1-loop using the Standard Perturbation Theory implemented in the CPT Library [http://www2.yukawa.kyoto-u.ac.jp/~atsushi.taruya/cpt_pack.html]. Details can be found in Taruya et al. (2010) [https://arxiv.org/abs/1006.0699].
\[ A(k,\mu) = A_0(k)L_0(\mu) + A_2(k)L_2(\mu) + A_4(k)L_4(\mu) \]
\[ B(k,\mu) = B_0(k)L_0(\mu) + B_2(k)L_2(\mu) + B_4(k)L_4(\mu) \]
where \(L_l\) represents the Legendre polynomial of order \(l\).
kk | the wave vector module |
method | method used to compute the power spectrum; valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by CAMB are stored; if false the output files created by CAMB are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
Definition at line 224 of file PkXiNonLinear.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Pk_TNS_AB_terms_1loop | ( | std::vector< double > | kk, |
const std::string | method, | ||
const double | redshift, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const int | norm, | ||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 |
||
) |
the expanded A and B correction terms for the TNS model
the expanded A and B correction terms for the TNS model are computed at 1-loop using the Standard Perturbation Theory implemented in the CPT Library [http://www2.yukawa.kyoto-u.ac.jp/~atsushi.taruya/cpt_pack.html]. Details can be found in Taruya et al. (2010) [https://arxiv.org/abs/1006.0699].
\[ A(k,\mu,\beta) = \beta\mu^2A_{11} + \beta^2(\mu^2A_{12} + \mu^4A_{22}) + \beta^3(\mu^4A_{23} + \mu^6A_{33}) \]
\[ B(k,\mu,\beta) = \mu^2(\beta^2B_{12} + \beta^3B_{13} + \beta^4B_{14}) + \mu^4(\beta^2B_{22} + \beta^3B_{23} + \beta^4B_{24}) + \mu^6(\beta^3B_{33} + \beta^4B_{34}) + \mu^8\beta^4B_{44} \]
kk | the wave vector module |
method | method used to compute the power spectrum; valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by CAMB are stored; if false the output files created by CAMB are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
Definition at line 322 of file PkXiNonLinear.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::Pk_TNS_dd_dt_tt | ( | std::vector< double > | kk, |
const std::string | method, | ||
const double | redshift, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const int | norm, | ||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 |
||
) |
the non-linear \(\delta-\delta\), \(\delta-\theta\), \(\theta-\theta\) matter power spectra
the non-linear \(\delta-\delta\), \(\delta-\theta\), \(\theta-\theta\) matter power spectra are computed at 1-loop using (Standard) Perturbation Theory as implemented in the CPT Library [http://www2.yukawa.kyoto-u.ac.jp/~atsushi.taruya/cpt_pack.html]. Details can be found in Taruya et al. (2010) [https://arxiv.org/abs/1006.0699]. The density, density-velocity divergence and velocity divergence-velocity divergence power spectra are defined as:
\[ < \delta(k)\delta(k')> = (2\pi)^3\delta(k + k')P_{\delta\delta}(k) \]
\[ < \delta(k)\theta(k')> = (2\pi)^3\delta(k + k')P_{\delta\theta}(k) \]
\[ < \theta(k)\theta(k')> = (2\pi)^3\delta(k + k')P_{\theta\theta}(k) \]
kk | the wave vector module |
method | method used to compute the power spectrum; valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by CAMB are stored; if false the output files created by CAMB are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
Definition at line 479 of file PkXiNonLinear.cpp.
double cbl::cosmology::Cosmology::potential_spectral_amplitude | ( | const std::string | method_Pk, |
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the potential spectral amplitude
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::pw | ( | const double | ww, |
const double | ff, | ||
const std::string | author | ||
) | const |
differential distribution
this function provides the differential rescaled and generalized formation redshift distribution
ww | rescaled variable w as in Lacey and Coles 1993 |
ff | assembled fraction |
author | valid authors are: NS (Nusser and Sheth), GTS (Giocoli et al. 2012) |
Definition at line 51 of file MassGrowth.cpp.
double cbl::cosmology::Cosmology::pz | ( | const double | m0, |
const double | z0, | ||
const double | frac, | ||
const double | redshift, | ||
const std::string | model_model, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" |
||
) | const |
formation probability
this function provides the probability that a halo of a given mass m0 at redshift z0 make a mass fraction f at redshift z
m0 | halo mass |
z0 | redshift when the halo has a mass m0 |
frac | mass fraction |
redshift | the redshift |
model_model | valid authors are: NS (Nusser and Sheth), GTS (Giocoli et al. 2012) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Definition at line 71 of file MassGrowth.cpp.
std::vector< double > cbl::cosmology::Cosmology::Q_DM | ( | const double | r1, |
const double | r2, | ||
const std::vector< double > | theta, | ||
const std::string | model, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the dark matter reduced three-point correlation function
this function computes the dark matter reduced three-point reduced correlation function with either the Slepian et al. 2015 or the Barriga & Gatzagnaga 2002 model
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | vector containing angles between r1 and r2, in radians |
model | the model to compute the three-point correlation function, can be "Slepian" or "BarrigaGatzanaga" |
kk | vector of the wave vector modules |
Pk_matter | the dark matter power spectrum |
double cbl::cosmology::Cosmology::Q_DM_BarrigaGatzanaga | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
std::vector< double > & | rr, | ||
std::vector< double > & | xi_matter, | ||
std::vector< double > & | Phi, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the dark matter reduced three-point correlation function model by Barriga & Gatzanaga et al. 2002
this functions computes \(Q_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2})\), as described in Barriga & Gatzanaga et al. 2002:
\[ Q_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2}) = \frac{\zeta_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2})} {\left( \xi(r_1)\xi(r_2)+\xi(r_2)\xi(r_3)+\xi(r_3)\xi(r_1)\right)} \]
see cbl::cosmology::Cosmology::zeta_DM_BarrigaGatzanaga for more details
[in] | r1 | the first side of the triangle |
[in] | r2 | the second side of the triangle |
[in] | theta | the angle between r1 and r2 |
[out] | rr | vector or scales |
[out] | xi_matter | vector containing the dark matter two-point correlation function |
[out] | Phi | vector containing \( \Phi(r)\) |
[in] | kk | vector of the wave vector modules |
[in] | Pk_matter | the dark matter power spectrum |
std::vector< double > cbl::cosmology::Cosmology::Q_DM_eq | ( | const std::vector< double > | rr, |
const std::string | model, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the dark matter equilateral reduced three-point correlation function
this function computes the dark matter equilateral reduced three-point correlation function with either the Slepian et al 2015 or the Barriga & Gatzagnaga 2002 model
rr | vector of sides |
model | the model to compute the three-point correlation function, can be "Slepian" or "BarrigaGatzanaga" |
kk | vector of the wave vector modules |
Pk_matter | the dark matter power spectrum |
double cbl::cosmology::Cosmology::Q_DM_Slepian | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
std::vector< double > & | rr, | ||
std::vector< double > & | xi_matter, | ||
std::vector< double > & | xi_matter_m1, | ||
std::vector< double > & | xi_matter_p1, | ||
std::vector< double > & | xi_matter_2, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter, | ||
const int | norders = 9 , |
||
const double | prec = 1.e-3 |
||
) | const |
the dark matter reduced three-point correlation function model by Slepian et al. 2015
this function computes \(Q_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2})\) as described in Slepian et al. 2015:
\[ Q_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2}) = \frac{\zeta_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2})} {\left( \xi(r_1)\xi(r_2)+\xi(r_2)\xi(r_3)+\xi(r_3)\xi(r_1)\right)} \]
see cbl::cosmology::Cosmology::zeta_DM_Slepian for more details
[in] | r1 | the first side of the triangle |
[in] | r2 | the second side of the triangle |
[in] | theta | the angle between r1 and r2 |
[out] | rr | vector or scales |
[out] | xi_matter | vector containing the dark matter two-point orrelation function |
[out] | xi_matter_m1 | vector containing \(\xi^{[1-]}_{DM}(r)\) |
[out] | xi_matter_p1 | vector containing \(\xi^{[1+]}_{DM}(r)\) |
[out] | xi_matter_2 | vector containing \(\xi^{[2]}_{DM}(r)\) |
[out] | kk | vector of the wave vector modules |
[out] | Pk_matter | the dark matter power spectrum |
[in] | norders | the maximum numbers of orders |
[in] | prec | the integral precision |
std::vector< double > cbl::cosmology::Cosmology::Q_halo | ( | const double | r1, |
const double | r2, | ||
const std::vector< double > | theta, | ||
const double | b1, | ||
const double | b2, | ||
const double | g2, | ||
const std::string | model, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the non-local-bias model of the three-point correlation function of dark matter haloes
this function computes the reduced three-point correlation function of dark matter haloes, with non-local bias corrections, with either the Slepian et al. 2015 or the Barriga & Gatzagnaga 2002 model, as follows:
\[ Q_h (r_1, r_2, \hat{r_1} \cdot \hat{r_2}) = \frac{Q_{DM}(r_1, r_2, \hat{r_1} \cdot \hat{r_2})}{b_1}+ \frac{b_2}{b_1^2}+\frac{g_2}{b_1}Q_{non-local} \]
\(Q_{DM}\) is compute by cbl::cosmology::Cosmology::Q_DM and \(Q_{non-local}\) is the non-local contirbuion term, computed by cbl::cosmology::Cosmology::Q_nonLocal
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | vector containing angles between r1 and r2, in radians |
b1 | the linear bias |
b2 | the non-linear bias |
g2 | the non-local bias |
model | the model to compute the three-point correlation function, can be "Slepian" or "BarrigaGatzanaga" |
kk | vector of the wave vector modules |
Pk_matter | the dark matter power spectrum |
std::vector< double > cbl::cosmology::Cosmology::Q_halo | ( | const double | r1, |
const double | r2, | ||
const std::vector< double > | theta, | ||
const double | b1, | ||
const double | b2, | ||
const std::string | model, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the local-bias model of the reduced three-point correlation function of dark matter haloes
this function computes the reduced three-point correlation function of dark matter haloes with either the Slepian et al. 2015 or the Barriga & Gatzagnaga 2002 model, as follows:
\[ Q_h (r_1, r_2, \hat{r_1} \cdot \hat{r_2}) = \frac{Q_{DM}(r_1, r_2, \hat{r_1} \cdot \hat{r_2})}{b_1}+\frac{b_2}{b_1^2}\]
\(Q_{DM}\) is compute by cbl::cosmology::Cosmology::Q_DM
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | vector containing angles between r1 and r2, in radians |
b1 | the linear bias |
b2 | the non-linear bias |
model | the model to compute the three-point correlation function, can be "Slepian" or "BarrigaGatzanaga" |
kk | vector of the wave vector modules |
Pk_matter | the dark matter power spectrum |
double cbl::cosmology::Cosmology::Q_nonLocal | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
std::vector< double > & | rr, | ||
std::vector< double > & | xi_matter, | ||
std::vector< double > & | Phi, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the non-local contribution to the reduced dark matter three-point correlation function
this function computes the non-local contribution to three-point correlation function; specifically, it implements Eq. 22 of Bel el et al. 2015, MNRAS, 453, 259:
\[ Q_{non-local}(r_1, r_2, \theta) = \frac{2}{3} \left( \frac{\Gamma_{123} + \Gamma_{312} + \Gamma_{231}} {\xi(r_1)\cdot\xi(r_2) + \xi(r_2)\cdot\xi(r_3) + \xi(r_3)\cdot\xi(r_1)}-1 \right) \]
where the prime indicates the derivative with respect to \(r\), and \(\xi(r), \Phi(r)\) are the integrals of the power spectrum computed by cbl::cosmology::Cosmology::integrals_Q_nonLocal
[in] | r1 | the first side of the triangle |
[in] | r2 | the second side of the triangle |
[in] | theta | the angle betwee r1 and r2 |
[out] | rr | vector or scales at which the dark matter two-point correlation function is computed |
[out] | xi_matter | vector containing the dark matter two-point correlation function values |
[out] | Phi | vector containing the \( \Phi(r)\) values, estimated at the scales given in rr |
[in] | kk | vector of the wave vector modules at which the power spectrum is computed |
[in] | Pk_matter | vector of containing the dark matter power spectrum values, estimated at the wave vector modules given in kk |
std::vector< double > cbl::cosmology::Cosmology::Q_nonLocal | ( | const double | r1, |
const double | r2, | ||
const std::vector< double > | theta, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
all the non-local contribution terms of the reduced dark matter three-point correlation function
this function computes all the the non-local contribution terms of the reduced three-point correlation function, computed by cbl::cosmology::Cosmology::Q_nonLocal
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | the angle betwee r1 and r2 |
kk | vector of the wave vector modules at which the power spectrum is computed |
Pk_matter | vector of containing the dark matter power spectrum values, estimated at the wave vector modules given in kk |
double cbl::cosmology::Cosmology::qq | ( | const double | redshift = 0. | ) | const |
the deceleration parameter at a given redshift
redshift | the redshift |
Definition at line 973 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::quadrupole | ( | const double | Mass_min, |
const double | Mass_max, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the normalised quadrupole Q
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::quadrupole | ( | const std::vector< double > | MM, |
const std::vector< double > | MF, | ||
const double | redshift, | ||
const std::string | model_bias, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const double | kk = -1. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the normalised quadrupole Q
MM | vector of halo masses |
MF | vector of mass function values, dΦ/dM=dn(M)/dM |
redshift | the redshift |
model_bias | author(s) who proposed the bias; valid authors are: ST99 (Sheth & Tormen 1999), SMT01 (Sheth, Mo & Tormen 2001), SMT01_WL04 (Sheth, Mo & Tormen 2001 with the correction of Warren 2004), Tinker (Tinker et al. 2010) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
kk | wave vector module |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::r_rL | ( | const double | deltav = -2.71 | ) | const |
expansion factor
deltav | the linear density contrast: \(\delta_v^L\) (default value set to \(-2.71\)) |
Definition at line 65 of file SizeFunction.cpp.
double cbl::cosmology::Cosmology::r_vir | ( | const double | M_vir, |
const double | redshift, | ||
const std::string | author = "BryanNorman" , |
||
const bool | unit1 = false |
||
) | const |
the virial radius, given the virial mass and the redshift
this function computes the virial halo radius as follows:
\[r_{vir}(z) = \left(\frac{3 M_{vir}}{4\pi\Delta_c(z)\rho_{crit}(z)}\right)^{1/3}\]
where \(\Delta_c(z)\) is computed by cbl::cosmology::Cosmology::Delta_c and \(\rho_{crit}(z)\) is computed by cbl::cosmology::Cosmology::rho_crit
M_vir | the virial mass |
redshift | the redshift |
author | the author of the \(\Delta_c(z)\) equation (see cbl::cosmology::Cosmology::Delta_c) |
unit1 | true \(\rightarrow\) force cosmological units |
Definition at line 1331 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Redshift | ( | const double | d_c = 1. , |
const double | z1_guess = 0. , |
||
const double | z2_guess = 10. , |
||
const double | prec = 0.0001 |
||
) | const |
redshift at a given comoving distance
this method provides the redshift for a given comoving distance
d_c | line-of-sight comoving distance |
z1_guess | minimum prior on the redshift |
z2_guess | maximum prior on the redshift |
prec | precision of the computation ( prec = min(prec,1.e-5) ) |
Definition at line 1045 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Redshift | ( | const double | mm, |
const double | redshift, | ||
const double | ff, | ||
const std::string | method_SS, | ||
const double | wwf, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" |
||
) | const |
redshift at a given wf
this routine estimates the redshift from wf, given the parent halo mass at z=z', z', and its assembled fraction f
mm | mass |
redshift | the redshift |
ff | assembled fraction |
method_SS | method used to compute the power spectrum and σ(mass) const; valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
wwf | rescaled variable w as in Lacey and Coles 1993 |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Definition at line 168 of file MassGrowth.cpp.
std::vector< double > cbl::cosmology::Cosmology::redshift_distribution_haloes | ( | const double | z_min, |
const double | z_max, | ||
const int | step_z, | ||
const double | Area_degrees, | ||
const double | Mass_min, | ||
const double | Mass_max, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const bool | isDelta_critical = false , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
redshift distribution of dark matter haloes
z_min | minimum redshift |
z_max | maximum redshift |
step_z | redshift step |
Area_degrees | the survey area, in degrees |
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
isDelta_critical | \(\rightarrow\) \(\Delta\) is the overdensity defined with respect to the critical density |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 761 of file MassFunction.cpp.
std::vector< double > cbl::cosmology::Cosmology::redshift_distribution_haloes_selection_function | ( | const std::vector< double > | redshift, |
const double | Area_degrees, | ||
const double | Mass_min, | ||
const double | Mass_max, | ||
const std::string | model_MF, | ||
const std::string | method_SS, | ||
const std::string | selection_function_file, | ||
const std::vector< int > | column = {} , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200 , |
||
const bool | isDelta_critical = false , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
redshift distribution of dark matter haloes, given a selection function
redshift | vector containing the redshift at which the halo distribution will be computed |
Area_degrees | the survey area, in degrees |
Mass_min | minimum halo mass |
Mass_max | maximum halo mass |
model_MF | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), ShenH (halo MF, Shen et al. 2006), ShenF (filament MF, Shen et al. 2006), ShenS (sheet MF, Shen et al. 2006), Pan (Pan 2007), Peacock (Peacock at al. 2007), Reed (Reed et al. 2007), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Manera (Manera et al. 2010), Courtin (Courtin et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Angulo_FOF (FoF MF, Angulo et al. 2012), Angulo_Sub (SUBFIND MF, Angulo et al. 2012), Watson_FOF (FoF MF, Watson et al. 2012), Watson_SOH (Spherical Overdensity halo MF, Watson et al. 2012), Despali_Z0, Despali_AllZ, Despali_AllZAllCosmo, Despali_HighM (Despali et al. 2016) |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
selection_function_file | input file where the selection function is stored |
column | the columns to be read |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
isDelta_critical | \(\rightarrow\) \(\Delta\) is the overdensity defined with respect to the critical density |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 820 of file MassFunction.cpp.
double cbl::cosmology::Cosmology::Redshift_LCDM | ( | const double | d_c = 1. , |
const double | z1_guess = 0. , |
||
const double | z2_guess = 10. , |
||
const bool | go_fast = 1 , |
||
const double | prec = 0.0001 |
||
) | const |
redshift at a given comoving distance
this method provides the redshift for a given comoving distance; the iteration process exploits the properties of the f=d(z) function (i.e. f'=1/E(z), f"<0)
d_c | line-of-sight comoving distance |
z1_guess | minimum redshift of the region explored to search the redshift |
z2_guess | maximum redshift used to search the redshift |
go_fast | 0 \(\rightarrow\) the method uses the function Cosmology::D_C; 1 \(\rightarrow\) the method uses the function Cosmology::D_C_LCDM (much faster than D_C) |
prec | precision of the computation; ( prec = min(prec,1.e-5) ) |
Definition at line 1101 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Redshift_time | ( | const double | time, |
const double | z1_guess, | ||
const double | z2_guess | ||
) | const |
redshift at a given cosmic time
time | cosmic time |
z1_guess | minimum redshift used to search the redshift |
z2_guess | maximum redshift used to search the redshift |
Definition at line 1169 of file Cosmology.cpp.
void cbl::cosmology::Cosmology::remove_output_Pk_tables | ( | const std::string | code, |
const bool | NL, | ||
const double | redshift, | ||
const std::string | output_root = "test" |
||
) | const |
remove the output generated by the methods CAMB, MPTbreeze or CLASS
code | method used to compute the power spectrum; valid codes are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465] |
NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
redshift | redshift |
output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
double cbl::cosmology::Cosmology::rho_crit | ( | const double | redshift, |
const bool | unit1 = false |
||
) | const |
the critical cosmic density
this function computes the critical cosmic density at a given redshift:
\[\rho_{crit}(z)=\frac{3H^2(z)}{8\pi G}\]
redshift | the redshift |
unit1 | true \(\rightarrow\) force cosmological units |
Definition at line 1257 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::rho_m | ( | const double | redshift = 0. , |
const bool | unit1 = false , |
||
const bool | nu = false |
||
) | const |
the mean cosmic background density
\[\rho_m(z) = \rho_{crit}(z)\Omega_M(z) = \frac{3H^2(z)}{8\pi G}\Omega_M(z)\]
redshift | the redshift |
unit1 | true \(\rightarrow\) force cosmological units |
nu | true \(\rightarrow\) compute \(\rho_m(z) = \rho_{crit}(z)[\Omega_M(z)-\Omega_\nu(z)]\) |
Definition at line 1274 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_RhoZero
Definition at line 1258 of file Cosmology.h.
|
inline |
get the sound horizon at recombination
Definition at line 1289 of file Cosmology.h.
double cbl::cosmology::Cosmology::rs | ( | const double | redshift, |
const double | T_CMB = 2.7255 |
||
) | const |
double cbl::cosmology::Cosmology::rs | ( | const std::string | method_Pk, |
const double | T_CMB = par::TCMB |
||
) | const |
the sound horizon at the drag epoch rs(zd), valid choices for method_Pk are: EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html], CAMB [http://camb.info/]
method_Pk | the method to compute the sound horizon |
T_CMB | TCMB: the present day CMB temperature [K] |
double cbl::cosmology::Cosmology::rs_CAMB | ( | ) | const |
the sound horizon at the drag epoch estimated with CAMB [http://camb.info/], analytical formula by Aubourg et al. 2014
see Anderson et al 2014, Eq. 16
double cbl::cosmology::Cosmology::rs_EH | ( | const double | T_CMB = par::TCMB | ) | const |
double cbl::cosmology::Cosmology::rs_integrand | ( | const double | redshift, |
const double | T_CMB = 2.7255 |
||
) | const |
void cbl::cosmology::Cosmology::run_CAMB | ( | const bool | NL, |
const double | redshift, | ||
const std::string | output_root = par::defaultString , |
||
const std::string | output_dir = par::defaultString , |
||
const double | k_max = 100. , |
||
const std::string | file_par = par::defaultString |
||
) | const |
run CAMB [http://camb.info/]
this function runs CAMB [http://camb.info/], after editing the parameter file appropriately (if file_par=NULL)
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
redshift | the redshift |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If NULL, the output will be deleted after running CAMB |
output_dir | std::string containing the output directory |
k_max | maximum wave vector module up to which the power spectrum is computed |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
void cbl::cosmology::Cosmology::run_CAMB | ( | std::vector< double > & | lgkk, |
std::vector< double > & | lgPk, | ||
const bool | NL, | ||
const double | redshift, | ||
const std::string | output_root = "test" , |
||
const std::string | output_dir = par::defaultString , |
||
const double | k_max = 100. , |
||
const std::string | file_par = par::defaultString |
||
) | const |
run CAMB [http://camb.info/] and read the matter power spectrum
this function runs CAMB [http://camb.info/], after editing the parameter file appropriately (if file_par=NULL) and store the matter power spectrum in two vectors
[out] | lgkk | vector of log(k) |
[out] | lgPk | vector of log(P(k)) |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum | |
redshift | the redshift | |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If NULL, the output will be deleted after running CAMB | |
output_dir | std::string containing the output directory | |
k_max | maximum wave vector module up to which the power spectrum is computed | |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will use be used, ignoring the cosmological parameters of the object |
|
inline |
get the private member Cosmology::m_scalar_amp
Definition at line 1220 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_scalar_pivot
Definition at line 1227 of file Cosmology.h.
|
inline |
set the value of fNL
fNL | fNL: the non-Gaussian amplitude |
Definition at line 1600 of file Cosmology.h.
|
inline |
set the value of H0
H0 | H0: Hubble constant [km/sec/Mpc] |
warn | true \(\rightarrow\) print a warning message if m_unit is true |
Definition at line 1533 of file Cosmology.h.
|
inline |
set the value of h
hh | the Hubble constant H0/100 |
warn | true \(\rightarrow\) print a warning message if m_unit is true |
Definition at line 1516 of file Cosmology.h.
|
inline |
set the cosmologial model used to compute distances
model | the cosmologial model used to compute distances |
Definition at line 1630 of file Cosmology.h.
|
inline |
set the value of nspec
n_spec | nspec: the primordial spectral index |
Definition at line 1569 of file Cosmology.h.
|
inline |
set the value of ΩM, keeping ΩDE=1-ΩM-Ωrad-Ωk
Omega_matter | ΩM: density of baryons, cold dark matter and massive neutrinos (in units of the critical density) |
Definition at line 1419 of file Cosmology.h.
|
inline |
set the value of \(\Omega_{\rm b}\), \(\Omega_{\rm cdm}\), \(\Omega_{\nu}\), \(\Omega_{\rm rad}\), \(\Omega_{\rm DE}\), and consequently the values of
\(\Omega_{\rm M} = \Omega_{\rm b}+\Omega_{\rm cdm}+\Omega_{\nu}, \)
and
\(\Omega_{\rm k} = 1-\Omega_{\rm M}-\Omega_{\rm rad}-\Omega_{\rm DE}\)
OmegaB | density of baryons, \(\Omega_{\rm M}\), in units of the critical density |
OmegaCDM | density of cold dark matter, \(\Omega_{\rm cdm}\), in units of the critical density |
OmegaNu | density of massive neutrinos, \(\Omega_{\nu}\), in units of the critical density |
OmegaR | density of radiation, \(\Omega_{\rm rad}\), in units of the critical density |
OmegaDE | density of dark energy, \(\Omega_{\rm DE}\), in units of the critical density |
Definition at line 1399 of file Cosmology.h.
|
inline |
set the private member Cosmology::m_Omega_radiation
Omega_radiation | \(\Omega_{rad}\): the radiation density |
Definition at line 1502 of file Cosmology.h.
|
inline |
set the value of Ωb, keeping ΩCDM=ΩM-Ωb
Omega_baryon | Ωb: density of baryons, (in units of the critical density) |
Definition at line 1432 of file Cosmology.h.
|
inline |
set the value of Ωb, keeping ΩCDM=ΩM-Ωb
Omega_baryonh2 | Ωbh2: density of baryons, (in units of the critical density) times h2 |
Definition at line 1446 of file Cosmology.h.
|
inline |
set the value of ΩDE
Omega_DE | ΩDE: density of dark energy |
Definition at line 1471 of file Cosmology.h.
|
inline |
set the value of ΩM
Omega_matter | ΩM: density of baryons, cold dark matter and massive neutrinos (in units of the critical density) |
Definition at line 1459 of file Cosmology.h.
|
inline |
set the value of Ων
Omega_neutrinos | Ων: density of massive neutrinos |
massless_neutrinos | Neff: the effective number (for QED + non-instantaneous decoupling) |
massive_neutrinos | the number of degenerate massive neutrino species |
Definition at line 1486 of file Cosmology.h.
void cbl::cosmology::Cosmology::set_parameter | ( | const CosmologicalParameter | parameter, |
const double | value | ||
) |
set the value of one cosmological paramter
parameter | cosmological parameter to set |
value | the new value for the parameter |
Definition at line 424 of file Cosmology.cpp.
void cbl::cosmology::Cosmology::set_parameters | ( | const std::vector< CosmologicalParameter > | parameter, |
const std::vector< double > | value | ||
) |
set the value of some cosmological paramters
parameter | vector containing the cosmological parameters to set |
value | vector containing the new values for the parameters |
Definition at line 525 of file Cosmology.cpp.
|
inline |
set the value of ρ0
RhoZero | the mean density of the Universe at z=0 [Msun*Mpc^-3] |
Definition at line 1593 of file Cosmology.h.
|
inline |
set the value of the \(r_s\);
rs | the sound horizon |
Definition at line 1623 of file Cosmology.h.
|
inline |
set the value of As
scalar_amp | \(A_s\): initial scalar amplitude of the power spectrum |
Definition at line 1555 of file Cosmology.h.
|
inline |
set the value of the scalar pivot
scalar_pivot | the scalar pivot k in \(Mpc^{-1}\) |
Definition at line 1562 of file Cosmology.h.
|
inline |
set the value of σ8
sigma8 | σ8: power spectrum normalisation |
Definition at line 1547 of file Cosmology.h.
|
inline |
set the value of the τ
τ | the Thomson scattering optical depth due to reionization |
Definition at line 1616 of file Cosmology.h.
|
inline |
set the value of the non-Gaussian shape
type_NG | the non-Gaussian shape (type=1 local, type=2 equilateral, type=3 enfolded, type=4 orthogonal) |
Definition at line 1608 of file Cosmology.h.
|
inline |
set the value of unit
unit | false \(\rightarrow\) phyical units; true \(\rightarrow\) cosmological units (i.e. in units of h) |
Definition at line 1638 of file Cosmology.h.
|
inline |
set the value of w0
w0 | w0: parameter of the dark energy equation of state (CPL parameterisation) |
Definition at line 1577 of file Cosmology.h.
|
inline |
set the value of wa
wa | wa: parameter of the dark energy equation of state (CPL parameterisation) |
Definition at line 1585 of file Cosmology.h.
double cbl::cosmology::Cosmology::sigma2M | ( | const double | mass, |
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const bool | unit1 = false |
||
) | const |
the mass variance, \(\sigma^2(M)\)
this function computes the variance of the linear density field:
\[ \sigma^2(M) = \frac{1}{2\pi^2}\int_0^\infty {\rm d}k\, k^2 P_{lin}(k, z) W^2(k, R)\]
where \(W(x)=(3/x)^3(\sin x-x\cos x)\) and \(R=(3M/4\pi\rho_m)^{1/3}\)
mass | the mass |
method_Pk | the method used to compute the power spectrum; valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
unit1 | true \(\rightarrow\) force cosmological units |
double cbl::cosmology::Cosmology::sigma2R | ( | const double | radius, |
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true , |
||
const bool | unit1 = false |
||
) | const |
the mass variance, \(\sigma^2(R)\)
this function computes the variance of the linear density field:
\[ \sigma^2(R)=\frac{1}{2\pi^2}\int_0^\infty {\rm d}k\, k^2 P_{lin}(k, z) W^2(k, R)\]
where \(W(x)=(3/x)^3(\sin x-x\cos x)\)
radius | the radius, \(R\) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
unit1 | true \(\rightarrow\) force cosmological units |
|
inline |
get the private member Cosmology::m_sigma8
Definition at line 1212 of file Cosmology.h.
double cbl::cosmology::Cosmology::sigma8 | ( | const double | redshift | ) | const |
σ8 at a given redshift
redshift | the redshift |
Definition at line 729 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::sigma8_interpolated | ( | const double | redshift | ) | const |
σ8
this function provides an approximate value of σ8, at a given redshift, from Aubourg et al. 2015, eq.(32)
redshift | the redshift |
double cbl::cosmology::Cosmology::sigma8_Pk | ( | const std::string | method_Pk, |
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | NL = 0 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) | const |
the dark matter rms mass fluctuation within 8 Mpc/h
this function provides the rms mass fluctuation within 8 Mpc/h, estimated directly from the power spectrum
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::sigma_v | ( | const double | redshift = 0. , |
const std::string | method_Pk = "CAMB" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const int | bin_k = 512 , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString , |
||
const bool | unit1 = false |
||
) |
the linear-order one-dimensional pairwise velocity dispersion, \(\sigma_{\mathrm{v}, \mathrm{lin}}\)
This function computes the linear-order one-dimensional pairwise velocity dispersion, \(\sigma_{\mathrm{v}, \mathrm{lin}}\), as defined in Taruya et al. (2010) (Eq. 7 of https://arxiv.org/abs/1006.0699)
\[ \sigma_{\mathrm{v}, \mathrm{lin}}^{2} = \frac{1}{3} \int \frac{d^{3} \boldsymbol{q}}{(2 \pi)^{3}} \frac{P_{\mathrm{lin}}(q, z)}{q^{2}} \]
where \(P_{\mathrm{lin}}(q, z)\) is the linear power spectrum at a given redshift
redshift | the redshift |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed to estimate the power spectrum normalisation; this parameter is used only if norm=1 |
bin_k | number of wave vector modules used for the integration |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
unit1 | true \(\rightarrow\) force cosmological units |
double cbl::cosmology::Cosmology::Sigman_PT | ( | const int | nn, |
const double | RR, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
the deprojected hierarchical moments Σn
this function provides the deprojected hierarchical moments Σn given by the perturbation theory (see e.g. Juszkiewicz et al. 1993, Bernardeau 1994, Wolk 2013)
nn | order of the moment |
RR | comoving separation |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::sigmaR_DM | ( | const double | RR, |
const int | corrType, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const double | pimax = 40 , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | NL = 1 , |
||
const int | norm = -1 , |
||
const double | r_min = 1.e-3 , |
||
const double | r_max = 350. , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 0. , |
||
const bool | GSL = false , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the dark matter rms mass fluctuation
RR | radius inside which the dark matter rms mass fluctuation is computed |
corrType | 0 \(\rightarrow\) the projected correlation function, w(θ), is used; 1 \(\rightarrow\) the spherically averaged correlation function, ξ(r), is used |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
pimax | the upper limit of the line-of-sight integration |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
r_min | minimum separation up to which the correlation function is computed |
r_max | maximum separation up to which the correlation function is computed |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
aa | parameter a of Eq. 24 of Anderson et al. 2012 |
GSL | false \(\rightarrow\) FFTlog is used; true \(\rightarrow\) the GSL libraries are used |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::size_function | ( | const double | RV, |
const double | redshift, | ||
const std::string | model, | ||
const double | b_eff, | ||
double | slope = 0.854 , |
||
double | offset = 0.420 , |
||
const double | deltav_NL = -0.795 , |
||
const double | del_c = 1.69 , |
||
const std::string | method_Pk = "EisensteinHu" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
the void size function
RV | radius |
redshift | the redshift |
model | size function model name; valid choices for model name are SvdW (Sheth and van de Weygaert, 2004), linear and Vdn (Jennings et al., 2013) |
b_eff | the effective bias of the sample |
slope | first coefficent to convert the effective bias (default value set to \(0.854\)) |
offset | second coefficent to convert the effective bias (default value set to \(0.420\)) |
deltav_NL | the non linear density contrast: \(\rho_v/\rho_m\) (default value set to \(-0.795\)) |
del_c | critical value of the linear density field (default value set to \(1.06\)) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 112 of file SizeFunction.cpp.
double cbl::cosmology::Cosmology::size_function | ( | const double | RV, |
const double | redshift, | ||
const std::string | model_mf, | ||
const double | del_v, | ||
const std::string | model_sf, | ||
const std::string | method_Pk = "EisensteinHu" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | Delta = 200. , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the void size function
RV | radius |
redshift | the redshift |
model_mf | author(s) who proposed the mass function; valid authors are: PS (Press & Schechter), ST (Sheth & Tormen), Jenkins (Jenkins et al. 2001), Warren (Warren et al. 2006), Reed, (Reed et al. 2007), Pan (Pan 2007), ShenH (halo MF by Shen et al. 2006), ShenF (filaments MF by Shen et al. 2006), ShenS (sheets MF by Shen et al. 2006), Tinker (Tinker et al. 2008), Crocce (Crocce et al. 2010), Angulo_FOF (FOF MF by Angulo et al. 2012), Angulo_Sub (SUBFIND MF by Angulo et al. 2012), Watson_FOF(FOF MF by Watson et al. 2012), Watson_SOH (MF for Spherical Overdensity Haloes by Watson et al. 2012), Manera (Manera et al. 2010), Bhattacharya (Bhattacharya et al. 2011), Courtin (Courtin et al. 2010), Peacock (by Peacock at al. 2007) |
del_v | linear density contrast defining a void |
model_sf | size function model name; valid choices for model name are SvdW (Sheth and van de Weygaert, 2004), linear and Vdn (Jennings et al., 2013) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Delta | \(\Delta\), the overdensity |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 306 of file SizeFunction.cpp.
std::vector< double > cbl::cosmology::Cosmology::size_function | ( | const std::vector< double > | RV, |
const double | redshift, | ||
const std::string | model, | ||
const double | b_eff, | ||
double | slope = 0.854 , |
||
double | offset = 0.420 , |
||
const double | deltav_NL = -0.795 , |
||
const double | del_c = 1.69 , |
||
const std::string | method_Pk = "EisensteinHu" , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
the void size function
RV | vector of radii |
redshift | the redshift |
model | size function model name; valid choices for model name are SvdW (Sheth and van de Weygaert, 2004), linear and Vdn (Jennings et al., 2013) |
b_eff | the effective bias of the sample |
slope | first coefficent to convert the effective bias (default value set to \(0.854\)) |
offset | second coefficent to convert the effective bias (default value set to \(0.420\)) |
deltav_NL | the non linear density contrast: \(\rho_v/\rho_m\) (default value set to \(-0.795\)) |
del_c | critical value of the linear density field (default value set to \(1.06\)) |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
Definition at line 144 of file SizeFunction.cpp.
double cbl::cosmology::Cosmology::skewness | ( | const double | mass, |
const std::string | method_Pk, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) |
the skewness
mass | halo mass |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | the output_root parameter of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::Sn_PT | ( | const int | nn, |
const double | RR, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const std::string | interpType = "Linear" , |
||
const double | k_max = 100. , |
||
const std::string | input_file = par::defaultString , |
||
const bool | is_parameter_file = true |
||
) | const |
the hierarchical moments Sn
this function provides the hierarchical moments Sn given by the perturbation theory (see e.g. Juszkiewicz et al. 1993, Bernardeau 1994, Wolk 2013)
nn | order of the moment |
RR | comoving separation |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
interpType | method to interpolate the power spectrum |
k_max | maximum wave vector module up to which the power spectrum is computed |
input_file | either the parameter file or the power spectrum file; if a parameter file is provided, i.e. input_file!=NULL and is_parameter_file=true, it will be used to compute the power spectrum; if a power spectrum file is provided, i.e. input_file!=NULL and is_parameter_file=false, then the provided power spectrum will be used directly; in both cases σ2(M) is computed by integrating the computed/provided power spectrum ignoring the cosmological parameters of the object |
is_parameter_file | true \(\rightarrow\) the input_file is a parameter file, used to compute the power spectrum with the method specified by method_Pk; false \(\rightarrow\) the input_file is a file containing the power spectrum |
double cbl::cosmology::Cosmology::sound_speed | ( | const double | redshift, |
const double | T_CMB = 2.7255 |
||
) | const |
double cbl::cosmology::Cosmology::square_bulk_flow | ( | const double | rr, |
const double | k_int_min, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the mean square bulk flow
rr | comoving radius |
k_int_min | minimum wave vector module up to which the integral is computed |
method_Pk | method used to compute the power spectrum and σ(mass) (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 45 of file Velocities.cpp.
double cbl::cosmology::Cosmology::square_bulk_flow_Table | ( | const double | rr, |
const double | k_int_min, | ||
const std::vector< double > | lgkk, | ||
const std::vector< double > | lgPk, | ||
const double | redshift | ||
) | const |
the mean square bulk flow
rr | comoving radius |
k_int_min | minimum wave vector module up to which the integral is computed |
lgkk | vector of log(k) |
lgPk | vector of log(P(k)) |
redshift | the redshift |
Definition at line 82 of file Velocities.cpp.
double cbl::cosmology::Cosmology::square_velocity_dispersion | ( | const double | rr, |
const double | k_int_min, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the mean square velocity dispersion
rr | comoving radius |
k_int_min | minimum wave vector module up to which the integral is computed |
method_Pk | method used to compute the power spectrum and σ(mass) (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 98 of file Velocities.cpp.
|
inline |
get the private member Cosmology::m_t_H
Definition at line 1198 of file Cosmology.h.
void cbl::cosmology::Cosmology::Table_PkCodes | ( | const std::string | code, |
const bool | NL, | ||
std::vector< double > & | lgkk, | ||
std::vector< double > & | lgPk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_max = 100. , |
||
const std::string | file_par = par::defaultString |
||
) | const |
write or read the table where the dark matter power spectrum is stored
[in] | code | method used to compute the power spectrum; valid codes are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465] |
[in] | NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
[out] | lgkk | vector of log(k) |
[out] | lgPk | vector of log(P(k)) |
[in] | redshift | redshift |
[in] | store_output | if true the output files created are stored; if false the output files created are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
[in] | file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
void cbl::cosmology::Cosmology::Table_PkCodes | ( | const std::string | code, |
const bool | NL, | ||
std::vector< std::vector< double >> & | lgkk, | ||
std::vector< std::vector< double >> & | lgPk, | ||
const std::vector< double > | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_max = 100. , |
||
const std::string | file_par = par::defaultString |
||
) | const |
write or read the table where the dark matter power spectrum is stored
[in] | code | method used to compute the power spectrum; valid codes are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465] |
[in] | NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
[out] | lgkk | vector of vectors containing the log(k) at each redshift |
[out] | lgPk | vector of vectors containing the log(P(k)) at each redshift |
[in] | redshift | vector of redshifts |
[in] | store_output | if true the output files created are stored; if false the output files created are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
[in] | file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
void cbl::cosmology::Cosmology::Table_XiCodes | ( | const std::string | code, |
const bool | NL, | ||
std::vector< double > & | rr, | ||
std::vector< double > & | xi, | ||
const double | redshift, | ||
const bool | store_output, | ||
const std::string | output_root, | ||
const double | k_max, | ||
std::string | file_par | ||
) | const |
write or read the table where the dark matter two-point correlation function is stored
[in] | code | method used to compute the power spectrum; valid codes are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
[in] | NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
[out] | rr | vector of comoving separations |
[out] | xi | vector of the binned values of ξ(r) |
[in] | redshift | redshift |
[in] | store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
[in] | output_root | output_root of the parameter file used to compute the power spectrum; it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
[in] | k_max | maximum wave vector module up to which the power spectrum is computed |
[in] | file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
|
inline |
get the private member Cosmology::m_tau
Definition at line 1281 of file Cosmology.h.
|
inline |
get the private member Cosmology::m_type_NG
Definition at line 1273 of file Cosmology.h.
double cbl::cosmology::Cosmology::unevolved_mass_function | ( | const double | mass_accr | ) | const |
the unevolved mass function
mass_accr | mass accreted |
Definition at line 579 of file MassFunction.cpp.
|
inline |
get the private member Cosmology::m_unit
Definition at line 1338 of file Cosmology.h.
double cbl::cosmology::Cosmology::value | ( | const CosmologicalParameter | parameter | ) | const |
get the private member specified by the enum CosmologicalParameter
parameter | the cosmological parameter |
Definition at line 319 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Volume | ( | const double | z1, |
const double | z2, | ||
const double | Area | ||
) | const |
comoving volume for a given redshift range and sky area
this function provides an approximated expression of the comoving volume valid only for a ΛCDM model
z1 | minimum redshift |
z2 | maximum redshift |
Area | sky area [square degrees] |
Definition at line 1183 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Volume | ( | const double | z1, |
const double | z2, | ||
const double | RA_min, | ||
const double | RA_max, | ||
const double | Dec_min, | ||
const double | Dec_max | ||
) | const |
comoving volume for a given redshift range and R.A.-Dec limits
this function provides an approximated expression of the comoving volume valid only for a ΛCDM model
z1 | minimum redshift |
z2 | maximum redshift |
RA_min | minimum Right ascension [radians] |
RA_max | maximum Right ascension [radians] |
Dec_min | minimum Declination [radians] |
Dec_max | minimum Declination [radians] |
Definition at line 1194 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::Volume | ( | const double | zz | ) | const |
total comoving volume from z=0 to z
from Hogg 2000, Eq. 29
zz | redshift |
Definition at line 1205 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_w0
Definition at line 1242 of file Cosmology.h.
double cbl::cosmology::Cosmology::w_CPL | ( | const double | redshift = 0. | ) | const |
the DE equation of state in the CPL parameterisation, as a function of redshift
redshift | the redshift |
Definition at line 535 of file Cosmology.cpp.
|
inline |
get the private member Cosmology::m_wa
Definition at line 1250 of file Cosmology.h.
double cbl::cosmology::Cosmology::wf | ( | const double | mm, |
const double | redshift, | ||
const double | ff, | ||
const double | zf, | ||
const std::string | method_SS, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" |
||
) | const |
rescaled variable w as in Lacey and Coles 1993
this functions provides the conditional variable w=[δc(zf) - δc(z)] / √ [s(fm)-s(m)] whereδc(z) = δc0(z)/D+(z)
mm | halo mass |
redshift | the redshift |
ff | assembled fraction |
zf | redshift at which the mass is accreted |
method_SS | method used to compute the power spectrum and σ(mass); valid method_SS are: CAMB [http://camb.info/], CLASS [http://class-code.net/], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Definition at line 153 of file MassGrowth.cpp.
double cbl::cosmology::Cosmology::wp_DM | ( | const double | rp, |
const std::string | method_Pk, | ||
const bool | NL, | ||
const double | redshift, | ||
const double | pimax, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | r_min = 1.e-3 , |
||
const double | r_max = 350. , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 0. , |
||
const bool | GSL = false , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = cbl::par::defaultString |
||
) |
the dark matter projected correlation function
this function provides the dark matter projected correlation functions, obtained by Fourier transforming the matter power spectrum
rp | rp: projected separation |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
NL | false \(\rightarrow\) linear DM two-point correlation function; true \(\rightarrow\) non-linear DM two-point correlation function |
redshift | the redshift |
pimax | the upper limit of the line-of-sight integration |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
r_min | minimum separation up to which the correlation function is computed |
r_max | maximum separation up to which the correlation function is computed |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
aa | parameter a of Eq. 24 of Anderson et al. 2012 |
GSL | false \(\rightarrow\) FFTlog is used; true \(\rightarrow\) the GSL libraries are used |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::wtheta_DM | ( | const double | theta, |
const std::vector< double > | kk, | ||
const std::vector< double > | Pk, | ||
const std::vector< double > | zz, | ||
const std::vector< double > | nz, | ||
const std::vector< double > | phiz, | ||
const std::string | interpolationType = "Spline" , |
||
const CoordinateUnits | coordUnits = CoordinateUnits::_degrees_ , |
||
const bool | GSL = false , |
||
const double | redshift_Pk = 0 |
||
) |
the dark matter angular two-point correlation function
this function provides the dark matter angular correlation function, obtained by integrating the 2PCF using Limber approximation (see Sawangwit et al. 2011, eqs. 14,15):
\[ w(\theta) = \frac{\int_{z_{min}}^{z_{max}} \mathrm{d}z_1 \int_{z_{min}}^{z_{max}} \mathrm{d}z_2 f(z_1) f(z_2) \xi(r,z)}Â {Â \left\{ \int_{z_{min}}^{z_{max}} f(z) dz \right\}^2} \]
where \( r = \sqrt{\chi(z_1)^2+\chi(z_2)^2 -2\chi(z_1)\chi(z_2)\cos(\theta)} \), \(\chi\) is the comoving distance and \(z = (z_1+z_2)/2 \).
The function \(f(z)\) is the number of objects per unitar volume:
\[ f(z) = \frac{\mathrm{d}V}{\mathrm{d}z \mathrm{d\Omega}} n(z) \phi(z) \]
where \(\frac{\mathrm{d}V}{\mathrm{d}z \mathrm{d\Omega}}\) is the comoving volume element, \(n(z)\) is the comoving number density and \(\phi(z)\) is the selection function
theta | the angular separation |
kk | the wave vector module |
Pk | linear power spectrum |
zz | the redshift range |
nz | the comoving number density |
phiz | the selection function |
interpolationType | the method in interpolation |
coordUnits | the angular separation units |
GSL | false \(\rightarrow\) FFTlog is used; true \(\rightarrow\) the GSL libraries are used |
redshift_Pk | the redshift of the input power spectrum |
double cbl::cosmology::Cosmology::wtheta_DM | ( | const double | theta, |
const std::vector< double > | zz, | ||
const std::vector< double > | phiz, | ||
const std::string | interpolationMethod, | ||
const CoordinateUnits | coordUnits = CoordinateUnits::_degrees_ , |
||
const bool | GSL = false , |
||
const std::string | method_Pk = "CAMB" , |
||
const bool | NL = false , |
||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 1.e-4 , |
||
const double | k_max = 100 , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the dark matter angular two-point correlation function
this function provides the dark matter angular correlation function, obtained by integrating the 2PCF using Limber approximation (see Salazar et al. 2014, eqs. 5-8):
\[ w(\theta) = \int_{z_{min}}^{z_{max}} \mathrm{d}z_1 \int_{z_{min}}^{z_{max}} \mathrm{d}z_2 \phi(z_1) \phi(z_2) \xi(r,z) \]
where \( r = \sqrt{\chi(z_1)^2+\chi(z_2)^2 -2\chi(z_1)\chi(z_2)\cos(\theta)} \), \(\chi\) is the comoving distance and \(z = (z_1+z_2)/2 \)
theta | the angular separation |
zz | the redshift range |
phiz | the number density |
interpolationMethod | the method in interpolation |
coordUnits | the angular separation units |
GSL | false \(\rightarrow\) FFTlog is used; true \(\rightarrow\) the GSL libraries are used |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalize the power spectrum; 1 \(\rightarrow\) normalize the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::xi0_Kaiser | ( | const double | rad, |
const double | f_sigma8, | ||
const double | bias_sigma8, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | xiType = 0 , |
||
const double | k_star = -1. , |
||
const bool | NL = false , |
||
const int | norm = -1 , |
||
const double | r_min = 0.1 , |
||
const double | r_max = 150. , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 0. , |
||
const bool | GSL = false , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
monopole of the redshift-space two-point correlation function in the Kaiser limit
this function provides the monopole of the two-point correlation function of biased tracers, predicted at large scales in the Kaiser limit:
\[ \xi_0(s) = \xi_{DM}(s)\left(\frac{b\sigma_8}{\sigma_8}\right)^2 \left[ 1 + \frac{2}{3}\frac{f\sigma_8}{b\sigma_8} + \frac{1}{5}\left(\frac{f\sigma_8}{b\sigma_8}\right)^2 \right] \]
The Kaiser factor \( \left[ 1 + \frac{2}{3}\frac{f\sigma_8}{b\sigma_8} + \frac{1}{5}\left(\frac{f\sigma_8}{b\sigma_8}\right)^2 \right] \) is computed by cbl::xi_ratio
rad | comoving separation |
f_sigma8 | f*σ8 |
bias_sigma8 | b*σ8 |
method_Pk | method used to compute the power spectrum and σ(mass) (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
xiType | 0 \(\rightarrow\) standard; 1 \(\rightarrow\) Chuang & Wang model |
k_star | k* of the Chuang & Wang model |
NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
r_min | minimum separation up to which the correlation function is computed |
r_max | maximum separation up to which the correlation function is computed |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
aa | parameter a of Eq. 24 of Anderson et al. 2012 |
GSL | true \(\rightarrow\) the GSL libraries are used |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 46 of file PkXizSpace.cpp.
std::vector< double > cbl::cosmology::Cosmology::xi0_Kaiser | ( | const std::vector< double > | rad, |
const double | bias, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | NL = false , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
monopole of the redshift-space two-point correlation function in the Kaiser limit
this function provides the monopole of the two-point correlation function of biased tracers, predicted at large scales in the Kaiser limit:
\[ \xi_0(s) = \xi_{DM}(s)b^2\left[1 + \frac{2\beta}{3} + \frac{\beta^2}{5}\right] \]
where \( \beta=\beta(z)=\frac{f(z)}{b(z)} \). The Kaiser factor \( \left[1 + \frac{2\beta}{3} + \frac{\beta^2}{5}\right] \) is computed by cbl::xi_ratio, while the linear growth rate \( f(z) \) is computed by cbl::cosmology::Cosmology::linear_growth_rate
rad | comoving separations |
bias | b |
method_Pk | method used to compute the power spectrum and σ(mass) (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
NL | false \(\rightarrow\) linear power spectrum; true \(\rightarrow\) non-linear power spectrum |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 62 of file PkXizSpace.cpp.
double cbl::cosmology::Cosmology::xi2D_CW | ( | const double | rp, |
const double | pi, | ||
const double | beta, | ||
const double | bias_lin, | ||
const double | bA, | ||
const double | sigmav0, | ||
const double | cmu, | ||
const double | cs1, | ||
const double | cs2, | ||
const double | redshift, | ||
std::vector< double > | rr1, | ||
std::vector< double > | Xi1, | ||
std::vector< double > | rr2, | ||
std::vector< double > | Xi2, | ||
std::vector< double > & | Xi1_, | ||
std::vector< double > & | Xi1__, | ||
std::vector< double > & | Xi2_, | ||
std::vector< double > & | Xi2__, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | BAO = 1 , |
||
const bool | xiType = 0 , |
||
const double | k_star = -1 , |
||
const bool | xiNL = 0 , |
||
const double | r_min = 0.1 , |
||
const double | r_max = 150. , |
||
const double | v_min = -3000. , |
||
const double | v_max = 3000. , |
||
const int | step_v = 500 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | x_min = -3000. , |
||
const double | x_max = 3000. , |
||
const int | step_x = 500 , |
||
const double | aa = 0. , |
||
const bool | GSL = false , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
2D correlation function, ξ(rp,π), predicted by the Chuang & Wang model
rp | rp: the comoving separation perpendicular to the line-of-sight |
pi | π: the comoving separation parallel to the line-of-sight |
beta | β=f/b, where f is the linear growth rate and b is the bias |
bias_lin | linear bias |
bA | ba non-linear bias parameter |
sigmav0 | σ0(v): parameter of the velocity distribution function, f(v) |
cmu | parameter of the velocity distribution function, f(v) |
cs1 | parameter of the velocity distribution function, f(v) |
cs2 | parameter of the velocity distribution function, f(v) |
redshift | the redshift |
rr1 | vector of r, the module of the comoving separation |
Xi1 | vector of ξ(r), the two-point correlation function of dark matter |
rr2 | vector of r, the module of the comoving separation |
Xi2 | vector of ξ(r), the two-point correlation function of dark matter |
Xi1_ | vector of barred ξ(r), |
Xi1__ | vector of double-barred ξ(r) |
Xi2_ | vector of barred ξ(r), |
Xi2__ | vector of double-barred ξ(r) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
BAO | 0 \(\rightarrow\) no BAO convolution; 1 \(\rightarrow\) BAO convolution |
xiType | 0 \(\rightarrow\) standard; 1 \(\rightarrow\) Chuang & Wang model |
k_star | k* of the Chuang & Wang model |
xiNL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
r_min | minimum separation up to which the correlation function is computed |
r_max | maximum separation up to which the correlation function is computed |
v_min | minimum velocity used in the convolution of the correlation function |
v_max | maximum velocity used in the convolution of the correlation function |
step_v | number of steps used in the convolution of the correlation function |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
x_min | minimum velocity used in the integral of the Chuang & Wang model |
x_max | maximum velocity used in the integral of the Chuang & Wang model |
step_x | number of steps in the integral of the Chuang & Wang model |
aa | parameter a of Eq. 24 of Anderson et al. 2012 |
GSL | true \(\rightarrow\) the GSL libraries are used |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 187 of file PkXizSpace.cpp.
double cbl::cosmology::Cosmology::xi2D_dispersionModel | ( | const double | rp, |
const double | pi, | ||
const double | f_sigma8, | ||
const double | bias_sigma8, | ||
const double | sigmav, | ||
const std::string | method_Pk, | ||
const double | redshift, | ||
const int | FV, | ||
const bool | NL, | ||
std::vector< double > | rr, | ||
std::vector< double > & | Xi, | ||
std::vector< double > & | Xi_, | ||
std::vector< double > & | Xi__, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | index = -1 , |
||
const bool | bias_nl = 0 , |
||
const double | bA = -1. , |
||
const bool | xiType = 0 , |
||
const double | k_star = -1. , |
||
const bool | xiNL = 0 , |
||
const double | v_min = -3000. , |
||
const double | v_max = 3000. , |
||
const int | step_v = 500 , |
||
const int | norm = -1 , |
||
const double | r_min = 0.1 , |
||
const double | r_max = 150. , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 0. , |
||
const bool | GSL = false , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
2D correlation function, ξ(rp,π), predicted by the dispersion model
rp | rp: the comoving separation perpendicular to the line-of-sight |
pi | π: the comoving separation parallel to the line-of-sight |
f_sigma8 | f*σ8 |
bias_sigma8 | b*σ8 |
sigmav | σ12: pairwise peculiar velocity dispersion |
method_Pk | method used to compute the power spectrum and σ(mass) (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
redshift | the redshift |
FV | 0 \(\rightarrow\) exponential form for f(v); 1 \(\rightarrow\) Gaussian form for f(v); where f(v) is the velocity distribution function |
NL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
rr | vector of r, the module of the comoving separation |
Xi | vector of ξ(r), the two-point correlation function of dark matter |
Xi_ | vector of barred ξ(r), |
Xi__ | vector of double-barred ξ(r) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
index | internal parameter used when minimizing the χ2 |
bias_nl | 0 \(\rightarrow\) linear bias; 1 \(\rightarrow\) non-linear bias |
bA | ba non-linear bias parameter |
xiType | 0 \(\rightarrow\) standard; 1 \(\rightarrow\) Chuang & Wang model |
k_star | k* of the Chuang & Wang model |
xiNL | 0 \(\rightarrow\) linear power spectrum; 1 \(\rightarrow\) non-linear power spectrum |
v_min | minimum velocity used in the convolution of the correlation function |
v_max | maximum velocity used in the convolution of the correlation function |
step_v | number of steps used in the convolution of the correlation function |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
r_min | minimum separation up to which the correlation function is computed |
r_max | maximum separation up to which the correlation function is computed |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
aa | parameter a of Eq. 24 of Anderson et al. 2012 |
GSL | true \(\rightarrow\) the GSL libraries are used |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 81 of file PkXizSpace.cpp.
double cbl::cosmology::Cosmology::xi_matter | ( | const double | rr, |
const std::string | method_Pk, | ||
const bool | NL, | ||
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const int | norm = -1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 0. , |
||
const bool | GSL = false , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the dark matter two-point correlation function
this function provides the dark matter correlation function, obtained by Fourier transforming the matter power spectrum
rr | the module of the comoving separation |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
NL | false \(\rightarrow\) linear DM two-point correlation function; true \(\rightarrow\) non-linear DM two-point correlation function |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
aa | parameter a of Eq. 24 of Anderson et al. 2012 |
GSL | false \(\rightarrow\) FFTlog is used; true \(\rightarrow\) the GSL libraries are used |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, const ignoring the cosmological parameters of the object |
double cbl::cosmology::Cosmology::xi_matter_DeWiggle | ( | const double | rr, |
const double | redshift, | ||
const double | sigma_NL, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | norm = 1 , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | aa = 1. , |
||
const double | prec = 1.e-2 |
||
) |
the dark matter two-point correlation function, de-wiggled (see e.g. Anderson et al 2014)
this function provides the dark matter correlation function, obtained by Fourier transforming the De-Wiggled matter power spectrum
rr | the module of the comoving separation |
redshift | the redshift |
sigma_NL | the non linear BAO damping |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
norm | 0 \(\rightarrow\) don't normalise the power spectrum; 1 \(\rightarrow\) normalise the power spectrum; -1 \(\rightarrow\) normalise only if sigma8 is set |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
aa | parameter a of Eq. 24 of Anderson et al. 2012 |
prec | accuracy of the integration |
void cbl::cosmology::Cosmology::xi_r_n | ( | std::vector< double > & | xi_n, |
const std::vector< double > | rr, | ||
const int | nn, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk | ||
) |
compute the power spectrum integral transform
this function computes the power spectrum integral transform:
\[ \xi^{[n]} (r) = \int \frac{k^2\mathrm{d}k}{2\pi^2} P(k) j_n(kr). \]
where n is the order of the transform.
xi_n | the power spectrum transform \(\xi^{[n]} (r)\) |
rr | vector of scales |
nn | the order of the transform |
kk | vector of wavevector modules |
Pk | dark matter power spectrum |
void cbl::cosmology::Cosmology::xi_r_n_pm | ( | std::vector< double > & | xi_n_p, |
std::vector< double > & | xi_n_m, | ||
const std::vector< double > | rr, | ||
const int | nn, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk | ||
) |
compute the power spectrum integral transform
this function computes the power spectrum integral transform:
\[ \xi^{[n\pm]} (r) = \int \frac{k^2\mathrm{d}k}{2\pi^2} k^{\pm1} P(k) j_n(kr) \]
where n is the order of the transform.
xi_n_p | the power spectrum transform \(\xi^{[n+]} (r)\) |
xi_n_m | the power spectrum transform \(\xi^{[n-]} (r)\) |
rr | vector of scales |
nn | the order of the transform |
kk | vector of wavevector modules |
Pk | dark matter power spectrum |
double cbl::cosmology::Cosmology::xi_star | ( | const double | rr, |
const double | redshift, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_star = -1. , |
||
const double | k_min = 0.001 , |
||
const double | k_max = 100. , |
||
const double | prec = 1.e-2 , |
||
const std::string | file_par = par::defaultString |
||
) |
the function ξ* of the Chuang & Wang 2012 model
see Chuang & Wang 2012, 1209.0210
rr | comoving separation |
redshift | the redshift |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_star | k* of the Chuang & Wang model |
k_min | minimum wave vector module up to which the power spectrum is computed in order to estimate the power spectrum normalisation; this parameter is used only if either norm=1, or norm=-1 and sigma8 is set |
k_max | maximum wave vector module up to which the power spectrum is computed |
prec | accuracy of the integration |
file_par | name of the parameter file; if a parameter file is provided (i.e. file_par!=NULL), it will be used, ignoring the cosmological parameters of the object |
Definition at line 122 of file PkXizSpace.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::XiMonopole_covariance | ( | const int | nbins, |
const double | rMin, | ||
const double | rMax, | ||
const double | nn, | ||
const double | Volume, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk0, | ||
const int | IntegrationMethod = 1 |
||
) |
the covariance matrix of the first three non-null multipoles of the two-point correlation function
nbins | the number of bins of the two-point correlation function multipoles |
rMin | the minimum scale |
rMax | the maximum scale |
nn | order of the moment |
Volume | the volume |
kk | vector containing the wave vector modules |
Pk0 | vector containing the monopole of the power spectrum |
IntegrationMethod | the integration method |
std::vector< std::vector< double > > cbl::cosmology::Cosmology::XiMultipoles | ( | const int | nbins, |
const double | rMin, | ||
const double | rMax, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk0, | ||
const std::vector< double > | Pk2, | ||
const std::vector< double > | Pk4, | ||
const int | IntegrationMethod = 1 |
||
) |
the first three non-null multipoles of the two-point correlation function
nbins | the number of bins of the two-point correlation function multipoles |
rMin | the minimum scale |
rMax | the maximum scale |
kk | vector containing the wave vector modules |
Pk0 | vector containing the monopole of the power spectrum |
Pk2 | vector containing the quadrupole of the power spectrum |
Pk4 | vector containing the hexadecapole of the power spectrum |
IntegrationMethod | the integration method |
std::vector< std::vector< double > > cbl::cosmology::Cosmology::XiMultipoles_covariance | ( | const int | nbins, |
const double | rMin, | ||
const double | rMax, | ||
const double | nn, | ||
const double | Volume, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk0, | ||
const std::vector< double > | Pk2, | ||
const std::vector< double > | Pk4, | ||
const int | IntegrationMethod = 1 |
||
) |
the covariance matrix of the first three non-null multipole moments of the two-point correlation function
nbins | the number of bins of the two-point correlation function multipoles |
rMin | the minimum scale |
rMax | the maximum scale |
nn | order of the moment |
Volume | the volume |
kk | vector containing the wave vector modules |
Pk0 | vector containing the monopole of the power spectrum |
Pk2 | vector containing the quadrupole of the power spectrum |
Pk4 | vector containing the hexadecapole of the power spectrum |
IntegrationMethod | the integration method |
double cbl::cosmology::Cosmology::xis_gBAO | ( | const double | rp, |
const double | pi, | ||
const double | f_sigma8, | ||
const double | bias_sigma8, | ||
const double | redshift, | ||
std::vector< double > | rr, | ||
std::vector< double > | Xi, | ||
std::vector< double > & | Xi_, | ||
std::vector< double > & | Xi__, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const double | k_star = -1. , |
||
const double | x_min = -3000. , |
||
const double | x_max = 3000. , |
||
const int | step_x = 500 |
||
) |
the function ξg,BAO(s) of the Chuang & Wang 2012 model
see Chuang & Wang 2012, 1209.0210
rp | rp: the comoving separation perpendicular to the line-of-sight |
pi | π: the comoving separation parallel to the line-of-sight |
f_sigma8 | f*σ8 |
bias_sigma8 | b*σ8 |
redshift | the redshift |
rr | vector of r, the module of the comoving separation |
Xi | vector of ξ(r), the two-point correlation function of dark matter |
Xi_ | vector of barred ξ(r), |
Xi__ | vector of double-barred ξ(r) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
k_star | k* of the Chuang & Wang model |
x_min | minimum velocity used in the integral of the Chuang & Wang model |
x_max | maximum velocity used in the integral of the Chuang & Wang model |
step_x | number of steps in the integral of the Chuang & Wang model |
Definition at line 156 of file PkXizSpace.cpp.
double cbl::cosmology::Cosmology::xisnl_gnw | ( | const double | rp, |
const double | pi, | ||
const double | f_sigma8, | ||
const double | bias_sigma8, | ||
const double | bA, | ||
const double | redshift, | ||
std::vector< double > | rr, | ||
std::vector< double > | Xi, | ||
std::vector< double > & | Xi_, | ||
std::vector< double > & | Xi__, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" |
||
) |
the function ξg,nw(s) of the Chuang & Wang 2012 model
see Chuang & Wang 2012, 1209.0210
rp | rp: the comoving separation perpendicular to the line-of-sight |
pi | π: the comoving separation parallel to the line-of-sight |
f_sigma8 | f*σ8 |
bias_sigma8 | b*σ8 |
bA | ba non-linear bias parameter |
redshift | the redshift |
rr | vector of r, the module of the comoving separation |
Xi | vector of ξ(r), the two-point correlation function of dark matter |
Xi_ | vector of barred ξ(r), |
Xi__ | vector of double-barred ξ(r) |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
Definition at line 145 of file PkXizSpace.cpp.
double cbl::cosmology::Cosmology::ys | ( | const double | redshift, |
const std::string | method_Pk, | ||
const double | T_CMB = par::TCMB |
||
) | const |
the fiducial cosmology independent ratio rs/DV, valid choices for method_Pk are: EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html], CAMB [http://camb.info/]
both rs and DV are in Mpc
redshift | the redshift |
method_Pk | method used to compute the sound horizon (i.e. the Boltzmann solver) |
T_CMB | CMB temperature |
double cbl::cosmology::Cosmology::z_acc | ( | ) | const |
redshift at which the Universe begins to accelerate
see e.g. de Araujo 2005
Definition at line 994 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::z_decoupling | ( | ) | const |
double cbl::cosmology::Cosmology::z_drag | ( | ) | const |
double cbl::cosmology::Cosmology::z_eq | ( | ) | const |
redshift of matter-dark energy equality
see e.g. de Araujo 2005
Definition at line 1008 of file Cosmology.cpp.
double cbl::cosmology::Cosmology::z_eq_rad | ( | const double | T_CMB = 2.7255 | ) | const |
redshift of matter-radiation equality
T_CMB | the temperature of the CMB |
Definition at line 1018 of file Cosmology.cpp.
std::vector< std::vector< double > > cbl::cosmology::Cosmology::zeta_covariance | ( | const double | Volume, |
const double | nObjects, | ||
const std::vector< double > | theta, | ||
const double | r1, | ||
const double | r2, | ||
const double | deltaR, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk, | ||
const int | norders = 10 , |
||
const double | prec = 1.e-3 , |
||
const bool | method = false , |
||
const int | nExtractions = 10000 , |
||
const std::vector< double > | mean = {} , |
||
const int | seed = 543 |
||
) |
the dark matter three-point correlation function covariance model
this function computes the dark matter three-point correlation function covariance model, by Slepian et al. 2015, as a function of \(\theta = r_1 \cdot r_2\):
\[ C(r_1, r_2, \vec{r_1}\cdot\vec{r_2} \equiv \cos(\theta) = \sum_{l=0}^{l=max_l} \sum_{l^'=0}^{l^'=max_l} C_{l, l^'}(r_1, r_2) P_l(\cos(\theta) P_{l^'}(\cos(theta) \]
where \(C_{l, l^'}(r_1, r_2)\) is computed by cbl::cosmology::Cosmology::zeta_multipoles_covariance
Volume | the volume |
nObjects | the number of objects |
theta | vector of angles at which the covariance is computed |
r1 | the scale \(r_1\) |
r2 | the scale \(r_2\) |
deltaR | the bin size, if non-positive, no bin average is computed |
kk | vector of the wave vector modules |
Pk | the pdark matter ower spectrum |
norders | the maximum number of orders of multipoles of the three point correlation function expansion |
prec | the integral precision |
method | false \(\rightarrow\) apply method 1; true \(\rightarrow\) apply method 2 |
nExtractions | the number of mock extraction from zeta multipoles coefficient covariance matrix |
mean | vector containing the mean values |
seed | random number generator seed |
std::vector< double > cbl::cosmology::Cosmology::zeta_DM | ( | const double | r1, |
const double | r2, | ||
const std::vector< double > | theta, | ||
const std::string | model, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the dark matter three-point correlation function
this function computes the dark matter three-point correlation function with either the Slepian et al 2015 or the Barriga & Gatzagnaga 2002 model
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | vector containing angles between r1 and r2, in radians |
model | the model to compute the three-point correlation function, can be "Slepian" or "BarrigaGatzanaga" |
kk | vector of the wave vector modules |
Pk_matter | the dark matter power spectrum |
double cbl::cosmology::Cosmology::zeta_DM_BarrigaGatzanaga | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
std::vector< double > & | rr, | ||
std::vector< double > & | xi_matter, | ||
std::vector< double > & | Phi, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the dark matter three-point correlation function model by Barriga & Gatzanaga et al. 2002
this functions computes the dark matter three-point correlation function model by Barriga & Gatzanaga et al 2002:
\[ f(r_1, r_2) = \frac{10}{7}\xi(r_1) \xi(r_2)+\frac{4}{7} \left\{ -3 \frac{\Phi^\prime(r_1) \Phi^\prime(r_2)}{r_1 r_2} -\frac{\xi(r1) \Phi^\prime(r_2)}{r_2}-\frac{\xi(r2) \Phi^\prime(r_1)}{r_1} +\mu^2\left[ \xi(r_1)+3\frac{\Phi^\prime(r_1)}{r1}\right]\left[ \xi(r_2)+3\frac{\Phi^\prime(r_2)}{r_3}\right] \right\} -\mu\left[ \xi^\prime(r_1)\Phi^\prime(r_2) + \xi^\prime(r_2)\Phi^\prime(r_1)\right] + \mathrm{permutations} \]
where the prime indicates the derivative with respect to \(r\), and \(\xi(r), \Phi(r)\) are the integrals of the power spectrum computed by cbl::cosmology::Cosmology::integrals_zeta_BarrigaGatzanaga.
[in] | r1 | the first side of the triangle |
[in] | r2 | the second side of the triangle |
[in] | theta | the angle between r1 and r2 |
[out] | rr | vector or scales |
[out] | xi_matter | vector containing the dark matter two-point correlation function |
[out] | Phi | vector containing \( \Phi(r)\) |
[in] | kk | vector of the wave vector modules |
[in] | Pk_matter | the dark matter power spectrum |
std::vector< double > cbl::cosmology::Cosmology::zeta_DM_eq | ( | const std::vector< double > | rr, |
const std::string | model, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the dark matter equilateral three-point correlation function
this function computes the dark matter equilateral three-point correlation function with either the Slepian et al 2015 or the Barriga & Gatzagnaga 2002 model
rr | vector of sides |
model | the model to compute the three-point correlation function, can be "Slepian" or "BarrigaGatzanaga" |
kk | vector of the wave vector modules |
Pk_matter | the dark matter power spectrum |
double cbl::cosmology::Cosmology::zeta_DM_Slepian | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
std::vector< double > & | rr, | ||
std::vector< double > & | xi_matter, | ||
std::vector< double > & | xi_matter_m1, | ||
std::vector< double > & | xi_matter_p1, | ||
std::vector< double > & | xi_matter_2, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter, | ||
const int | norders = 9 , |
||
const double | prec = 1.e-3 |
||
) | const |
the dark matter three-point correlation function model by Slepian et al. 2015
this function computes \(\zeta_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2})\), as described in Slepian et al. 2015:
\[ \zeta_{DM} (r_1, r_2, \hat{r_1} \cdot \hat{r_2}) = \sum_l \zeta_l(r_1, r_2) P_l(\hat{r_1} \cdot \hat{r_2}) .\]
The coefficients of the expansion are computed by cbl::cosmology::Cosmology::zeta_expansion_Slepian
[in] | r1 | the first side of the triangle |
[in] | r2 | the second side of the triangle |
[in] | theta | the angle between r1 and r2 |
[out] | rr | vector or scales |
[out] | xi_matter | vector containing the dark matter two-point correlation function |
[out] | xi_matter_m1 | vector containing \(\xi^{[1-]}_{DM}(r)\) |
[out] | xi_matter_p1 | vector containing \(\xi^{[1+]}_{DM}(r)\) |
[out] | xi_matter_2 | vector containing \(\xi^{[2]}_{DM}(r)\) |
[in] | kk | vector of the wave vector modules |
[in] | Pk_matter | the dark matter power spectrum |
[in] | norders | the maximum number of orders |
[in] | prec | the integral precision |
double cbl::cosmology::Cosmology::zeta_ell_0_factor | ( | const double | b1, |
const double | gamma, | ||
const double | beta | ||
) |
the multiplicative factor for \( \zeta_0 \), with local bias
This function computes the multiplicative factor for \( \zeta_0 \), with local bias:
\[ l = 0 : b_1^3 \left( \frac{34}{21} \left[ 1+\frac{4}{3}\beta+\frac{1154}{1275}\beta^2+ \frac{936}{2975}\beta^3+\frac{21}{425}\beta^4\right]+ \gamma\left[ 1+\frac{2}{3}\beta+\frac{1}{9}\beta^2 \right ] \right) \]
with \(b_1\) the linear bias, \(\gamma\) the ratio of quadratic and linear bias, \(\gamma= 2 b_2 / b_1 \) and \( \beta = f/b_1 \) with \( f \) the linear growth rate
b1 | the linear bias |
gamma | the ratio of quadratic and linear bias, \(\gamma= 2 b_2 / b_1 \), |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_0_factor_tidal | ( | const double | gamma_t, |
const double | beta | ||
) |
the multiplicative factor for \( \zeta_l, l=0 \), with non-local bias
This function computes the multiplicative factor for \( \zeta_0 \), with non-local bias:
\[ l=0: \frac{16 \beta^2 \gamma_t} {675} \]
with \(\gamma_t\ = b_t/b_1\) the ratio between the tidal and the linear bias and \( \beta = f/b_1 \) with \( f \) the linear growth rate
gamma_t | the ratio between the tidal and the linear bias |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_1_factor | ( | const double | b1, |
const double | beta | ||
) |
the multiplicative factor for \( \zeta_1 \), with local bias
This function computes the multiplicative factor for \( \zeta_1 \), with local bias:
\[ l = 1 : -b_1^3 \left[ 1+\frac{4}{3}\beta+\frac{82}{75}\beta^2+\frac{12}{25}\beta^3+\frac{3}{35}\beta^5 \right] \]
with \(b_1\) the linear bias and \( \beta = f/b_1 \) with \( f \) the linear growth rate
b1 | the linear bias |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_2_factor | ( | const double | b1, |
const double | gamma, | ||
const double | beta | ||
) |
the multiplicative factor for \( \zeta_2 \), with local bias
This function computes the multiplicative factor for \( \zeta_2 \), with local bias:
\[ l = 2 : b_1^3 \left( \frac{8}{21} \left[ 1+\frac{4}{3}\beta+\frac{52}{21}\beta^2 + \frac{81}{49}\beta^3 + \frac{12}{35}\beta^4\right]+\frac{32}{945}\gamma \beta^2 \right) \]
with \(b_1\) the linear bias, \(\gamma\) the ratio of quadratic and linear bias, \(\gamma= 2 b_2 / b_1 \) and \( \beta = f/b_1 \) with \( f \) the linear growth rate
b1 | the linear bias |
gamma | the ratio of quadratic and linear bias, \(\gamma= 2 b_2 / b_1 \), |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_2_factor_tidal | ( | const double | gamma_t, |
const double | beta | ||
) |
the multiplicative factor for \( \zeta_l, l=2 \), with non-local bias
This function computes the multiplicative factor for \( \zeta_2 \), with non-local bias:
\[ l=2: \frac{5}{2} \left(\frac{8}{15}+\frac{16\beta}{45}+\frac{344\beta^2}{4725} \right)\gamma_t \]
with \(\gamma_t\ = b_t/b_1\) the ratio between the tidal and the linear bias and \( \beta = f/b_1\) with \( f \) the linear growth rate
gamma_t | the ratio between the tidal and the linear bias |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_3_factor | ( | const double | b1, |
const double | beta | ||
) |
the multiplicative factor for \( \zeta_3 \), with local bias
This function computes the multiplicative factor for \( \zeta_3 \), with local bias:
\[ l=3: -b_1^3 \left[ \frac{8}{75}\beta^2+\frac{16}{175}\beta^3+\frac{8}{315}\beta^4 \right] \]
with \(b_1\) the linear bias and \( \beta = f/b_1 \) with \( f \) the linear growth rate
b1 | the linear bias |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_4_factor | ( | const double | b1, |
const double | beta | ||
) |
the multiplicative factor for \( \zeta_4 \), with local bias
This function computes the multiplicative factor for \( \zeta_4 \), with local bias:
\[ l=4: -b_1^3 \left[ -\frac{32}{3675}\beta^2+\frac{32}{8575}\beta^3+\frac{128}{11025}\beta^4 \right] \]
with \( b_1\) the linear bias and \( \beta = f/b_1 \) with \( f \) the linear growth rate
b1 | the linear bias |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_4_factor_tidal | ( | const double | gamma_t, |
const double | beta | ||
) |
the multiplicative factor for \( \zeta_l, l=4 \), with non-local bias
This function computes the multiplicative factor for \( \zeta_4 \), with non-local bias:
\[ l=4: \frac{32 \beta^2 \gamma_t} {525} \]
with \(\gamma_t\ = b_t/b_1\) the ratio between the tidal and the linear bias and \( \beta = f/b_1 \) with \( f \) the linear growth rate
gamma_t | the ratio between the tidal and the linear bias |
beta | the kaiser factor \( \beta = f/b_1\) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_k_factor | ( | const double | b1, |
const double | beta | ||
) |
the multiplicative factor for \( \zeta_l, l>4 \), with local bias
This function computes the multiplicative factor for \( \zeta_k, l>4 \), with local bias:
\[ l>4: b_1^3(7\beta^2+3\beta^3) \]
with \(b_1\) the linear bias and \( \beta = f/b_1 \) with \( f \) the linear growth rate
b1 | the linear bias |
beta | the kaiser factor \( \beta = f/b_1 \) with \( f \) the linear growth rate |
double cbl::cosmology::Cosmology::zeta_ell_precyclic | ( | const double | r1, |
const double | r2, | ||
const int | ell, | ||
const double | b1, | ||
const double | b2, | ||
const double | bt, | ||
const double | beta, | ||
std::vector< std::shared_ptr< glob::FuncGrid >> | interp_xi_ell, | ||
const bool | use_k, | ||
std::shared_ptr< glob::FuncGrid2D > | interp_k_ell | ||
) |
the pre-cyclic \( \zeta_l \)
This function computes the legendre multipoles coefficients of the three-point correlation function using the tree-level expansion order of the biased and redshift space density field, as derived by Slepian&Eisenstein (2017) in configuration space, based on the work presented by Scoccimarro et al (1999) for the bispectrum.
The model is computed for a specific triangle configurations and order of the expansion given the biasing parameters and \(\beta\).
Integrals and coefficients are computed by: cbl::cosmology::Cosmology::xi_r_n, cbl::cosmology::Cosmology::xi_r_n_pm, cbl::cosmology::Cosmology::k_ell, cbl::cosmology::Cosmology::zeta_ell_0_factor, cbl::cosmology::Cosmology::zeta_ell_1_factor, cbl::cosmology::Cosmology::zeta_ell_2_factor, cbl::cosmology::Cosmology::zeta_ell_3_factor, cbl::cosmology::Cosmology::zeta_ell_4_factor, cbl::cosmology::Cosmology::zeta_ell_k_factor, cbl::cosmology::Cosmology::zeta_ell_0_factor_tidal, cbl::cosmology::Cosmology::zeta_ell_2_factor_tidal, cbl::cosmology::Cosmology::zeta_ell_4_factor_tidal
r1 | the first triangle side |
r2 | the second triangle side |
ell | the order of the expansion |
b1 | the linear bias |
b2 | the quadratic bias |
bt | the tidal bias |
beta | the kaiser factor |
interp_xi_ell | vector of interpolating function for terms \(\xi^{[n]}, \xi^{[n\pm]}\) |
use_k | if true, use the \(k_l\) part of the model \(O(\beta^2)\) |
interp_k_ell | interpolationg function for \( k_l\). |
std::vector< double > cbl::cosmology::Cosmology::zeta_expansion_Slepian | ( | const double | r1, |
const double | r2, | ||
const double | b1, | ||
const double | b2, | ||
std::vector< double > & | rr, | ||
std::vector< double > & | xi_matter, | ||
std::vector< double > & | xi_matter_m1, | ||
std::vector< double > & | xi_matter_p1, | ||
std::vector< double > & | xi_matter_2, | ||
const int | norders = 9 , |
||
const double | prec = 1.e-3 |
||
) | const |
the terms of the \(\zeta(r_1, r_2)\) expansion
this function computes the terms of the \(\zeta(r_1, r_2)\) expansion up to an arbitrary order \(l\) (the default value is \(l_{max}=9\)), as described in Slepian et al. 2015:
\[\zeta_l(r_1, r_2) = \frac{2l+1}{2} \int_{-1}^{1} \mathrm{d}\mu_{12} \left[\zeta_{pc}(r_1, r_2, \mu_{12})+\zeta_{pc}(r_2, r_3, \mu_{23})+ \zeta_{pc}(r_3, r_1, \mu_{31})\right] P_l(\mu_{12}) .\]
the terms in square brackets is computed by cbl::cosmology::Cosmology::zeta_precyclic_Slepian
[in] | r1 | the first side of the triangle |
[in] | r2 | the second side of the triangle |
[in] | b1 | the linear bias of the triangle |
[in] | b2 | the non-linear bias |
[out] | rr | vector or scales |
[out] | xi_matter | vector containing the dark matter two-point correlation function |
[out] | xi_matter_m1 | vector containing \(\xi^{[1-]}_{DM}(r)\) |
[out] | xi_matter_p1 | vector containing \(\xi^{[1+]}_{DM}(r)\) |
[out] | xi_matter_2 | vector containing \(\xi^{[2]}_{DM}(r)\) |
[in] | norders | the maximum numbers of orders |
[in] | prec | the integral precision |
std::vector< double > cbl::cosmology::Cosmology::zeta_halo | ( | const double | r1, |
const double | r2, | ||
const std::vector< double > | theta, | ||
const double | b1, | ||
const double | b2, | ||
const std::string | model, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk_matter | ||
) | const |
the local-bias model of the three-point correlation function of dark matter haloes
this function computes the three-point correlation function of dark matter haloes with either the Slepian et al. 2015 or the Barriga & Gatzagnaga 2002 model, as follows:
\[ \zeta_h (r_1, r_2, \hat{r_1} \cdot \hat{r_2}) = b_1^3 \zeta_{DM}(r_1, r_2, \hat{r_1} \cdot \hat{r_2}) + b_1^2 b_2 \left[ \xi(r_1)\cdot\xi(r_2) + \xi(r_2)\cdot\xi(r_3) + \xi(r_3)\cdot\xi(r_1) \right] \]
with \(r_3 = \sqrt{r_1^2+r_2^2-2 r_1 r_2 \cos(\theta)}\) and \(b_1, b_2\) the linear and non-linear halo bias, respectively; \(\zeta_{DM}\) is compute by cbl::cosmology::Cosmology::zeta_DM
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | vector containing angles between r1 and r2, in radians |
b1 | the linear bias |
b2 | the non-linear bias |
model | the model to compute the three-point correlation function, can be "Slepian" or "BarrigaGatzanaga" |
kk | vector of the wave vector modules |
Pk_matter | the dark matter power spectrum |
double cbl::cosmology::Cosmology::zeta_multipoles_covariance | ( | const double | Volume, |
const double | nObjects, | ||
const int | l, | ||
const int | l_prime, | ||
const double | r1, | ||
const double | r2, | ||
const double | r1_prime, | ||
const double | r2_prime, | ||
const double | deltaR, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk, | ||
const std::vector< double > | rr, | ||
const std::vector< double > | Xi, | ||
const double | prec = 1.e-3 |
||
) |
the dark matter three-point correlation function multipoles covariance model, by Slepian et al. 2015
\[ C_{{\rm GRF}, ll'}(r_{1},r_{2};r_{1}',r_{2}')=\frac{4\pi}{V}(2l+1)(2l'+1)(-1)^{l+l'} \times\int r^{2}dr\sum_{l_{2}}(2l_{2}+1) \left(\begin{array}{ccc} l & l' & l_{2}\\ 0 & 0 & 0 \end{array}\right)^2\nonumber\\ \times\bigg\{(-1)^{l_2}\xi(r)\bigg[f_{l_{2}ll'}(r;r_{1},r_{1}')f_{l_{2}ll'}(r;r_{2},r_{2}') +f_{l_{2}ll'}(r;r_{2},r_{1}')f_{l_{2}ll'}(r;r_{1},r_{2}')\bigg]+(-1)^{(l+l'+l_{2})/2} \times\bigg[f_{ll}(r;r_{1})f_{l'l'}(r;r_{1}')f_{l_{2}ll'}(r;r_{2},r_{2}') +f_{ll}(r;r_{1})f_{l'l'}(r;r_{2}')f_{l_{2}ll'}(r;r_{2},r_{1}') +f_{ll}(r;r_{2})f_{l'l'}(r;r_{1}')f_{l_{2}ll'}(r;r_{1},r_{2}') +f_{ll}(r;r_{2})f_{l'l'}(r;r_{2}')f_{l_{2}ll'}(r;r_{1},r_{1}')\bigg]\bigg\} \]
with:
\[ f_{ll}(r;r_{1})=\int\frac{k^{2}dk}{2\pi^{2}}\left[P(k)+\frac{1}{n}\right]j_{l}(kr_{1})j_{l}(kr) \]
and:
\[ f_{l_{2}ll'}(r;r_{1},r_{1}')=\int\frac{k^{2}dk}{2\pi^{2}} \left[P(k)+\frac{1}{n}\right] j_{l}(kr_{1})j_{l'}(kr_{1}')j_{l_{2}}(kr), \]
where \(V\) is the effective survey volume, and \(n\) is the effective number density of the survey.
Volume | the volume |
nObjects | the number of objects |
l | the order l of the multipoles expansion |
l_prime | the order \(l'\) of the multipoles expansion |
r1 | the scale \(r_1\) |
r2 | the scale \(r_2\) |
r1_prime | the scale \(r_1'\) |
r2_prime | the scale \(r_2'\) |
deltaR | the bin size, if non-positive, no bin average is computed |
kk | vector of the wave vector modules |
Pk | the pdark matter ower spectrum |
rr | vector of scales |
Xi | vector containing the two-point correlation function |
prec | the integral precision |
double cbl::cosmology::Cosmology::zeta_precyclic_Slepian | ( | const double | r1, |
const double | r2, | ||
const double | mu, | ||
const double | b1, | ||
const double | b2, | ||
const glob::FuncGrid | interp_xi_matter, | ||
const glob::FuncGrid | interp_xi_matter_m1, | ||
const glob::FuncGrid | interp_xi_matter_p1, | ||
const glob::FuncGrid | interp_xi_matter_2 | ||
) | const |
the pre-cyclic three-point correlation function as described in Slepian et al. 2015
this function computes the pre-cyclic three-point correlation function as described in Slepian et al. 2015, as follows:
\[ \zeta_{pc} = \sum_{l=0}^2 \zeta_{pc l}(r_1, r_2) P_l(\hat{r_1}\cdot \hat{r_2})+ \sum_{l=0}^2 \zeta_{pc l}(r_2, r_3) P_l(\hat{r_2}\cdot \hat{r_3})+ \sum_{l=0}^2 \zeta_{pc l}(r_3, r_1) P_l(\hat{r_3}\cdot \hat{r_1}) \]
with
\[r_3 = \sqrt{r_1^2+r_2^2-2 r_1 r_2 \cos(\theta)}\]
and
\[ \zeta_{pc0}(r_i, r_j) = \left[ 2 b_1^2 b_2 + \frac{34}{21} b_1^3 \right] \xi(r_i) \xi(r_j), \]
\[ \zeta_{pc1}(r_i, r_j) = -b_1^3\left[ \xi^{[1-]}(r_i) \xi^{[1+]}(r_j) + \xi^{[1-]}(r_j) \xi^{[1+]}(r_i) \right] , \]
\[ \zeta_{pc2}(r_i, r_j) = \frac{8}{21} b_1^3\xi^{[2]}(r_i)\xi^{[2]}(r_j) . \]
where \( b_1, b_2 \) are the linear and non-linear bias, respectively, and \(\xi_{DM}(r), \xi^{[1\pm]}_{DM}(r), \xi^{[2]}_{DM}(r)\) are the integrals of the dark matter power spectrum computed by cbl::cosmology::Cosmology::integrals_zeta_Slepian
r1 | the first side |
r2 | the second side |
mu | the cosine of the angle between r1 and r2 |
b1 | the linear bias |
b2 | the non-linear bias |
interp_xi_matter | interpolating function for \(\xi_matter\) |
interp_xi_matter_m1 | interpolating function for \(\xi^{[1-]}_{DM}(r)\) |
interp_xi_matter_p1 | interpolating function for \(\xi^{[1+]}_{DM}(r)\) |
interp_xi_matter_2 | interpolating function for \(\xi^{[2]}_{DM}(r)\) |
double cbl::cosmology::Cosmology::zeta_precyclic_Slepian | ( | const double | r1, |
const double | r2, | ||
const double | r3, | ||
const double | deltaR, | ||
const double | b1, | ||
const double | b2, | ||
const glob::FuncGrid | interp_xi_matter, | ||
const glob::FuncGrid | interp_xi_matter_m1, | ||
const glob::FuncGrid | interp_xi_matter_p1, | ||
const glob::FuncGrid | interp_xi_matter_2 | ||
) | const |
the pre-cyclic three-point correlation function as described in Slepian et al. 2015, for a triangle averaging in the bin
this function computes the pre-cyclic three-point correlation function as described in Slepian et al. 2015, as follows:
\[ \zeta_{pc} = \sum_{l=0}^2 \zeta_{pc l}(r_1, r_2) P_l(\hat{r_1}\cdot \hat{r_2})+ \sum_{l=0}^2 \zeta_{pc l}(r_2, r_3) P_l(\hat{r_2}\cdot \hat{r_3})+ \sum_{l=0}^2 \zeta_{pc l}(r_3, r_1) P_l(\hat{r_3}\cdot \hat{r_1}) \]
with
\[r_3 = \sqrt{r_1^2+r_2^2-2 r_1 r_2 \cos(\theta)}\]
and
\[ \zeta_{pc0}(r_i, r_j) = \left[ 2 b_1^2 b_2 + \frac{34}{21} b_1^3 \right] \xi(r_i) \xi(r_j), \]
\[ \zeta_{pc1}(r_i, r_j) = -b_1^3\left[ \xi^{[1-]}(r_i) \xi^{[1+]}(r_j) + \xi^{[1-]}(r_j) \xi^{[1+]}(r_i) \right] , \]
\[ \zeta_{pc2}(r_i, r_j) = \frac{8}{21} b_1^3\xi^{[2]}(r_i)\xi^{[2]}(r_j) . \]
where \( b_1, b_2 \) are the linear and non-linear bias, respectively, and \(\xi_{DM}(r), \xi^{[1\pm]}_{DM}(r), \xi^{[2]}_{DM}(r)\) are the integrals of the dark matter power spectrum computed by cbl::cosmology::Cosmology::integrals_zeta_Slepian
r1 | the first side |
r2 | the second side |
r3 | the third side |
deltaR | the side width |
b1 | the linear bias |
b2 | the non-linear bias |
interp_xi_matter | interpolating function for \(\xi_matter\) |
interp_xi_matter_m1 | interpolating function for \(\xi^{[1-]}_{DM}(r)\) |
interp_xi_matter_p1 | interpolating function for \(\xi^{[1+]}_{DM}(r)\) |
interp_xi_matter_2 | interpolating function for \(\xi^{[2]}_{DM}(r)\) |
std::vector< double > cbl::cosmology::Cosmology::zeta_RSD | ( | const double | r1, |
const double | r2, | ||
const int | ntheta, | ||
const double | b1, | ||
const double | b2, | ||
const double | bt, | ||
const double | beta, | ||
const std::vector< double > | rr, | ||
const std::vector< double > | kk, | ||
const std::vector< double > | Pk, | ||
const bool | include_limits = false , |
||
const int | max_ll = 4 , |
||
const bool | use_k = false |
||
) |
the \( \zeta (r_1, r_2, \theta) \)
This function computes tree-level prediction for three-point correlation function of haloes in redshift space, as derived by Slepian&Eisenstein (2017) in configuration space, based on the work presented by Scoccimarro et al (1999) for the bispectrum.
r1 | the first triangle side |
r2 | the second triangle side |
ntheta | the number of \(\theta\) bins |
b1 | the linear bias |
b2 | the quadratic bias |
bt | the tidal bias |
beta | the kaiser factor |
rr | vector of scales |
kk | vector of wavevector modules |
Pk | dark matter power spectrum |
include_limits | include the \(\theta\) limits |
max_ll | maximum order in the model |
use_k | if true, use the \(k_l\) part of the model \(O(\beta^2)\) |
std::vector< double > cbl::cosmology::Cosmology::zeta_RSD | ( | const double | r1, |
const double | r2, | ||
const int | ntheta, | ||
const double | b1, | ||
const double | b2, | ||
const double | bt, | ||
const double | redshift, | ||
const std::string | method_Pk, | ||
const int | step_r, | ||
const int | step_k, | ||
const bool | store_output = true , |
||
const std::string | output_root = "test" , |
||
const bool | force_RealSpace = false , |
||
const bool | include_limits = false , |
||
const int | max_ll = 4 , |
||
const bool | use_k = false |
||
) |
the \( \zeta (r_1, r_2, \theta) \)
This function computes tree-level prediction for three-point correlation function of haloes in redshift space, as derived by Slepian&Eisenstein (2017) in configuration space, based on the work presented by Scoccimarro et al (1999) for the bispectrum.
r1 | the first triangle side |
r2 | the second triangle side |
ntheta | the number of \(\theta\) bins |
b1 | the linear bias |
b2 | the quadratic bias |
bt | the tidal bias |
redshift | the redshift |
method_Pk | method used to compute the power spectrum (i.e. the Boltzmann solver); valid choices for method_Pk are: CAMB [http://camb.info/], CLASS [http://class-code.net/], MPTbreeze-v1 [http://arxiv.org/abs/1207.1465], EisensteinHu [http://background.uchicago.edu/~whu/transfer/transferpage.html] |
step_r | the number of bins for r |
step_k | the number of bins for k |
store_output | if true the output files created by the Boltzmann solver are stored; if false the output files are removed |
output_root | output_root of the parameter file used to compute the power spectrum and σ(mass); it can be any name. If this parameter is different from the default value it will be used also in the output directory name |
force_RealSpace | if true, force the computation to be in real space |
include_limits | include the \(\theta\) limits |
max_ll | maximum order in the model |
use_k | if true, use the \(k_l\) part of the model \(O(\beta^2)\) |
double cbl::cosmology::Cosmology::zeta_single_BarrigaGatzanaga | ( | const double | r1, |
const double | r2, | ||
const double | theta, | ||
const std::vector< double > | xi, | ||
const std::vector< double > | dxi, | ||
const std::vector< double > | dPhi | ||
) | const |
the single term of the dark matter three-point correlation function model by Barriga & Gatzanaga et al. 2002
this function computes the single term of the dark matter three-point correlation function, following Barriga & Gatzanaga et al. 2002:
\[ f(r_1, r_2) = \frac{10}{7}\xi(r_1) \xi(r_2)+\frac{4}{7} \left\{ -3 \frac{\Phi^\prime(r_1) \Phi^\prime(r_2)}{r_1 r_2} -\frac{\xi(r_1) \Phi^\prime(r_2)}{r_2}-\frac{\xi(r_2) \Phi^\prime(r_1)}{r_1} +\mu^2\left[ \xi(r_1)+3\frac{\Phi^\prime(r_1)}{r1}\right]\left[ \xi(r_2)+3\frac{\Phi^\prime(r_2)}{r_3}\right] \right\} -\mu\left[ \xi^\prime(r_1)\Phi^\prime(r_2) + \xi^\prime(r_2)\Phi^\prime(r_1)\right] \]
where the prime indicates the derivative with respect to \(r\), and \(\xi(r), \Phi(r)\) are the integrals of the power spectrum computed by cbl::cosmology::Cosmology::integrals_zeta_BarrigaGatzanaga
r1 | the first side of the triangle |
r2 | the second side of the triangle |
theta | the angle betwee r1 and r2 |
xi | vector containing the value of xi at r1, r2 |
dxi | vector containing the value of the derivative of xi at r1, r2 |
dPhi | vector containing the value of the derivative of Phi at r1, r2 |