示例#1
0
 def setup(self):
     # define a cosmology
     cosmo = FlatLambdaCDM(H0=70, Om0=0.3, Ob0=0.05)
     self._cosmo = cosmo
     redshift_list = [0.1, 0.3, 0.8]  # list of redshift of the deflectors
     z_source = 2  # source redshift
     self._z_source = z_source
     # analytic profile class in multi plane
     self._lensmodel = LensModel(lens_model_list=['NFW', 'NFW', 'NFW'],
                                 lens_redshift_list=redshift_list,
                                 multi_plane=True,
                                 z_source_convention=z_source,
                                 cosmo=cosmo,
                                 z_source=z_source)
     # a single plane class from which the convergence/mass maps are computeded
     single_plane = LensModel(lens_model_list=['NFW'], multi_plane=False)
     # multi-plane class with three interpolation grids
     self._lens_model_interp = LensModel(
         lens_model_list=['INTERPOL', 'INTERPOL', 'INTERPOL'],
         lens_redshift_list=redshift_list,
         multi_plane=True,
         z_source_convention=z_source,
         cosmo=cosmo,
         z_source=z_source)
     # deflector parameterisation in units of reduced deflection angles to the source convention redshift
     logM_200_list = [8, 9,
                      10]  # log 10 halo masses of the three deflectors
     c_list = [20, 10, 8]  # concentrations of the three halos
     kwargs_lens = []
     kwargs_lens_interp = []
     grid_spacing = 0.01  # spacing of the convergence grid in units arc seconds
     x_grid, y_grid = util.make_grid(
         numPix=500, deltapix=grid_spacing
     )  # we create the grid coordinates centered at zero
     x_axes, y_axes = util.get_axes(
         x_grid, y_grid)  # we need the axes only for the interpolation
     mass_map_list = []
     grid_spacing_list_mpc = []
     for i, z in enumerate(
             redshift_list):  # loop through the three deflectors
         lens_cosmo = LensCosmo(
             z_lens=z, z_source=z_source, cosmo=cosmo
         )  # instance of LensCosmo, a class that manages cosmology relevant quantities of a lens
         alpha_Rs, Rs = lens_cosmo.nfw_physical2angle(
             M=10**(logM_200_list[i]), c=c_list[i]
         )  # we turn the halo mass and concentration in reduced deflection angles and angles on the sky
         kwargs_nfw = {
             'Rs': Rs,
             'alpha_Rs': alpha_Rs,
             'center_x': 0,
             'center_y': 0
         }  # lensing parameters of the NFW profile in lenstronomy conventions
         kwargs_lens.append(kwargs_nfw)
         kappa_map = single_plane.kappa(
             x_grid, y_grid,
             [kwargs_nfw])  # convergence map of a single NFW profile
         kappa_map = util.array2image(kappa_map)
         mass_map = lens_cosmo.epsilon_crit_angle * kappa_map * grid_spacing**2  # projected mass per pixel on the gird
         mass_map_list.append(mass_map)
         npt.assert_almost_equal(
             np.log10(np.sum(mass_map)), logM_200_list[i], decimal=0
         )  # check whether the sum of mass roughtly correspoonds the mass definition
         grid_spacing_mpc = lens_cosmo.arcsec2phys_lens(
             grid_spacing)  # turn grid spacing from arcseconds into Mpc
         grid_spacing_list_mpc.append(grid_spacing_mpc)
         f_x, f_y = convergence_integrals.deflection_from_kappa_grid(
             kappa_map, grid_spacing
         )  # perform the deflection calculation from the convergence map
         f_ = convergence_integrals.potential_from_kappa_grid(
             kappa_map, grid_spacing
         )  # perform the lensing potential calculation from the convergence map (attention: arbitrary normalization)
         kwargs_interp = {
             'grid_interp_x': x_axes,
             'grid_interp_y': y_axes,
             'f_': f_,
             'f_x': f_x,
             'f_y': f_y
         }  # keyword arguments of the interpolation model
         kwargs_lens_interp.append(kwargs_interp)
     self.kwargs_lens = kwargs_lens
     self.kwargs_lens_interp = kwargs_lens_interp
     self.lightCone = LightCone(
         mass_map_list, grid_spacing_list_mpc, redshift_list
     )  # here we make the instance of the LightCone class based on the mass map, physical grid spacing and redshifts.
class TestLensCosmo(object):
    """
    tests the UnitManager class routines
    """
    def setup(self):
        z_L = 0.8
        z_S = 3.0
        from astropy.cosmology import FlatLambdaCDM
        cosmo = FlatLambdaCDM(H0=70, Om0=0.3, Ob0=0.05)
        self.lensCosmo = LensCosmo(z_L, z_S, cosmo=cosmo)

    def test_ang_dist(self):
        npt.assert_almost_equal(self.lensCosmo.ds,
                                1588.9213590743666,
                                decimal=8)
        npt.assert_almost_equal(self.lensCosmo.dd,
                                1548.7055203661785,
                                decimal=8)
        npt.assert_almost_equal(self.lensCosmo.dds,
                                892.0038749095863,
                                decimal=8)

    def test_epsilon_crit(self):
        npt.assert_almost_equal(self.lensCosmo.sigma_crit / 1.9121e+15,
                                1,
                                decimal=3)

    def test_arcsec2phys(self):
        arcsec = np.array([1, 2])  # pixel coordinate from center
        physcoord = self.lensCosmo.arcsec2phys_lens(arcsec)
        npt.assert_almost_equal(physcoord[0], 0.0075083362428338641, decimal=8)
        npt.assert_almost_equal(physcoord[1], 0.015016672485667728, decimal=8)

        physcoord = self.lensCosmo.arcsec2phys_source(arcsec)
        npt.assert_almost_equal(physcoord[0], 0.007703308130864105, decimal=8)
        npt.assert_almost_equal(physcoord[1], 0.01540661626172821, decimal=8)

    def test_phys2arcsec_lens(self):
        phys = 1.
        arc_sec = self.lensCosmo.phys2arcsec_lens(phys)
        phys_new = self.lensCosmo.arcsec2phys_lens(arc_sec)
        npt.assert_almost_equal(phys_new, phys, decimal=8)

    def test_mass_in_phi_E(self):
        phi_E = 1.5
        mass = self.lensCosmo.mass_in_theta_E(phi_E)
        npt.assert_almost_equal(mass, 761967261292.6725, decimal=2)

    def test_kappa2proj_mass(self):
        kappa = 0.5
        mass = self.lensCosmo.kappa2proj_mass(kappa)
        npt.assert_almost_equal(mass,
                                kappa * self.lensCosmo.sigma_crit,
                                decimal=3)

    def test_mass_in_coin(self):
        theta_E = 1.
        m_coin = self.lensCosmo.mass_in_coin(theta_E)
        npt.assert_almost_equal(m_coin, 165279526936.52194, decimal=0)

    def test_D_dt_model(self):
        D_dt = self.lensCosmo.ddt
        npt.assert_almost_equal(D_dt, 4965.660384441859, decimal=8)

    def test_nfw_angle2physical(self):
        Rs_angle = 6.
        alpha_Rs = 1.
        rho0, Rs, c, r200, M200 = self.lensCosmo.nfw_angle2physical(
            Rs_angle, alpha_Rs)
        assert Rs * c == r200

    def test_nfw_physical2angle(self):
        M = 10.**13.5
        c = 4
        Rs_angle, alpha_Rs = self.lensCosmo.nfw_physical2angle(M, c)
        rho0, Rs, c_out, r200, M200 = self.lensCosmo.nfw_angle2physical(
            Rs_angle, alpha_Rs)
        npt.assert_almost_equal(c_out, c, decimal=3)
        npt.assert_almost_equal(np.log10(M200), np.log10(M), decimal=4)

    def test_sis_theta_E2sigma_v(self):
        theta_E = 2.
        sigma_v = self.lensCosmo.sis_theta_E2sigma_v(theta_E)
        theta_E_out = self.lensCosmo.sis_sigma_v2theta_E(sigma_v)
        npt.assert_almost_equal(theta_E_out, theta_E, decimal=5)

    def test_fermat2delays(self):

        fermat_pot = 0.5
        dt_days = self.lensCosmo.time_delay_units(fermat_pot)
        fermat_pot_out = self.lensCosmo.time_delay2fermat_pot(dt_days)
        npt.assert_almost_equal(fermat_pot, fermat_pot_out, decimal=10)

    def test_uldm_angular2phys(self):

        kappa_0, theta_c = 0.1, 3
        mlog10, Mlog10 = self.lensCosmo.uldm_angular2phys(kappa_0, theta_c)
        npt.assert_almost_equal(mlog10, -24.3610006, decimal=5)
        npt.assert_almost_equal(Mlog10, 11.7195843, decimal=5)

    def test_uldm_mphys2angular(self):

        m_log10, M_log10 = -24, 11
        kappa_0, theta_c = self.lensCosmo.uldm_mphys2angular(m_log10, M_log10)
        mcheck, Mcheck = self.lensCosmo.uldm_angular2phys(kappa_0, theta_c)
        npt.assert_almost_equal(mcheck, m_log10, decimal=4)
        npt.assert_almost_equal(Mcheck, M_log10, decimal=4)

    def test_a_z(self):

        a = self.lensCosmo.a_z(z=1)
        npt.assert_almost_equal(a, 0.5)
示例#3
0
class TestLensCosmo(object):
    """
    tests the UnitManager class routines
    """
    def setup(self):
        z_L = 0.8
        z_S = 3.0
        from astropy.cosmology import FlatLambdaCDM
        cosmo = FlatLambdaCDM(H0=70, Om0=0.3, Ob0=0.05)
        self.lensCosmo = LensCosmo(z_L, z_S, cosmo=cosmo)

    def test_ang_dist(self):
        npt.assert_almost_equal(self.lensCosmo.D_s,
                                1588.9213590743666,
                                decimal=8)
        npt.assert_almost_equal(self.lensCosmo.D_d,
                                1548.7055203661785,
                                decimal=8)
        npt.assert_almost_equal(self.lensCosmo.D_ds,
                                892.0038749095863,
                                decimal=8)

    def test_epsilon_crit(self):
        npt.assert_almost_equal(self.lensCosmo.epsilon_crit / 1.9121e+15,
                                1,
                                decimal=3)

    def test_arcsec2phys(self):
        arcsec = np.array([1, 2])  # pixel coordinate from center
        physcoord = self.lensCosmo.arcsec2phys_lens(arcsec)
        assert physcoord[0] == 0.0075083362428338641
        assert physcoord[1] == 0.015016672485667728

        physcoord = self.lensCosmo.arcsec2phys_source(arcsec)
        assert physcoord[0] == 0.007703308130864105
        assert physcoord[1] == 0.01540661626172821

    def test_phys2arcsec_lens(self):
        phys = 1.
        arc_sec = self.lensCosmo.phys2arcsec_lens(phys)
        phys_new = self.lensCosmo.arcsec2phys_lens(arc_sec)
        assert phys_new == phys

    def test_mass_in_phi_E(self):
        phi_E = 1.5
        mass = self.lensCosmo.mass_in_theta_E(phi_E)
        assert mass == 761967261292.6725

    def test_kappa2proj_mass(self):
        kappa = 0.5
        mass = self.lensCosmo.kappa2proj_mass(kappa)
        npt.assert_almost_equal(mass,
                                kappa * self.lensCosmo.epsilon_crit,
                                decimal=3)

    def test_mass_in_coin(self):
        theta_E = 1.
        m_coin = self.lensCosmo.mass_in_coin(theta_E)
        npt.assert_almost_equal(m_coin, 165279526936.52194, decimal=0)

    def test_D_dt_model(self):
        D_dt = self.lensCosmo.D_dt
        assert D_dt == 4965.660384441859

    def test_nfw_angle2physical(self):
        Rs_angle = 6.
        theta_Rs = 1.
        rho0, Rs, c, r200, M200 = self.lensCosmo.nfw_angle2physical(
            Rs_angle, theta_Rs)
        assert Rs * c == r200

    def test_nfw_physical2angle(self):
        M = 10.**13.5
        c = 4
        Rs_angle, theta_Rs = self.lensCosmo.nfw_physical2angle(M, c)
        rho0, Rs, c_out, r200, M200 = self.lensCosmo.nfw_angle2physical(
            Rs_angle, theta_Rs)
        npt.assert_almost_equal(c_out, c, decimal=3)
        npt.assert_almost_equal(np.log10(M200), np.log10(M), decimal=4)

    def test_sis_theta_E2sigma_v(self):
        theta_E = 2.
        sigma_v = self.lensCosmo.sis_theta_E2sigma_v(theta_E)
        theta_E_out = self.lensCosmo.sis_sigma_v2theta_E(sigma_v)
        npt.assert_almost_equal(theta_E_out, theta_E, decimal=5)