halomod.integrate_corr.AngularCF

class halomod.integrate_corr.AngularCF(*args, **kwargs)[source]

Framework extension to angular correlation functions.

Parameters
  • p1 (callable, optional) – The redshift distribution of the sample. This needs not be normalised to 1, as this will occur internally. May be either a function of radial distance [Mpc/h] or redshift. If a function of radial distance, p_of_z() must be set to False. Default is a flat distribution in redshift.

  • p2 (callable, optional) – See p1. This can optionally be a different function against which to cross-correlate. By default is equivalent to p1().

  • theta_min (float, optional) – min,max angular separations [Rad]

  • theta_max (float, optional) – min,max angular separations [Rad]

  • theta_num (int, optional) – Number of steps in angular separation

  • theta_log (bool, optional) – Whether to use logspace for theta values

  • zmin (float, optional) – The redshift limits of the sample distribution. Note that this is in redshit, regardless of the value of p_of_z().

  • zmax (float, optional) – The redshift limits of the sample distribution. Note that this is in redshit, regardless of the value of p_of_z().

  • znum (int, optional) – Number of steps in redshift grid.

  • logu_min (float, optional) – min,max of the log10 of radial separation grid [Mpc/h]. Must be large enough to let the integral over the 3D correlation function to converge.

  • logu_max (float, optional) – min,max of the log10 of radial separation grid [Mpc/h]. Must be large enough to let the integral over the 3D correlation function to converge.

  • unum (int, optional) – Number of steps in the u grid.

  • check_p_norm (bool, optional) – If False, cancels checking the normalisation of p1() and p2().

  • p_of_z (bool, optional) – Whether p1() and p2() are functions of redshift.

  • kwargs (unpacked-dict) – Any keyword arguments passed down to halomod.HaloModel.

Methods

__init__([p1, p2, theta_min, theta_max, …])

Initializer for the class.

clone(**kwargs)

Create and return an updated clone of the current object.

get_all_parameter_defaults([recursive])

Dictionary of all parameters and defaults.

get_all_parameter_names()

Yield all parameter names in the class.

get_dependencies(*q)

Determine all parameter dependencies of the quantities in q.

parameter_info([names])

Prints information about each parameter in the class.

power_hh(k[, mmin, mmax, mmin2, mmax2])

The halo-centre power spectrum of haloes in a given mass range.

quantities_available()

Obtain a list of all available output quantities.

update(**kwargs)

Updates any parameter passed.

validate()

Perform validation of the input parameters as they relate to each other.

Attributes

ERROR_ON_BAD_MDEF

Switch to turn off exceptions for mdef’s not matching hmf_model

Mmax

Maximum mass at which to perform analysis [units \(\log_{10}M_\odot h^{-1}\)].

Mmin

Minimum mass at which to perform analysis [units \(\log_{10}M_\odot h^{-1}\)].

angular_corr_gal

The angular correlation function w(theta) for tracers.

angular_corr_matter

The angular correlation function w(theta) for matter.

bias

The halo bias as a function of halo mass.

bias_effective_matter

The effective bias of matter in DM halos.

bias_effective_tracer

The tracer occupation-weighted halo bias factor (Tinker 2005).

bias_model

Bias Model.

bias_params

Dictionary of parameters for the Bias model.

central_fraction

The total fraction of tracers that are centrals.

central_occupation

The mean central occupation of the tracer as a function of halo mass.

check_p_norm

If False, cancels checking the normalisation of p1() and p2().

cmz_relation

Concentration-mass-redshift relation.

colossus_cosmo

An instance of a COLOSSUS cosmology, which can be used to perform various COLOSSUS operations.

colossus_params

Options for colossus cosmology not set/derived in the astropy cosmology.

corr_1h_auto_matter

The halo model 1-halo dark matter auto-correlation function.

corr_1h_auto_matter_fnc

A callable returning the halo model 1-halo DM auto-correlation function.

corr_1h_auto_tracer

The 1-halo term of the tracer auto correlations.

corr_1h_auto_tracer_fnc

A callable returning the 1-halo term of the tracer auto correlations.

corr_1h_cross_tracer_matter

The 1-halo term of the cross correlation between tracer and matter.

corr_1h_cross_tracer_matter_fnc

A callable returning the 1-halo cross-corr between tracer and matter.

corr_1h_cs_auto_tracer

The cen-sat part of the 1-halo term of the tracer auto-correlation function.

corr_1h_cs_auto_tracer_fnc

A callable returning the cen-sat part of the 1-halo term of the tracer auto-correlation function.

corr_1h_ss_auto_tracer

The satellite-satellite part of the 1-halo term of the tracer auto-correlation function.

corr_1h_ss_auto_tracer_fnc

A callable returning the satellite-satellite part of the 1-halo term of the tracer auto-correlation function.

corr_2h_auto_matter

The 2-halo term of the matter auto-correlation.

corr_2h_auto_matter_fnc

A callable returning the 2-halo term of the matter auto-correlation at arbitrary k.

corr_2h_auto_tracer

The 2-halo term of the tracer auto-correlation.

corr_2h_auto_tracer_fnc

A callable returning the 2-halo term of the tracer auto-correlation.

corr_2h_cross_tracer_matter

The 2-halo term of the cross-correlation between tracer and matter.

corr_2h_cross_tracer_matter_fnc

A callable returning the 2-halo cross-corr between tracer and matter.

corr_auto_matter

The halo-model-derived nonlinear dark matter auto-correlation function.

corr_auto_matter_fnc

A callable returning the halo-model DM auto-correlation function.

corr_auto_tracer

The tracer auto correlation function.

corr_auto_tracer_fnc

A callable returning the tracer auto correlation function.

corr_cross_tracer_matter

Cross-correlation of tracer with matter.

corr_cross_tracer_matter_fnc

A callable returning the cross-correlation of tracer with matter.

corr_gg

See corr_auto_tracer().

corr_gg_1h

See corr_1h_auto_tracer().

corr_gg_2h

See corr_2h_auto_tracer().

corr_halofit_mm

The nonlinear (from halofit) auto-correlation function of dark matter.

corr_halofit_mm_fnc

A callable returning the nonlinear auto-correlation function of dark matter.

corr_linear_mm

The linear auto-correlation function of dark matter.

corr_linear_mm_fnc

A callable returning the linear auto-correlation function of dark matter.

corr_mm

See corr_auto_matter().

corr_mm_1h

See corr_1h_auto_matter().

corr_mm_2h

See corr_2h_auto_matter().

cosmo

Cosmographic object (astropy.cosmology.FLRW object), with custom cosmology from cosmo_params applied.

cosmo_model

The basis for the cosmology – see astropy documentation.

cosmo_params

Parameters for the cosmology that deviate from the base cosmology passed.

delta_c

The critical overdensity for collapse, \(\delta_c\).

delta_k

Dimensionless power spectrum, \(\Delta_k = \frac{k^3 P(k)}{2\pi^2}\).

disable_mass_conversion

Disable converting mass function from builtin definition to that provided.

dlnk

Step-size of log wave-numbers

dlog10m

log10 interval between mass bins

dndlnm

The differential mass function in terms of natural log of m, len=len(m) [units \(h^3 Mpc^{-3}\)]

dndlog10m

The differential mass function in terms of log of m, len=len(m) [units \(h^3 Mpc^{-3}\)]

dndm

The number density of haloes, len=len(m) [units \(h^4 M_\odot^{-1} Mpc^{-3}\)]

dr_table

The width of r bin.

exclusion_model

A string identifier for the type of halo exclusion used (or None).

exclusion_params

Dictionary of parameters for the Exclusion model.

filter

Instantiated model for filter/window functions.

filter_model

A model for the window/filter function.

filter_params

Model parameters for filter_model.

force_1halo_turnover

Suppress 1-halo power on scales larger than a few virial radii.

fsigma

The multiplicity function, \(f(\sigma)\), for hmf_model.

growth

The instantiated growth model.

growth_factor

The growth factor.

growth_model

The model to use to calculate the growth function/growth rate.

growth_params

Relevant parameters of the growth_model.

halo_bias

Halo bias.

halo_concentration

The concentration-mass relation.

halo_concentration_model

A halo_concentration-mass relation

halo_concentration_params

Dictionary of parameters for the concentration model.

halo_overdensity_crit

The halo overdensity with respect to the critical density.

halo_overdensity_mean

The halo overdensity with respect to the mean background.

halo_profile

A class containing the elements necessary to calculate halo halo_profile quantities.

halo_profile_lam

Mass-normalised halo profile self-convolution, with shape (len(r), len(m)).

halo_profile_model

The halo density halo_profile model.

halo_profile_params

Dictionary of parameters for the Profile model.

halo_profile_rho

Mass-normalised halo density profile, with shape (len(r), len(m)).

halo_profile_ukm

Mass-normalised fourier halo profile, with shape (len(k), len(m)).

hc_spectrum

The spectrum with which the halo-centre power spectrum is identified.

hm_dlog10k

The width of k bin in log10.

hm_logk_max

The maximum k bin in log10.

hm_logk_min

The minimum k bin in log10.

hmf

Instantiated model for the hmf fitting function.

hmf_model

A model to use as the fitting function \(f(\sigma)\)

hmf_params

Model parameters for hmf_model.

hod

A class representing the HOD

hod_model

HOD class.

hod_params

Dictionary of parameters for the HOD model.

how_big

Size of simulation volume in which to expect one halo of mass m (with 95% probability), ` len=len(m)` [units \(Mpch^{-1}\)]

k

Wavenumbers, [h/Mpc]

k_hm

The wave-numbers at which halo-model power spectra are calculated.

linear_power_fnc

A callable returning the linear power as a function of k (in h/Mpc).

lnk_max

Maximum (natural) log wave-number, k [h/Mpc].

lnk_min

Minimum (natural) log wave-number, k [h/Mpc].

lnsigma

Natural log of inverse mass variance, len=len(m).

logu_max

Maximum radial separation grid [Mpc/h].

logu_min

Minimum radial separation grid [Mpc/h].

m

Halo masses (defined via mdef).

mass_effective

Average host-halo mass (in log10 units).

mass_nonlinear

The nonlinear mass, nu(Mstar) = 1.

mdef

The halo mass-definition model instance.

mdef_model

A model to use as the mass definition.

mdef_params

Model parameters for mdef_model.

mean_density

Mean density of universe at redshift z.

mean_density0

Mean density of universe at z=0, [Msun h^2 / Mpc**3]

mean_density_in_halos

mean_tracer_den

The mean density of the tracer.

mean_tracer_den_unit

The mean density of the tracer, in the units defined in the HOD.

n

Spectral index of fluctuations

n_eff

Effective spectral index at scale of halo radius, len=len(m)

ngtm

The cumulative mass function above m, len=len(m) [units \(h^3 Mpc^{-3}\)]

nonlinear_delta_k

Dimensionless nonlinear power spectrum.

nonlinear_power

Non-linear log power [units \(Mpc^3/h^3\)].

nonlinear_power_fnc

A callable returning the nonlinear (halofit) power as a function of k (in h/Mpc).

normalised_filter

A normalised filter, such that filter.sigma(8) == sigma8

nu

The parameter \(\nu = \left(\frac{\delta_c}{\sigma}\right)^2\), len=len(m)

p1

The redshift distribution of the sample.

p2

The redshift distribution of the second sample for correlation.

p_of_z

Whether p1() and p2() are functions of redshift.

parameter_values

Dictionary of all parameters and their current values

power

Normalised log power spectrum [units \(Mpc^3/h^3\)].

power_1h_auto_matter

The halo model-derived nonlinear 1-halo dark matter auto-power spectrum.

power_1h_auto_matter_fnc

A callable returning the halo model 1-halo DM auto-power spectrum.

power_1h_auto_tracer

The total 1-halo term of the tracer auto power spectrum.

power_1h_auto_tracer_fnc

A callable returning the total 1-halo term of the tracer auto power spectrum.

power_1h_cross_tracer_matter

The total 1-halo cross-power spectrum between tracer and matter.

power_1h_cross_tracer_matter_fnc

A callable returning the total 1-halo cross-power spectrum between tracer and matter.

power_1h_cs_auto_tracer

The cen-sat part of the 1-halo term of the tracer auto-power spectrum.

power_1h_cs_auto_tracer_fnc

A callable returning the cen-sat part of the 1-halo term of the tracer auto-power spectrum.

power_1h_ss_auto_tracer

The satellite-satellite part of the 1-halo term of the tracer auto-power spectrum.

power_1h_ss_auto_tracer_fnc

A callable returning the satellite-satellite part of the 1-halo term of the tracer auto-power spectrum.

power_2h_auto_matter

The halo model 2-halo matter auto-power spectrum at k_hm.

power_2h_auto_matter_fnc

Return the halo model 2-halo matter auto-power spectrum at k.

power_2h_auto_tracer

The 2-halo term of the tracer auto-power spectrum.

power_2h_auto_tracer_fnc

Return the 2-halo term of the tracer auto-power spectrum at k.

power_2h_cross_tracer_matter

The 2-halo term of the cross-power spectrum between tracer and matter.

power_2h_cross_tracer_matter_fnc

A callable returning the 2-halo cross-power between tracer and matter.

power_auto_matter

The halo-model-derived nonlinear dark power auto-power spectrum.

power_auto_matter_fnc

A callable returning the halo-model DM auto-power spectrum.

power_auto_tracer

Auto-power spectrum of the tracer.

power_auto_tracer_fnc

power_cross_tracer_matter

Cross-power spectrum between tracer and matter.

power_cross_tracer_matter_fnc

A callable returning cross-power spectrum of tracer and matter.

power_gg

See power_auto_tracer().

power_gg_1h

See corr_auto_tracer().

power_gg_2h

See power_2h_auto_tracer().

power_mm

See power_auto_matter().

power_mm_1h

See power_1h_auto_matter().

power_mm_2h

See power_2h_auto_matter().

r

Physical separation grid [Mpc/h].

radii

The radii corresponding to the masses m.

rho_gtm

Mass density in haloes >m, len=len(m) [units \(M_\odot h^2 Mpc^{-3}\)]

rho_ltm

Mass density in haloes <m, len=len(m) [units \(M_\odot h^2 Mpc^{-3}\)]

rlog

If True, r bins are logarithmically distributed.

rmax

Maximum length scale.

rmin

Minimum length scale.

rnum

Number of r bins.

satellite_fraction

The total fraction of tracers that are satellites.

satellite_occupation

The mean satellite occupation of the tracer as a function of halo mass.

sd_bias

A class containing relevant methods to calculate scale-dependent bias corrections.

sd_bias_correction

Return the correction for scale dependancy of bias.

sd_bias_model

Model of Scale Dependant Bias.

sd_bias_params

Dictionary of parameters for Scale Dependant Bias.

sigma

The sqrt of the mass variance at z, len=len(m).

sigma_8

RMS linear density fluctuations in spheres of radius 8 Mpc/h

takahashi

Whether to use updated HALOFIT coefficients from Takahashi+12.

theta

Angular separations, [Rad].

theta_log

If angular separations are logarithmically distributed.

theta_max

Maximum angular separations [Rad].

theta_min

Minimum angular separations [Rad].

theta_num

Number of angular separations [Rad].

total_occupation

The mean total occupation of the tracer as a function of halo mass.

tracer_cmz_relation

The concentrations corresponding to m().

tracer_concentration

Concentration-mass relation model instance.

tracer_concentration_model

The tracer concentration-mass relation.

tracer_concentration_params

Dictionary of parameters for tracer concentration-mass relation.

tracer_density

Mean density of the tracer, ONLY if passed directly.

tracer_density_m

The total tracer density in halos of mass m.

tracer_mmin

The minimum halo mass of integrals over the tracer population.

tracer_profile

Object to calculate quantities of the tracer profile.

tracer_profile_lam

The mass-normalised profile self-convolution of the tracer, shape (len(r), len(m)).

tracer_profile_model

The tracer density halo_profile model.

tracer_profile_params

Dictionary of parameters for the tracer Profile model.

tracer_profile_rho

The mass-normalised density profile of the tracer, with shape (len(r), len(m)).

tracer_profile_ukm

The mass-normalised fourier density profile of the tracer, shape (len(k), len(m)).

transfer

The instantiated transfer model

transfer_function

Normalised CDM log transfer function.

transfer_model

Defines which transfer function model to use.

transfer_params

Relevant parameters of the transfer_model.

unum

Number of radial separation grids [Mpc/h].

uvec

Radial separation grid [Mpc/h].

xvec

Radial distance grid (corresponds to zvec) [Mpc/h].

z

Redshift.

zmax

Maximum redshift.

zmin

Minimum redshift.

znum

Number of redshift bins.

zvec

Redshift distribution grid.