diff --git a/CMakeLists.txt b/CMakeLists.txt index f533da3..28a5169 100644 --- a/CMakeLists.txt +++ b/CMakeLists.txt @@ -1,81 +1,110 @@ -cmake_minimum_required(VERSION 3.2) +cmake_minimum_required(VERSION 2.6) +include(FindPkgConfig) # Adding customized cmake module list(APPEND CMAKE_MODULE_PATH "${CMAKE_SOURCE_DIR}/cmake/Modules/") + project(nicaea) - # - # Loading dependencies - # - find_package(FFTW REQUIRED) - find_package(GSL 1.8 REQUIRED) - - include_directories(${GSL_INCLUDE_DIRS} ${FFTW_INCLUDES}) - link_directories(${GSL_LIBRARY_DIRS} ${FFTW_LIBRARY_DIRS}) - - # - # Compilation flags - # - set(CMAKE_C_FLAGS "-Wuninitialized -O3 -fPIC -std=gnu9x") - - # - # Building nicaea library - # - # - include_directories(Cosmo/include Coyote/include halomodel/include tools/include) - FILE(GLOB src_cosmo "${PROJECT_SOURCE_DIR}/Cosmo/src/*.c") - FILE(GLOB src_halo "${PROJECT_SOURCE_DIR}/halomodel/src/*.c") - FILE(GLOB src_coyote "${PROJECT_SOURCE_DIR}/Coyote/src/*.c") - FILE(GLOB src_tools "${PROJECT_SOURCE_DIR}/tools/src/*.c") - add_library(nicaea STATIC ${src_cosmo} ${src_halo} ${src_coyote} ${src_tools}) - target_link_libraries(nicaea ${GSL_LIBRARIES} ${FFTW_LIBRARIES} m) - - # - # Compiling executables - # - # - add_executable(lensingdemo Demo/lensingdemo.c) - target_link_libraries(lensingdemo nicaea) - - add_executable(cmb_bao_demo Demo/cmb_bao_demo.c) - target_link_libraries(cmb_bao_demo nicaea) - - add_executable(cosebi_demo Demo/cosebi_demo.c) - target_link_libraries(cosebi_demo nicaea) - - add_executable(decomp_eb_demo Demo/decomp_eb_demo.c) - target_link_libraries(decomp_eb_demo nicaea) - - add_executable(halomodeldemo Demo/halomodeldemo.c) - target_link_libraries(halomodeldemo nicaea) - - add_executable(sn1ademo Demo/sn1ademo.c) - target_link_libraries(sn1ademo nicaea) - - add_executable(third_order_demo Demo/third_order_demo.c) - target_link_libraries(third_order_demo nicaea) - - - # - # Install (by default in the project directory) - # - set(CMAKE_INSTALL_PREFIX ${PROJECT_SOURCE_DIR}) - - # Install nicaea library - INSTALL(TARGETS nicaea DESTINATION lib) - - # Install nicaea headers - FILE(GLOB inc "${PROJECT_SOURCE_DIR}/tools/include/*.h" "${PROJECT_SOURCE_DIR}/Cosmo/include/*.h" "${PROJECT_SOURCE_DIR}/halomodel/include/*.h" "${PROJECT_SOURCE_DIR}/Coyote/include/*.h") - INSTALL(FILES ${inc} DESTINATION include/nicaea) - - # install nicaea executables - INSTALL(TARGETS lensingdemo cmb_bao_demo decomp_eb_demo halomodeldemo sn1ademo cosebi_demo third_order_demo DESTINATION bin) - - # - # Tests - # - enable_testing() - message("-- Creating test module lensingdemo") - add_test(NAME lensingdemo COMMAND ${CMAKE_INSTALL_PREFIX}/bin/lensingdemo WORKING_DIRECTORY ${PROJECT_SOURCE_DIR}/par_files) - add_test(NAME cmb_bao_demo COMMAND ${CMAKE_INSTALL_PREFIX}/bin/cmb_bao_demo WORKING_DIRECTORY ${PROJECT_SOURCE_DIR}/par_files) +cmake_policy(SET CMP0042 NEW) + +# +# Loading dependencies +# +pkg_check_modules(PKGS REQUIRED fftw3 gsl) +include_directories(${PKGS_INCLUDE_DIRS}) +link_directories(${PKGS_LIBRARY_DIRS}) + + +# +# Compilation flags +# +set(CMAKE_C_FLAGS "-Wall -Wuninitialized -pedantic -O3 -fPIC -std=gnu9x") + + +# +# Building nicaea library +# +# +include_directories(Cosmo/include Coyote/include halomodel/include tools/include) +FILE(GLOB src_cosmo "${PROJECT_SOURCE_DIR}/Cosmo/src/*.c") +FILE(GLOB src_halo "${PROJECT_SOURCE_DIR}/halomodel/src/*.c") +FILE(GLOB src_coyote "${PROJECT_SOURCE_DIR}/Coyote/src/*.c") +FILE(GLOB src_tools "${PROJECT_SOURCE_DIR}/tools/src/*.c") +add_library(nicaea STATIC ${src_cosmo} ${src_halo} ${src_coyote} ${src_tools}) +target_link_libraries(nicaea ${PKGS_LIBRARIES}) + +# +# Build python module +# +# +find_package(PythonLibsNew) +if (NOT PYTHON_LIBRARIES) + message("-- Python library not found, cannot install pynicaea") +endif() +find_package(Boost 1.45.0 COMPONENTS python) +if (NOT Boost_LIBRARIES) + message("-- Boost not found, cannot install pynicaea, continuing...") +endif() +if (PYTHON_LIBRARIES AND Boost_LIBRARIES) + message("-- Adding pynicaea to targets") + INCLUDE_DIRECTORIES(${Boost_INCLUDE_DIRS} ${PYTHON_INCLUDE_DIRS}) + + add_library(pynicaea SHARED python/bindings.cpp python/cosmo.cpp) + target_link_libraries(pynicaea nicaea ${Boost_LIBRARIES} ${PYTHON_LIBRARIES}) + set_target_properties(pynicaea PROPERTIES PREFIX "") + set_target_properties(pynicaea PROPERTIES OUTPUT_NAME "nicaea") +endif() + + +# +# Compiling executables +# +# +add_executable(lensingdemo Demo/lensingdemo.c) +target_link_libraries(lensingdemo nicaea) + +add_executable(cmb_bao_demo Demo/cmb_bao_demo.c) +target_link_libraries(cmb_bao_demo nicaea) + +add_executable(cosebi_demo Demo/cosebi_demo.c) +target_link_libraries(cosebi_demo nicaea) + +add_executable(decomp_eb_demo Demo/decomp_eb_demo.c) +target_link_libraries(decomp_eb_demo nicaea) + +add_executable(halomodeldemo Demo/halomodeldemo.c) +target_link_libraries(halomodeldemo nicaea) + +add_executable(sn1ademo Demo/sn1ademo.c) +target_link_libraries(sn1ademo nicaea) + +add_executable(third_order_demo Demo/third_order_demo.c) +target_link_libraries(third_order_demo nicaea) + + +# +# Install (by default in the project directory) +# +set(CMAKE_INSTALL_PREFIX ${PROJECT_SOURCE_DIR}) + +# Install nicaea library +INSTALL(TARGETS nicaea DESTINATION lib) + +# Install nicaea headers +FILE(GLOB inc "${PROJECT_SOURCE_DIR}/tools/include/*.h" "${PROJECT_SOURCE_DIR}/Cosmo/include/*.h" "${PROJECT_SOURCE_DIR}/halomodel/include/*.h" "${PROJECT_SOURCE_DIR}/Coyote/include/*.h") +INSTALL(FILES ${inc} DESTINATION include/nicaea) + +# install nicaea executables +INSTALL(TARGETS lensingdemo cmb_bao_demo decomp_eb_demo halomodeldemo sn1ademo cosebi_demo third_order_demo DESTINATION bin) + +# +# Tests +# +enable_testing() +message("-- Creating test module lensingdemo") +add_test(NAME lensingdemo COMMAND ${CMAKE_INSTALL_PREFIX}/bin/lensingdemo WORKING_DIRECTORY ${PROJECT_SOURCE_DIR}/par_files) +add_test(NAME cmb_bao_demo COMMAND ${CMAKE_INSTALL_PREFIX}/bin/cmb_bao_demo WORKING_DIRECTORY ${PROJECT_SOURCE_DIR}/par_files) + + diff --git a/Cosmo/include/cmb_bao.h b/Cosmo/include/cmb_bao.h index 75ae5e3..83dba67 100644 --- a/Cosmo/include/cmb_bao.h +++ b/Cosmo/include/cmb_bao.h @@ -6,10 +6,6 @@ #ifndef __CMB_BAO_H #define __CMB_BAO_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include @@ -22,9 +18,6 @@ extern "C" { #include "maths.h" #include "mvdens.h" -#ifdef __cplusplus -namespace nicaea { -#endif double z_star(cosmo *self); double acoustic_scale(cosmo *self, error **err); @@ -38,8 +31,5 @@ double chi2_bao_A(cosmo *model, mvdens *g, const double *z_BAO, error **err); double chi2_bao_d_z(cosmo *model, mvdens *g, const double *z_BAO, error **err); double chi2_bao_D_V_ratio(cosmo *model, mvdens *g, const double *z_BAO, error **err); -#ifdef __cplusplus -}} -#endif #endif diff --git a/Cosmo/include/decomp_eb.h b/Cosmo/include/decomp_eb.h index 8d1df99..e8bf11d 100644 --- a/Cosmo/include/decomp_eb.h +++ b/Cosmo/include/decomp_eb.h @@ -7,10 +7,6 @@ #ifndef __DECOMP_EB_H #define __DECOMP_EB_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include @@ -39,11 +35,6 @@ extern "C" { #define NMAX_COSEBI 20 -#ifdef __cplusplus -namespace nicaea { -#endif - - typedef enum {cheby, cheby2, legen, cosebi} poly_t; #define spoly_t(i) ( \ i==cheby ? "cheby" : \ @@ -114,8 +105,5 @@ double sum_combinations(int j, int n, const double *r, error **err); void xipmEB(double theta, double THETA_MIN, double THETA_MAX, const double *c, const double *E, const double *B, int N, double xi_pm_EB[4], error **err); -#ifdef __cplusplus -}} -#endif #endif diff --git a/Cosmo/include/lensing.h b/Cosmo/include/lensing.h index fd0f7d5..4a7bfe0 100644 --- a/Cosmo/include/lensing.h +++ b/Cosmo/include/lensing.h @@ -7,10 +7,6 @@ #ifndef __LENSING_H #define __LENSING_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -40,10 +36,6 @@ extern "C" { #include "reduced_fit.h" -#ifdef __cplusplus -namespace nicaea { -#endif - /* Dimensions of interpolation tables */ /* N_s was increased from 200 to 400, for linear tabulation of P_kappa */ #define N_s 400 @@ -332,6 +324,9 @@ cosmo_lens* set_cosmological_parameters_to_default_lens(error **err); void free_parameters_lens(cosmo_lens** self); void dump_param_lens(cosmo_lens* self, FILE *F, int wnofz, error **err); +void update_cosmo_lens_par_one(cosmo_lens **self, char spar[], double val, error **err); + + /* ============================================================ * * Lensing functions. * * ============================================================ */ @@ -429,8 +424,6 @@ CHANGE(gamma2); CHANGE(map2); #undef CHANGE -#ifdef __cplusplus -}} -#endif #endif /* __LENSING_H */ + diff --git a/Cosmo/include/lensing_3rd.h b/Cosmo/include/lensing_3rd.h index 4645f6b..e0d13cf 100644 --- a/Cosmo/include/lensing_3rd.h +++ b/Cosmo/include/lensing_3rd.h @@ -6,10 +6,6 @@ #ifndef __LENSING_3RD_H #define __LENSING_3RD_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -51,10 +47,6 @@ extern "C" { #define lensing_3rd_rootbracket -4 + lensing_3rd_base #define lensing_3rd_slc -5 + lensing_3rd_base -#ifdef __cplusplus -namespace nicaea { -#endif - typedef enum {fgauss=0, fpoly=1, ftophat=2, fdelta=3, fxip=4, fxim=5, fall=6} filter_t; typedef enum {PT=0, SCOCOU=1, GM12} bispmode_t; @@ -229,8 +221,7 @@ void fill_dmm_map3gauss(cosmo_3rd *self, double *data_minus_model, int start, co int Ntheta, double *theta, error **err); double chi2_lensing_3rd(cosmo_3rd *self, datcov *dc, const cosebi_info_t *cosebi_info, error **err); -#ifdef __cplusplus -}} -#endif + #endif + diff --git a/Cosmo/include/nofz.h b/Cosmo/include/nofz.h index 0b9d963..b252b8b 100644 --- a/Cosmo/include/nofz.h +++ b/Cosmo/include/nofz.h @@ -6,10 +6,6 @@ #ifndef __NOFZ_H #define __NOFZ_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -39,10 +35,6 @@ extern "C" { * distribution formally goes to infinity. */ #define ZMAX 7 -#ifdef __cplusplus -namespace nicaea { -#endif - /* Distribution types and functions */ typedef enum {ludo, jonben, ymmk, ymmk0const, cfhtlens, hist, single} nofz_t; #define snofz_t(i) ( \ @@ -146,9 +138,5 @@ CHANGE(redshift); int change_zmean(redshift_t *, redshift_t *, error **err); -#ifdef __cplusplus -}} -#endif - #endif diff --git a/Cosmo/include/reduced_fit.h b/Cosmo/include/reduced_fit.h index 5750d7d..dce4267 100644 --- a/Cosmo/include/reduced_fit.h +++ b/Cosmo/include/reduced_fit.h @@ -1,9 +1,6 @@ #ifndef __REDUCED_FIT_H #define __REDUCED_FIT_H -#ifdef __cplusplus -extern "C" { -#endif #include #include @@ -24,9 +21,6 @@ extern "C" { #define N_B 4 #define N_C 4 -#ifdef __cplusplus -namespace nicaea { -#endif extern const double B_fit[M_PAR][N_PL][N_B]; extern const double C_fit[M_PAR][N_POLY][N_C]; @@ -52,8 +46,5 @@ double sum_a_for_Pg1(double logell, double a_min, int Na, double da, const doubl const double dpar[M_PAR]); int check_limits(const double dpar[M_PAR]); -#ifdef __cplusplus -}} -#endif #endif diff --git a/Cosmo/include/sn1a.h b/Cosmo/include/sn1a.h index 632f93d..54f1370 100644 --- a/Cosmo/include/sn1a.h +++ b/Cosmo/include/sn1a.h @@ -6,9 +6,6 @@ #ifndef __SN1A_H #define __SN1A_H -#ifdef __cplusplus -extern "C" { -#endif #include #include @@ -29,10 +26,6 @@ extern "C" { //#define NLCP 3 #define NLCP 4 -#ifdef __cplusplus -namespace nicaea { -#endif - /* Chi^2 methods */ typedef enum {chi2_simple, chi2_Theta2_denom_fixed, chi2_no_sc, chi2_betaz, chi2_dust, chi2_residual} chi2mode_t; #define schi2mode_t(i) ( \ @@ -136,8 +129,4 @@ double chi2_SN(const cosmo_SN *cosmo, const SnSample *sn, mvdens *data_beta_d, double distance_module(cosmo *self, double dlum, error **err); -#ifdef __cplusplus -}} -#endif - #endif /* __SN1A_H */ diff --git a/Cosmo/src/lensing.c b/Cosmo/src/lensing.c index 282ae92..18bb15f 100644 --- a/Cosmo/src/lensing.c +++ b/Cosmo/src/lensing.c @@ -206,7 +206,6 @@ void read_cosmological_parameters_lens(cosmo_lens **self, FILE *F, error **err) tmp = set_cosmological_parameters_to_default_lens(err); forwardError(*err, __LINE__,); - /* Cosmological parameters */ CONFIG_READ_S(&tmp2, cosmo_file, s, F, c, err); if (strcmp(tmp2.cosmo_file, "-")!=0) { @@ -219,7 +218,6 @@ void read_cosmological_parameters_lens(cosmo_lens **self, FILE *F, error **err) forwardError(*err, __LINE__,); if (strcmp(tmp2.cosmo_file, "-")!=0) fclose(FD); - /* Redshift parameters */ CONFIG_READ_S(&tmp2, nofz_file, s, F, c, err); if (strcmp(tmp2.nofz_file, "-")!=0) { @@ -232,7 +230,6 @@ void read_cosmological_parameters_lens(cosmo_lens **self, FILE *F, error **err) forwardError(*err, __LINE__,); if (strcmp(tmp2.nofz_file, "-")!=0) fclose(FD); - /* Lensing parameters */ CONFIG_READ_S(&tmp2, stomo, s, F, c, err); STRING2ENUM(tmp->tomo, tmp2.stomo, tomo_t, stomo_t, j, Ntomo_t, err); @@ -263,7 +260,6 @@ void read_cosmological_parameters_lens(cosmo_lens **self, FILE *F, error **err) } - *self = copy_parameters_lens_only(tmp, err); forwardError(*err, __LINE__,); @@ -388,6 +384,30 @@ void dump_param_lens(cosmo_lens* self, FILE *F, int wnofz, error **err) if (self->cosmo->nonlinear==halodm) dump_param_only_hm(self->hm, F); } + +void update_cosmo_lens_par_one(cosmo_lens **self, char spar[], double val, error **err) +{ + cosmo_lens *tmp; + tmp = copy_parameters_lens_only(*self, err); + forwardError(*err, __LINE__,); + + if (strcmp(spar, "Omega_m") == 0) { + tmp->cosmo->Omega_m = val; + tmp->cosmo->Omega_de = 1.0 - val; // Flat universe + } else if (strcmp(spar, "sigma_8") == 0) { + testErrorRet(tmp->cosmo->normmode != 0, ce_wrongValue, "cosmo.par:normmode has to be 0 to use sigma_8 as on-the-fly parameter", *err, __LINE__,); + tmp->cosmo->normalization = val; + } else { + *err = addErrorVA(ce_unknown, "Unsupported on-the-fly parameter %s", *err, __LINE__, spar); + } + + free_parameters_lens(self); + *self = copy_parameters_lens_only(tmp, err); + forwardError(*err, __LINE__,); + + free_parameters_lens(&tmp); +} + double int_for_g(double aprime, void *intpar, error **err) { cosmo_lensANDintANDdouble* cANDdANDe; @@ -608,7 +628,6 @@ double w_limber2(cosmo_lens *self, double wa, double a, int n_bin, int interp, e for (i=0; icosmo, exp(w_arr[i]), err); - forwardError(*err, __LINE__, -1.0); } for (i=0; iia) { - case ia_3rd_S08 : - if (self->ia_terms == ia_GGI_GII_III || self->ia_terms == ia_only_GGI) { - GGI = map3_GGI(self, R[0], err); - forwardError(*err,__LINE__,0.0); - } - if (self->ia_terms == ia_GGI_GII_III || self->ia_terms == ia_only_GII) { - GII = map3_GII(self, R[0], err); - forwardError(*err,__LINE__,0.0); - } - break; + case ia_3rd_S08 : + if (self->ia_terms == ia_GGI_GII_III || self->ia_terms == ia_only_GGI) { + GGI = map3_GGI(self, R[0], err); + forwardError(*err,__LINE__,0.0); + } + if (self->ia_terms == ia_GGI_GII_III || self->ia_terms == ia_only_GII) { + GII = map3_GII(self, R[0], err); + forwardError(*err,__LINE__,0.0); + } + break; - default : - break; + default : + break; } /* Source-lens clustering */ - SLC = 0.0; switch (self->slc) { - case slc_FK13 : - testErrorRet(i_bin != j_bin || j_bin != k_bin, lensing_tomoij, - "SLC (mode 'slc_FK13') not implemented for tomography", - *err, __LINE__, 0.0); - SLC = map3_SLC_t1(self, R[0], i_bin, err); - forwardError(*err,__LINE__,0.0); - break; + case slc_FK13 : + testErrorRet(i_bin != j_bin || j_bin != k_bin, lensing_tomoij, + "SLC (mode 'slc_FK13') not implemented for tomography", + *err, __LINE__, 0.0); + SLC = map3_SLC_t1(self, R[0], i_bin, err); + forwardError(*err,__LINE__,0.0); + break; - default : - break; + default : + break; } @@ -1403,18 +1403,18 @@ double map3(cosmo_3rd *self, double R[3], int i_bin, int j_bin, int k_bin, filte /* General skewness, sum up three permutations */ for (i=0; i<3; i++) myR[i] = R[i]; for (i=0,m3=0.0; i<3; i++) { - m3 += map3_perm(self, myR, i_bin, j_bin, k_bin, wfilter, err); - forwardError(*err,__LINE__,0); - permute3(myR, 0); + m3 += map3_perm(self, myR, i_bin, j_bin, k_bin, wfilter, err); + forwardError(*err,__LINE__,0); + permute3(myR, 0); } testErrorRet(self->ia != ia_3rd_undef, lensing_ia, - "Intrinsic aligment for general skewness not yet known", - *err, __LINE__, 0.0); + "Intrinsic aligment for general skewness not yet known", + *err, __LINE__, 0.0); testErrorRet(self->slc != slc_none, lensing_3rd_slc, - "Intrinsic aligment for general skewness not yet known", - *err, __LINE__, 0.0); + "Intrinsic aligment for general skewness not yet known", + *err, __LINE__, 0.0); } diff --git a/Cosmo/src/nofz.c b/Cosmo/src/nofz.c index 6382bbd..52d715e 100644 --- a/Cosmo/src/nofz.c +++ b/Cosmo/src/nofz.c @@ -13,7 +13,7 @@ redshift_t *init_redshift_empty(int Nzbin, int Nnz_max, error **err) redshift_t *res; res = malloc_err(sizeof(redshift_t), err); forwardError(*err, __LINE__, NULL); - + res->Nzbin = Nzbin; res->Nnz = calloc_err(Nzbin, sizeof(int), err); forwardError(*err, __LINE__, NULL); res->Nnz_max = Nnz_max; @@ -57,7 +57,7 @@ redshift_t *init_redshift(int Nzbin, const int *Nnz, const nofz_t *nofz, const p for (n=0,res->Nnz_max=-1; nNnz[n]>res->Nnz_max) res->Nnz_max = res->Nnz[n]; } - + res->nofz = malloc_err(Nzbin*sizeof(nofz_t), err); forwardError(*err, __LINE__, NULL); memcpy(res->nofz, nofz, Nzbin*sizeof(nofz_t)); @@ -339,7 +339,7 @@ double *read_par_nz_hist(const char *name, int *Nnz, error **err) int i, n, nread; double *par_nz, dummy; char str[1024]; - char *dummy2; + char *dummy2 = NULL; size_t size; /* Number of lines */ @@ -368,7 +368,8 @@ double *read_par_nz_hist(const char *name, int *Nnz, error **err) rewind(F); /* Header line */ - fscanf(F, "%*[^\n]\n", NULL); + getline(&dummy2, &size, F); + free(dummy2); nread = fscanf(F, "%lg %lg\n", par_nz, par_nz+n+1); /* z_0 n_0 */ testErrorRetVA(nread!=2, io_file, "Error while reading n(z) file ('%s'): two doubles expected (first line)", @@ -640,7 +641,7 @@ double prob_unnorm(double z, void *intpar, sm2_error **err) epsabs = 1.0e-6; epsrel = 1.0e-3; w = gsl_integration_workspace_alloc(n); - F.function = &dpn_dz; + F.function = &dpn_dz; F.params = (void*)¶ms_photz; status = gsl_integration_qng(&F, get_zmin_ph(self, n_bin), get_zmax_ph(self, n_bin), epsabs, epsrel, &res, &abserr, &neval); @@ -686,7 +687,7 @@ double gaussian(double z, double mu, double sigma) res = exp(-0.5 * dsqr((z - mu)/sigma)) / sqrt(twopi) / sigma; - return res; + return res; } double prob_photz(double z, double zp, photz_t photz, const double *par_pz, error **err) @@ -873,7 +874,7 @@ double prob(redshift_t *self, double z, int n_bin, error **err) zz = z*self->z_rescale[n_bin]; testErrorRet(zz<0, ce_negative, "Negative redshift z", *err, __LINE__ , 0); - + rANDi.self = self; rANDi.i = n_bin; @@ -924,7 +925,7 @@ double int_for_zmean(double z, void *intpar, error **err) res = z*p; - return res; + return res; } #define EPS 1.0e-5 @@ -960,7 +961,7 @@ double zmean(redshift_t *self, int n_bin, error **err) res = sm2_qromberg(int_for_zmean, (void*)&rANDi, zmin, zmax, 1.0e-6, err); forwardError(*err, __LINE__, 0); - return res; + return res; } double zmedian(redshift_t *self, int n_bin, error **err) diff --git a/Coyote/include/constants.h b/Coyote/include/constants.h index 9d70cde..2f80384 100644 --- a/Coyote/include/constants.h +++ b/Coyote/include/constants.h @@ -14,14 +14,6 @@ #define peta 5 #define rs 6 -#ifdef __cplusplus -extern "C" { -#endif - -#ifdef __cplusplus -namespace nicaea { -#endif - const double ksim[nsim]; const double kemu[1000]; @@ -34,8 +26,7 @@ const double w_coyote[peta][m]; const double KrigBasis[peta][m]; /* The above defined quantities are undefined at the end of emu.c */ -#ifdef __cplusplus -}} -#endif #endif + + diff --git a/Coyote/include/coyote.h b/Coyote/include/coyote.h index e1ac62b..049489d 100644 --- a/Coyote/include/coyote.h +++ b/Coyote/include/coyote.h @@ -1,9 +1,8 @@ #ifndef __COYOTE_H #define __COYOTE_H -#ifdef __cplusplus -extern "C" { -#endif + + #include #include @@ -20,10 +19,6 @@ extern "C" { #include "maths.h" -#ifdef __cplusplus -namespace nicaea { -#endif - /* Error codes */ #define coyote_base -2200 #define coyote_h -1 + coyote_base @@ -73,8 +68,4 @@ void fill_xstar6_wo_z(double omega_m, double omega_b, double n_spec, double sigm double xstar[]); -#ifdef __cplusplus -}} -#endif - #endif diff --git a/Coyote/include/fr_constants.h b/Coyote/include/fr_constants.h index d4ca73f..813cd69 100644 --- a/Coyote/include/fr_constants.h +++ b/Coyote/include/fr_constants.h @@ -3,6 +3,7 @@ * Martin Kilbinger 2013 * * Constants from .h files in FrankenEmu. * * ==================================================== */ + #ifndef __FR_CONSTANTS_H #define __FR_CONSTANTS_H @@ -20,14 +21,6 @@ /* neta_over_rs = neta / rs */ # define neta_over_rs 500 -#ifdef __cplusplus -extern "C" { -#endif - -#ifdef __cplusplus -namespace nicaea { -#endif - const double fr_ksim[fr_nsim]; const double fr_kemu[neta_over_rs]; /* MKDEBUG: Size was 1000 in original Coyote emulator, for some reason */ @@ -43,8 +36,5 @@ const double fr_KrigBasis[peta][m]; /* The above defined quantities are undefined at the end of emu.c */ -#ifdef __cplusplus -}} #endif -#endif diff --git a/Demo/lensingdemo.c b/Demo/lensingdemo.c index 30d649d..8fba4d8 100644 --- a/Demo/lensingdemo.c +++ b/Demo/lensingdemo.c @@ -167,7 +167,11 @@ void usage(int ex) fprintf(stderr, " -L 'L_MIN L_MAX NL' NL Fourier modes between L_MIN and L_MAX (default: '%g %g %d')\n", ELL_MIN, ELL_MAX, NELL); fprintf(stderr, " --linlog MODE Linear (MODE='LIN') or logarithmic ('LOG'; default) bins for xi+, xi-\n"); fprintf(stderr, " -D DIM Dimensionless (DIM=1; default) or dimensional (DIM=0) 3D power spectrum\n"); - fprintf(stderr, " -H LEVEL Output file header level: 0 (no header), 1 (one line of column description), 2 (full; default)\n"); + fprintf(stderr, " --Omega_m VAL Use Omega_m=VAL instead of value from cosmo.par\n"); + fprintf(stderr, " --sigma_8 VAL Use sigma_8=VAL instead of value from cosmo.par\n"); + fprintf(stderr, " --out_suf SUF Suffix SUF appended to all output file names\n"); + fprintf(stderr, " -H LEVEL Output file header level: 0 (no header), 1 (one line of column\n"); + fprintf(stderr, " description), 2 (full; default)\n"); fprintf(stderr, " -q Quiet mode\n"); fprintf(stderr, " -h This message\n"); @@ -178,14 +182,15 @@ void usage(int ex) int main(int argc, char** argv) { cosmo_lens* model; - double k, logk, ell, theta, a, pk, pg, f, z, cumG, Ga, ww, incr; + double k, ell, theta, a, pk, pg, f, z, incr; int i_bin, j_bin, Nzbin, c, dimensionless, verbose, lin, header, iell; error *myerr = NULL, **err; - char *theta_fname, *theta_info, *ell_info, *substr, *slinlog; + char *theta_fname, *theta_info, *ell_info, *substr, *slinlog, *sOmega_m, *ssigma_8, *out_suf, out_name[1024]; FILE *F; size_t Nrec, Ntheta, Nell; double *theta_list, Theta_min, Theta_max, ell_min, ell_max, ell_fac; double z_mean, z_median; + int calc_P_delta, calc_n_of_z, calc_P_kappa_d, calc_P_kappa_c, calc_xi_pm, calc_gamma2, calc_map2; err = &myerr; @@ -193,10 +198,14 @@ int main(int argc, char** argv) theta_fname = theta_info = ell_info = NULL; slinlog = "LOG"; + sOmega_m = ssigma_8 = ""; dimensionless = 1; verbose = 1; lin = 0; header = 2; + calc_P_delta = calc_n_of_z = calc_P_kappa_d = calc_P_kappa_c = calc_xi_pm = calc_gamma2 = calc_map2 = 0; + calc_P_kappa_c = 1; + out_suf = NULL; while (1) { static struct option long_option[] = { @@ -206,6 +215,9 @@ int main(int argc, char** argv) {"", required_argument, 0, 'D'}, {"", required_argument, 0, 'H'}, {"linlog", required_argument, 0, 'l'}, + {"Omega_m", required_argument, 0, 'O'}, + {"sigma_8", required_argument, 0, 's'}, + {"out_suf", required_argument, 0, 'S'}, {0, 0, 0, 0} }; @@ -228,6 +240,15 @@ int main(int argc, char** argv) case 'D': dimensionless = atoi(optarg); break; + case 'O': + sOmega_m = optarg; + break; + case 's': + ssigma_8 = optarg; + break; + case 'S': + out_suf = optarg; + break; case 'H': header = atoi(optarg); break; @@ -246,7 +267,7 @@ int main(int argc, char** argv) end_arg: if (verbose) { - printf("# lensingdemo (M. Kilbinger, 2006-2012)\n"); + printf("# lensingdemo (M. Kilbinger, 2006-2018)\n"); } if (dimensionless > 0) { @@ -262,6 +283,11 @@ int main(int argc, char** argv) exit(1); } + if (out_suf==NULL) { + out_suf = (char*)malloc_err(512*sizeof(char), err); + quitOnError(*err, __LINE__, stderr); + strcpy(out_suf, ""); + } /* Setting up cosmology */ @@ -274,6 +300,16 @@ int main(int argc, char** argv) Nzbin = model->redshift->Nzbin; + /* On-the-fly (command line) update of parameters */ +#define Nspar 2 + char *spar[Nspar] = {sOmega_m, ssigma_8}; + char *sname[Nspar] = {"Omega_m", "sigma_8"}; + for (c=0; ccosmo, F); - for (a=0.01; a<1.0; a+=0.01) { - fprintf(F, "%f %f\n", a, w_de(model->cosmo, a, err)); - quitOnError(*err, __LINE__, stderr); - } - fclose(F); - - /* Growth factor */ - F = fopen("D_plus", "w"); - for (a=0.1; a<1.0; a+=0.01) { - fprintf(F, "%f %.6f\n", a, D_plus(model->cosmo, a, 1, err)); - quitOnError(*err, __LINE__, stderr); - } - fclose(F); - - /* IST WL code comparison */ - char name[1024]; - int cc_case = 2; - char author_id[] = "MKNic"; - - // WL_case_C0 - /* - F = fopen("growthfac-MK.dat", "w"); - for (z=0.0; z<2.5; z+=0.01) { - a = 1.0 / (1.0 + z); - fprintf(F, "%f %.6f\n", z, D_plus(model->cosmo, a, 1, err)); - quitOnError(*err, __LINE__, stderr); - } - fclose(F); - */ - - // lensing efficiency - sprintf(name, "lensw-C%d-%s.dat", cc_case, author_id); - F = fopen(name, "w"); - for (z=0.0; z<1.0; z+=0.01) { - fprintf(F, "%g", z); - a = 1.0 / (1.0 + z); - for (i_bin=0; i_bin0.1; a-=0.01) { - ww = w(model->cosmo, a, 0, err); - quitOnError(*err, __LINE__, stderr); - Ga = G(model, a, 0, err); - quitOnError(*err, __LINE__, stderr); - cumG += Ga * ww; - fprintf(F, "%f %g %g %g\n", a, Ga * ww, cumG, ww); - } - fclose(F); - - /* a(w) */ - F = fopen("a_of_w", "w"); - fprintf(F, "# a w(a)\n"); - double wmax = w(model->cosmo, model->cosmo->a_min, 0, err); - quitOnError(*err, __LINE__, stderr); - for (ww=0; wwcosmo, ww, err); - quitOnError(*err, __LINE__, stderr); - fprintf(F, "%g %g\n", ww, a); - } - - /* w_limber2 */ - double w0, w0i, w1, w2, w3; - F = fopen("w_limber2", "w"); - fprintf(F, "# chi wl2(chi) wl2(chi, interp) wl2' wl2'' wl2'''\n"); - for (ww=0.01; wwcosmo->nonlinear == coyote10) { - set_H0_Coyote(model->cosmo, err); - quitOnError(*err, __LINE__, stderr); if (verbose) { - printf("Coyote10: Hubble parameter set to h = %g\n", model->cosmo->h_100); + printf("Calculating density power spectrum, writing file P_delta\n"); } - } - F = fopen("P_delta", "w"); - if (header >= 2) { - dump_param(model->cosmo, F); - quitOnError(*err, __LINE__, stderr); + if (model->cosmo->nonlinear == coyote10) { + set_H0_Coyote(model->cosmo, err); + quitOnError(*err, __LINE__, stderr); + if (verbose) { + printf("Coyote10: Hubble parameter set to h = %g\n", model->cosmo->h_100); + } + } - if (dimensionless == 0) { - fprintf(F, "# k[h/Mpc] P_NL(k,a)[(Mpc/h)^3]\n"); - } else { - fprintf(F, "# k[h/Mpc] Delta_NL(k,a)\n"); + F = fopen("P_delta", "w"); + if (header >= 2) { + dump_param(model->cosmo, F); + + if (dimensionless == 0) { + fprintf(F, "# k[h/Mpc] P_NL(k,a)[(Mpc/h)^3]\n"); + } else { + fprintf(F, "# k[h/Mpc] Delta_NL(k,a)\n"); + } } - } - if (header >= 1) { - fprintf(F, "# k "); - for (a=1.0; a>=0.5; a-=0.5) { - fprintf(F, " a=%g", a); + if (header >= 1) { + fprintf(F, "# k "); + for (a=1.0; a>=0.5; a-=0.5) { + fprintf(F, " a=%g", a); + } + fprintf(F, "\n"); } - fprintf(F, "\n"); - } - for (k=0.0001; k<=100.0; k*=1.05) { - if (dimensionless == 0) { - f = 1.0; - } else { - f = k*k*k/(2.0*pi_sqr); - } - fprintf(F, "%e ", k); - for (a=1.0; a>=0.5; a-=0.5) { - if (a > model->cosmo->a_min) { - fprintf(F, "%e ", P_NL(model->cosmo, a, k, err)*f); - quitOnError(*err, __LINE__, stderr); + for (k=0.0001; k<=100.0; k*=1.05) { + if (dimensionless == 0) { + f = 1.0; } else { - fprintf(F, "undef "); - } + f = k*k*k/(2.0*pi_sqr); + } + fprintf(F, "%e ", k); + for (a=1.0; a>=0.5; a-=0.5) { + if (a > model->cosmo->a_min) { + fprintf(F, "%e ", P_NL(model->cosmo, a, k, err)*f); + quitOnError(*err, __LINE__, stderr); + } else { + fprintf(F, "undef "); + } + } + fprintf(F, "\n"); } - fprintf(F, "\n"); - quitOnError(*err, __LINE__, stderr); - } - fclose(F); - - // WL_case_C0 - F = fopen("pkzero-lin-MK.dat", "w"); - quitOnError(*err, __LINE__, stderr); - - for (logk=-3; logk<=1.0; logk+=0.01) { - k = pow(10, logk) / model->cosmo->h_100; // k [Mpc^[-1] = k/h [h/Mpc] - pk = P_L(model->cosmo, 1.0, k, err) / pow(model->cosmo->h_100, 3); // Pk [Mpc^3/h^3] = Pk/h^3 - quitOnError(*err, __LINE__, stderr); - fprintf(F, "%8g %8g\n", logk, log10(pk)); - } - fclose(F); - - // XC_case_C1 - F = fopen("P_delta_nicaea_XC_1.dat", "w"); - quitOnError(*err, __LINE__, stderr); + fclose(F); - for (logk=-5; logk<=3.0; logk+=0.01) { - k = pow(10, logk); // / model->cosmo->h_100; // k [Mpc^[-1] = k/h [h/Mpc] - pk = P_L(model->cosmo, 0.5, k, err); // / pow(model->cosmo->h_100, 3); // Pk [Mpc^3/h^3] = Pk/h^3 - quitOnError(*err, __LINE__, stderr); - fprintf(F, "%8g %8g\n", k, pk); } - fclose(F); + if (calc_n_of_z) { - - /* Redshift distribution */ - if (verbose) { - printf("Printing redshift distribution to file nz\n"); - } - F = fopen("nz", "w"); - dump_param_lens(model, F, 1, err); - quitOnError(*err, __LINE__, stderr); - - for (z=0; z<=10; z+=0.01) { - fprintf(F, "%.3f", z); - for (i_bin=0; i_binredshift, z, i_bin, err)); - quitOnError(*err, __LINE__, stderr); + /* Redshift distribution */ + if (verbose) { + printf("Printing redshift distribution to file nz\n"); } - fprintf(F, "\n"); - } - fclose(F); - - //nofz_bins_equal_number(model->redshift, err); quitOnError(*err, __LINE__, stderr); - - /* Convergence power spectrum */ - - if (verbose) { - printf("Calculating convergence power spectrum for discrete ell, writing file P_kappa_d\n"); - } + F = fopen("nz", "w"); + dump_param_lens(model, F, 1, err); + quitOnError(*err, __LINE__, stderr); - F = fopen("P_kappa_d", "w"); - write_header_p_kappa(F, header, model, dimensionless, Nzbin, err); - quitOnError(*err, __LINE__, stderr); - iell = 2; - //while (iell <= 1e5) { - while (iell < 400) { - if (dimensionless == 0) { - f = 1.0; - } else { - f = iell*(iell+1.0)/twopi; - } - fprintf(F, "%d ", iell); - for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - pk = Pshear_spherical(model, iell, i_bin, j_bin, err); + for (z=0; z<=10; z+=0.01) { + fprintf(F, "%.3f", z); + for (i_bin=0; i_binredshift, z, i_bin, err)); quitOnError(*err, __LINE__, stderr); - fprintf(F, " %e", pk*f); } + fprintf(F, "\n"); } + fclose(F); - fprintf(F, "\n"); - fflush(F); - - //iell++; - if (iell<=10) iell++; - else if (iell<=20) iell += 2; - else if (iell<=50) iell += 5; - else iell += 10; } - fclose(F); + /* Convergence power spectrum */ - if (model->projection != full) { + if (calc_P_kappa_d) { if (verbose) { - printf("Calculating convergence power spectrum for continuous ell, writing file P_kappa\n"); + printf("Calculating convergence power spectrum for discrete ell, writing file P_kappa_d\n"); } - F = fopen("P_kappa", "w"); + F = fopen("P_kappa_d", "w"); write_header_p_kappa(F, header, model, dimensionless, Nzbin, err); quitOnError(*err, __LINE__, stderr); - - if (ell_info != NULL) { - substr = strsep(&ell_info, " "); ell_min = atof(substr); - substr = strsep(&ell_info, " "); ell_max = atof(substr); - substr = strsep(&ell_info, " "); Nell = atoi(substr); - } else { - ell_min = ELL_MIN; - ell_max = ELL_MAX; - Nell = NELL; - } - ell_fac = pow( ell_max / ell_min, 1.0 / ((double)Nell - 1)); - - - for (ell=ell_min; ell<=ell_max*1.001; ell*=ell_fac) { + iell = 2; + while (iell < 400) { if (dimensionless == 0) { f = 1.0; } else { - f = ell*(ell+1.0)/twopi; + f = iell*(iell+1.0)/twopi; } - fprintf(F, "%e ", ell); + fprintf(F, "%d ", iell); for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - pk = Pshear(model, ell, i_bin, j_bin, err); - if (getErrorValue(*err)==reduced_fourier_limit) { - purgeError(err); - } + pk = Pshear_spherical(model, iell, i_bin, j_bin, err); quitOnError(*err, __LINE__, stderr); fprintf(F, " %e", pk*f); } } - fprintf(F, " "); - if (model->reduced!=reduced_none) { + fprintf(F, "\n"); + fflush(F); + + if (iell<=10) iell++; + else if (iell<=20) iell += 2; + else if (iell<=50) iell += 5; + else iell += 10; + } + + fclose(F); + + } + + if (calc_P_kappa_c) { + + if (model->projection != full) { + + if (verbose) { + printf("Calculating convergence power spectrum for continuous ell, writing file P_kappa\n"); + } + + sprintf(out_name, "%s%s", "P_kappa", out_suf); + F = fopen(out_name, "w"); + write_header_p_kappa(F, header, model, dimensionless, Nzbin, err); + quitOnError(*err, __LINE__, stderr); + + if (ell_info != NULL) { + substr = strsep(&ell_info, " "); ell_min = atof(substr); + substr = strsep(&ell_info, " "); ell_max = atof(substr); + substr = strsep(&ell_info, " "); Nell = atoi(substr); + } else { + ell_min = ELL_MIN; + ell_max = ELL_MAX; + Nell = NELL; + } + ell_fac = pow( ell_max / ell_min, 1.0 / ((double)Nell - 1)); + + + for (ell=ell_min; ell<=ell_max*1.001; ell*=ell_fac) { + if (dimensionless == 0) { + f = 1.0; + } else { + f = ell*(ell+1.0)/twopi; + } + fprintf(F, "%e ", ell); for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - pg = Pg1(model, ell, i_bin, j_bin, err); + pk = Pshear(model, ell, i_bin, j_bin, err); if (getErrorValue(*err)==reduced_fourier_limit) { purgeError(err); } quitOnError(*err, __LINE__, stderr); - fprintf(F, " %e", pg*f); + fprintf(F, " %e", pk*f); } } + fprintf(F, " "); + + if (model->reduced!=reduced_none) { + for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + pg = Pg1(model, ell, i_bin, j_bin, err); + if (getErrorValue(*err)==reduced_fourier_limit) { + purgeError(err); + } + quitOnError(*err, __LINE__, stderr); + fprintf(F, " %e", pg*f); + } + } + } + + fprintf(F, "\n"); } - fprintf(F, "\n"); - } + fclose(F); - fclose(F); + } else { - } else { + printf("For projection = full, real-space correlation functions are not yet implemented, exiting now...\n"); + return 0; + } - printf("For projection = full, real-space correlation functions are not yet implemented, exiting now...\n"); - return 0; } - /* Shear correlation functions */ - if (theta_fname != NULL) { + if (calc_xi_pm) { - Nrec = 0; - theta_list = (double*)read_any_list_count(theta_fname, &Nrec, "%lg", sizeof(double), &Ntheta, err); - quitOnError(*err, __LINE__, stderr); + if (theta_fname != NULL) { - } else { + Nrec = 0; + theta_list = (double*)read_any_list_count(theta_fname, &Nrec, "%lg", sizeof(double), &Ntheta, err); + quitOnError(*err, __LINE__, stderr); - /* Create angular bins */ - if (theta_info != NULL) { - substr = strsep(&theta_info, " "); Theta_min = atof(substr); - substr = strsep(&theta_info, " "); Theta_max = atof(substr); - substr = strsep(&theta_info, " "); Ntheta = atoi(substr); } else { - Theta_min = TH_MIN; - Theta_max = TH_MAX; - Ntheta = NTHETA; - } - theta_list = malloc_err(sizeof(double) * Ntheta, err); - quitOnError(*err, __LINE__, stderr); - for (c=0; c= 2) { + dump_param_lens(model, F, 1, err); + quitOnError(*err, __LINE__, stderr); + } + if (header >= 1) { + fprintf(F, "# theta[arcmin] xi+^{mn}(theta)\n# th['] "); + for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " %d%d", i_bin, j_bin); + } + } + fprintf(F, "\n"); + } - if (verbose) { - printf("Calculating shear correlation function, writing files xi_p, xi_m\n"); - } + for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " %e", xi(model, +1, theta, i_bin, j_bin, err)); + quitOnError(*err, __LINE__, stderr); + } + } + fprintf(F, "\n"); + } + fclose(F); - F = fopen("xi_p", "w"); - if (header >= 2) { - dump_param_lens(model, F, 1, err); - quitOnError(*err, __LINE__, stderr); - } - if (header >= 1) { - fprintf(F, "# theta[arcmin] xi+^{mn}(theta)\n# th['] "); - for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %d%d", i_bin, j_bin); + F = fopen("xi_m", "w"); + if (header >= 2) { + dump_param_lens(model, F, 1, err); + quitOnError(*err, __LINE__, stderr); + } + if (header >= 1) { + fprintf(F, "# theta[arcmin] xi-^{mn}(theta)\n# th['] "); + for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " %d%d", i_bin, j_bin); + } } + fprintf(F, "\n"); } - fprintf(F, "\n"); - } - for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %e", xi(model, +1, theta, i_bin, j_bin, err)); - quitOnError(*err, __LINE__, stderr); + for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " %e", xi(model, -1, theta, i_bin, j_bin, err)); + quitOnError(*err, __LINE__, stderr); + } } + fprintf(F, "\n"); } - fprintf(F, "\n"); + fclose(F); + } - fclose(F); - F = fopen("xi_m", "w"); - if (header >= 2) { + if (calc_gamma2) { + + /* Tophat shear variance */ + + if (verbose) { + printf("Calculating tophat shear variance, writing file gammasqr\n"); + } + + F = fopen("gammasqr", "w"); dump_param_lens(model, F, 1, err); quitOnError(*err, __LINE__, stderr); - } - if (header >= 1) { - fprintf(F, "# theta[arcmin] xi-^{mn}(theta)\n# th['] "); + + fprintf(F, "# theta[arcmin] <|gamma|^2>^{mn}(theta)\n# "); for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; @@ -669,137 +646,106 @@ int main(int argc, char** argv) } } fprintf(F, "\n"); - } - for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %e", xi(model, -1, theta, i_bin, j_bin, err)); - quitOnError(*err, __LINE__, stderr); + for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " %e", gamma2(model, theta, i_bin, j_bin, err)); + quitOnError(*err, __LINE__, stderr); + } } + fprintf(F, "\n"); } - fprintf(F, "\n"); + fclose(F); + } - fclose(F); - /* Tophat shear variance */ + if (calc_map2) { - if (verbose) { - printf("Calculating tophat shear variance, writing file gammasqr\n"); - } + /* Aperture mass variance */ - F = fopen("gammasqr", "w"); - dump_param_lens(model, F, 1, err); - quitOnError(*err, __LINE__, stderr); + if (verbose) { + printf("Calculating aperture mass variance (polynomial filter), writing files mapsqr, mapsqr_gauss\n"); + } + + F = fopen("mapsqr", "w"); + if (header >= 2) { + dump_param_lens(model, F, 1, err); + quitOnError(*err, __LINE__, stderr); - fprintf(F, "# theta[arcmin] <|gamma|^2>^{mn}(theta)\n# "); - for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %d%d", i_bin, j_bin); + fprintf(F, "# M = (theta){polynomial}\n"); } - } - fprintf(F, "\n"); - for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %e", gamma2(model, theta, i_bin, j_bin, err)); - quitOnError(*err, __LINE__, stderr); + if (header >= 1) { + fprintf(F, "# theta[arcmin]"); + for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " M^{%d,%d}", i_bin, j_bin); + } } + fprintf(F, "\n"); } - fprintf(F, "\n"); - } - fclose(F); - - /* Aperture mass variance */ - - if (verbose) { - printf("Calculating aperture mass variance (polynomial filter), writing files mapsqr, mapsqr_gauss\n"); - } + for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " %e", map2_poly(model, theta, i_bin, j_bin, err)); + quitOnError(*err, __LINE__, stderr); + } + } + fprintf(F, "\n"); + } + fclose(F); - F = fopen("mapsqr", "w"); - if (header >= 2) { + F = fopen("mapsqr_gauss", "w"); dump_param_lens(model, F, 1, err); quitOnError(*err, __LINE__, stderr); - fprintf(F, "# M = (theta){polynomial}\n"); - } - - if (header >= 1) { - fprintf(F, "# theta[arcmin]"); + fprintf(F, "# theta[arcmin] ^{mn}(theta){Gaussian}\n# "); for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " M^{%d,%d}", i_bin, j_bin); + fprintf(F, " %d%d", i_bin, j_bin); } } fprintf(F, "\n"); - } - for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %e", map2_poly(model, theta, i_bin, j_bin, err)); - quitOnError(*err, __LINE__, stderr); + for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; + if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; + fprintf(F, " %e", map2_gauss(model, theta, i_bin, j_bin, err)); + quitOnError(*err, __LINE__, stderr); + } } + fprintf(F, "\n"); } - fprintf(F, "\n"); - } - fclose(F); - - F = fopen("mapsqr_gauss", "w"); - dump_param_lens(model, F, 1, err); - quitOnError(*err, __LINE__, stderr); + fclose(F); - fprintf(F, "# theta[arcmin] ^{mn}(theta){Gaussian}\n# "); - for (i_bin=0; i_bintomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %d%d", i_bin, j_bin); - } } - fprintf(F, "\n"); - for (c=0; ctomo==tomo_auto_only && i_bin!=j_bin) continue; - if (model->tomo==tomo_cross_only && i_bin==j_bin) continue; - fprintf(F, " %e", map2_gauss(model, theta, i_bin, j_bin, err)); - quitOnError(*err, __LINE__, stderr); - } - } - fprintf(F, "\n"); - } - fclose(F); + free_parameters_lens(&model); if (verbose) { printf("Done\n"); } - free_parameters_lens(&model); - return 0; } #undef TH_MIN @@ -808,3 +754,4 @@ int main(int argc, char** argv) #undef ELL_MIN #undef ELL_MAX #undef NELL +#undef Nspar diff --git a/docs/.nicaea_2.7.rst.swp b/docs/.nicaea_2.7.rst.swp deleted file mode 100644 index ceebd0c..0000000 Binary files a/docs/.nicaea_2.7.rst.swp and /dev/null differ diff --git a/docs/astro.bib b/docs/astro.bib index 326a8f5..1aeda97 100644 --- a/docs/astro.bib +++ b/docs/astro.bib @@ -7,12 +7,110 @@ @string{apjs %%%%%%% My refereed publications (also in preparation/submitted) +@ARTICLE{pujol_shear_bias_17, + author = {{Pujol}, A. and {Sureau}, F. and {Bobin}, J. and {Courbin}, F. and + {Gentile}, M. and {Kilbinger}, M.}, + title = "{Shear measurement bias: dependencies on methods, simulation parameters and measured parameters}", + journal = {Submitted to \aap}, +archivePrefix = "arXiv", + note = {Also arXiv:1707.01285}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = jul, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv170701285P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{LK17, + author = {{Lin}, C.-A. and {Kilbinger}, M.}, + title = "{Quantifying systematics from the shear inversion on weak-lensing peak counts}", + journal = {Submitted to \aap}, +OPTarchivePrefix = "arXiv", + note = {Also arXiv:1704.00258}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = apr, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv170400258L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{Pierre_XXL_review_17, + author = {{Pierre}, M. and {Adami}, C. and {Birkinshaw}, M. and {Chiappetti}, L. and + {Ettori}, S. and {Evrard}, A. and {Faccioli}, L. and {Gastaldello}, F. and + {Giles}, P. and {Horellou}, C. and {Iovino}, A. and {Koulouridis}, E. and + {Lidman}, C. and {Le Brun}, A. and {Maughan}, B. and {Maurogordato}, S. and + {McCarthy}, I. and {Miyazaki}, S. and {Pacaud}, F. and {Paltani}, S. and + {Plionis}, M. and {Reiprich}, T. and {Sadibekova}, T. and {Smolcic}, V. and + {Snowden}, S. and {Surdej}, J. and {Tsirou}, M. and {Vignali}, C. and + {Willis}, J. and {Alis}, S. and {Altieri}, B. and {Baran}, N. and + {Benoist}, C. and {Bongiorno}, A. and {Bremer}, M. and {Butler}, A. and + {Cappi}, A. and {Caretta}, C. and {Ciliegi}, P. and {Clerc}, N. and + {Corasaniti}, P.~S. and {Coupon}, J. and {Delhaize}, J. and + {Delvecchio}, I. and {Democles}, J. and {Desai}, S. and {Devriendt}, J. and + {Dubois}, Y. and {Eckert}, D. and {Elyiv}, A. and {Farahi}, A. and + {Ferraril}, C. and {Fotopoulou}, S. and {Forman}, W. and {Georgantopoulos}, I. and + {Guglielmo}, V. and {Huynh}, M. and {Jerlin}, N. and {Jones}, C. and + {Lavoie}, S. and {Le Fevre}, J.-P. and {Lieu}, M. and {Kilbinger}, M. and + {MaruIli}, F. and {Mantz}, A. and {McGee}, S. and {Melin}, J.-B. and + {Melnyk}, O. and {Moscardini}, L. and {Novak}, M. and {Piconcelli}, E. and + {Poggianti}, B. and {Pomarede}, D. and {Pompei}, E. and {Ponman}, T. and + {Ramos Ceja}, M.~E. and {Rana}, P. and {Rapetti}, D. and {Raychaudhury}, S. and + {Ricci}, M. and {Rottgering}, H. and {Sahlen}, M. and {Sauvageot}, J.-L. and + {Schimd}, C. and {Sereno}, M. and {Smith}, G.~P. and {Umetsu}, K. and + {Valageas}, P. and {Valotti}, A. and {Valtchanov}, I. and {Veropalumbo}, A. and + {Ascaso}, B. and {Barnes}, D. and {De Petris}, M. and {Durret}, F. and + {Donahue}, M. and {Ithana}, M. and {Jarvis}, M. and {Johnston-Hollitt}, M. and + {Kalfountzou}, E. and {Kay}, S. and {La Franca}, F. and {Okabe}, N. and + {Muzzin}, A. and {Rettura}, A. and {Ricci}, F. and {Ridl}, J. and + {Risaliti}, G. and {Takizawa}, M. and {Thomas}, P. and {Truong}, N. + }, + title = "{The XXL survey: First results and future}", + journal = {Astronomische Nachrichten}, +archivePrefix = "arXiv", + eprint = {1610.01781}, + year = 2017, + month = mar, + volume = 338, + pages = {334-341}, + doi = {10.1002/asna.201713352}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017AN....338..334P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{PL17, + author = {{Peel}, A. and {Lin}, C.-A. and {Lanusse}, F. and {Leonard}, A. and + {Starck}, J.-L. and {Kilbinger}, M.}, + title = "{Cosmological constraints with weak-lensing peak counts and second-order statistics in a large-field survey}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {1612.02264}, + keywords = {gravitational lensing: weak, large-scale structure of Universe, cosmological parameters, methods: statistical}, + year = 2017, + month = mar, + volume = 599, + eid = {A79}, + pages = {A79}, + doi = {10.1051/0004-6361/201629928}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017A%26A...599A..79P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + @ARTICLE{KH17, - author = {Kilbinger, M. and others}, - title = {Precision calculations of the cosmic shear power spectrum}, - journal = {submitted to \mnras}, - year = {2017}, - eprint = {arXiv:XXXX.XXXX}, + author = {{Kilbinger}, M. and {Heymans}, C. and {Asgari}, M. and {Joudaki}, S. and + {Schneider}, P. and {Simon}, P. and {Van Waerbeke}, L. and {Harnois-D{\'e}raps}, J. and + {Hildebrandt}, H. and {K{\"o}hlinger}, F. and {Kuijken}, K. and + {Viola}, M.}, + title = "{Precision calculations of the cosmic shear power spectrum projection}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1702.05301}, + year = 2017, + OPTmonth = dec, + volume = 472, + pages = {2126-2141}, + doi = {10.1093/mnras/stx2082}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017MNRAS.472.2126K}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} } @ARTICLE{Scottez16, @@ -40,6 +138,38 @@ @ARTICLE{Scottez16 adsnote = {Provided by the SAO/NASA Astrophysics Data System} } +@ARTICLE{DESI_Instr_17, + author = {{DESI Collaboration} and {Aghamousa}, A. and {Aguilar}, J. and + {Ahlen}, S. and {Alam}, S. and {Allen}, L.~E. and {Allende Prieto}, C. and + {Annis}, J. and {Bailey}, S. and {Balland}, C. and et al.}, + title = "{The DESI Experiment Part II: Instrument Design}", + journal = {ArXiv:1611.00037}, +archivePrefix = "arXiv", + eprint = {1611.00037}, + primaryClass = "astro-ph.IM", + keywords = {Astrophysics - Instrumentation and Methods for Astrophysics, Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2016, + month = oct, + adsurl = {http://cdsads.u-strasbg.fr/abs/2016arXiv161100037D}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{DESI_science_17, + author = {{DESI Collaboration} and {Aghamousa}, A. and {Aguilar}, J. and + {Ahlen}, S. and {Alam}, S. and {Allen}, L.~E. and {Allende Prieto}, C. and + {Annis}, J. and {Bailey}, S. and {Balland}, C. and et al.}, + title = "{The DESI Experiment Part I: Science,Targeting, and Survey Design}", + journal = {ArXiv:1611.00036}, +archivePrefix = "arXiv", + eprint = {1611.00036}, + primaryClass = "astro-ph.IM", + keywords = {Astrophysics - Instrumentation and Methods for Astrophysics, Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2016, + month = oct, + adsurl = {http://cdsads.u-strasbg.fr/abs/2016arXiv161100036D}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + @ARTICLE{LKS16, author = {{Lin}, C.-A. and {Kilbinger}, M. and {Pires}, S.}, title = "{A new model to predict weak-lensing peak counts III. Filtering technique comparisons}", @@ -72,10 +202,6 @@ @ARTICLE{Lieu16 month = jun, volume = 592, eid = {A4}, - pages = {A4}, - doi = {10.1051/0004-6361/201526883}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2016A%26A...592A...4L}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} } @ARTICLE{Pierre16, @@ -119,24 +245,6 @@ @ARTICLE{Pierre16 adsnote = {Provided by the SAO/NASA Astrophysics Data System} } -@ARTICLE{LK15b, - author = {{Lin}, C.-A. and {Kilbinger}, M.}, - title = "{A new model to predict weak-lensing peak counts. II. Parameter constraint strategies}", - journal = {\aap}, -archivePrefix = "arXiv", - eprint = {1506.01076}, - keywords = {gravitational lensing: weak, large-scale structure of Universe, methods: statistical}, - year = 2015, - month = nov, - volume = 583, - eid = {A70}, - pages = {A70}, - doi = {10.1051/0004-6361/201526659}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2015A%26A...583A..70L}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - - @ARTICLE{great3-I, author = {{Mandelbaum}, R. and {Rowe}, B. and {Armstrong}, R. and {Bard}, D. and {Bertin}, E. and {Bosch}, J. and {Boutigny}, D. and {Courbin}, F. and @@ -175,7 +283,7 @@ @ARTICLE{MWCK15 eprint = {1411.4983}, keywords = {methods: statistical, galaxies: evolution, galaxies: formation, large-scale structure of Universe}, year = 2015, - month = may, + OPTmonth = may, volume = 449, pages = {901-916}, doi = {10.1093/mnras/stv305}, @@ -190,7 +298,7 @@ @ARTICLE{K15 archivePrefix = "arXiv", eprint = {1411.0115}, year = 2015, - month = jul, + OPTmonth = jul, volume = 78, number = 8, eid = {086901}, @@ -200,6 +308,23 @@ @ARTICLE{K15 adsnote = {Provided by the SAO/NASA Astrophysics Data System} } +@ARTICLE{LK15b, + author = {{Lin}, C.-A. and {Kilbinger}, M.}, + title = "{A new model to predict weak-lensing peak counts. II. Parameter constraint strategies}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {1506.01076}, + keywords = {gravitational lensing: weak, large-scale structure of Universe, methods: statistical}, + year = 2015, + OPTmonth = nov, + volume = 583, + eid = {A70}, + pages = {A70}, + doi = {10.1051/0004-6361/201526659}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015A%26A...583A..70L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + @ARTICLE{LK15a, author = {{Lin}, C.-A. and {Kilbinger}, M.}, title = "{A new model to predict weak-lensing peak counts. I. Comparison with N-body simulations}", @@ -208,7 +333,7 @@ @ARTICLE{LK15a eprint = {1410.6955}, keywords = {gravitational lensing: weak, large-scale structure of Universe, methods: statistical}, year = 2015, - month = apr, + OPTmonth = apr, volume = 576, eid = {A24}, pages = {A24}, @@ -764,6 +889,20 @@ @Article{SvWKM02 %%% Software +@MISC{swot_ascl, + author = {{Coupon}, J. and {Leauthaud}, A. and {Kilbinger}, M. and {Medezinski}, E. + }, + title = "{swot: Super W Of Theta}", + keywords = {Software}, +howpublished = {Astrophysics Source Code Library}, + year = 2017, + month = jul, +archivePrefix = "ascl", + eprint = {1707.007}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017ascl.soft07007C}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + @MISC{camelus_ascl, author = {{Lin}, C.-A. and {Kilbinger}, M.}, title = "{Camelus: Counts of Amplified Mass Elevations from Lensing with Ultrafast Simulations}", @@ -804,6 +943,43 @@ @MISC{cosmo_pmc_ascl %%% Conference proceedings +@INPROCEEDINGS{Vavrek_Euclid_Perf_17, + author = {{Vavrek}, R.~D. and {Laureijs}, R.~J. and {Lorenzo Alvarez}, J. and + {Amiaux}, J. and {Mellier}, Y. and {Azzollini}, R. and {Buenadicha}, G. and + {Saavedra Criado}, G. and {Cropper}, M. and {Dabin}, C. and + {Ealet}, A. and {Garilli}, B. and {Gregorio}, A. and {Hoekstra}, H. and + {Jahnke}, K. and {Kilbinger}, M. and {Kitching}, T. and {Hoar}, J. and + {Percival}, W. and {Racca}, G.~D. and {Salvignol}, J.-C. and + {Sauvage}, M. and {Scaramella}, R. and {Gaspar Venancio}, L.~M. and + {Wang}, Y. and {Zacchei}, A. and {Wachter}, S.}, + title = "{Mission-level performance verification approach for the Euclid space mission}", +booktitle = {Modeling, Systems Engineering, and Project Management for Astronomy VI}, + year = 2016, + series = {\procspie}, + volume = 9911, + month = aug, + eid = {991105}, + pages = {991105}, + doi = {10.1117/12.2233015}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2016SPIE.9911E..05V}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@INPROCEEDINGS{PL17_AAS, + author = {{Peel}, A. and {Lin}, C.-A. and {Lanusse}, F. and {Leonard}, A. and + {Starck}, J.-L. and {Kilbinger}, M.}, + title = "{Cosmological constraints with weak lensing peak counts and second-order statistics in a large-field survey}", +booktitle = {American Astronomical Society Meeting Abstracts}, + year = 2017, + series = {American Astronomical Society Meeting Abstracts}, + volume = 229, + month = jan, + eid = {430.01}, + pages = {430.01}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017AAS...22943001P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + @INPROCEEDINGS{LK14, author = {{Lin}, C.-A. and {Kilbinger}, M.}, title = "{A New Model to Predict Weak Lensing Peak Counts}", @@ -972,6 +1148,180 @@ @ARTICLE{2016yCat.9049....0P adsnote = {Provided by the SAO/NASA Astrophysics Data System} } + +%%% Euclid: Technical reports %%% + +@techreport{Cov_Tf_IR, + title = "Euclid Covariance Task Force Interim Report", + author = {Sellentin, E. and Joachimi, B. and others}, + group = {WLSWG}, + year = 2018, + number = 0, +} + +@techreport{LE3_CM_ML0_TN, + title = {{Euclid CM-2PCF-WL Maturity Level 0 --- technical note}}, + author = {Kilbinger, M.}, + group = {OU-LE3}, + year = {2016}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {SAP-EUCLID-MK-0134-16}, + PAGES = {10}, +} + +@techreport{LE3_2PCF_ML0_DP, + title = {{Euclid 2PCF-WL Maturity Level 0 Datapackage}}, + author = {Morin, B. and Kilbinger, M.}, + group = {SDC-FR + OU-LE3}, + year = {2015}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {SAP-EUCLID-BM-0035-15}, + PAGES = {16}, +} + +@techreport{LE3_2PCF_ML1A_DP, + title = {{Euclid 2PCF-WL Maturity Level 1A Datapackage}}, + author = {Morin, B. and Kilbinger, M. and Sureau, F.}, + group = {SDC-FR + OU-LE3}, + year = {2015}, + institution = {CEA Saclay, IRFU}, + NUMBER = {SAP-EUCLID-BM-0039-15}, + PAGES = {43}, +} + +@techreport{LE3_CM_ML0_DP, + title = {{Euclid CM-2PCF-WL Maturity Level 0 Datapackage}}, + author = {Morin, B. and Kilbinger, M.}, + group = {SDC-FR + OU-LE3}, + year = {2015}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {SAP-EUCLID-BM-0035-15}, + PAGES = {16}, +} + +@techreport{LE3_2PCF_athena_manual, + title = {{Athena v1.7 User Manual for Euclid}}, + author = {Kilbinger, M. and Coupon, J. and Bonnett, C.}, + group = {OU-LE3}, + year = {2014}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {SAP-EUCLID-MK-0041-15}, + PAGES = {13}, +} + +@techreport{LE3_COSEBIS_TN, + title = {{Euclid OU-LE3 PF WL-2PCF: COSEBis --- technical note}}, + author = {Kilbinger, M.}, + group = {OU-LE3}, + year = {2016}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {SAP-EUCLID-MK-1234-45}, + PAGES = {9}, +} + + +@techreport{SHE_VP, + title = {{Euclid SGS SHE Processing Function Validation Plan}}, + author = {Kilbinger, M. and others}, + group = {OU-SHE}, + year = {2015}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {EUCL-CEA-PL-8-001\_v0.91}, + PAGES = {25}, +} + +@techreport{SHE_RSD, + title = {{Euclid SGS SHE Processing Function Requirements Specification Document}}, + author = {Taylor, A. and Courbin, F. and Schrabback, T.}, + group = {OU-SHE}, + year = {2015, 2017}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {EUCL-IFA-RS-8-001}, + PAGES = {52}, +} + +@techreport{SHE_VP_STS, + title = {{Euclid SGS SHE Processing Function Validation Plan \& Software Tests Specifications}}, + author = {Kilbinger, M. and Nakajima, R. and Joachimi, B.}, + group = {OU-SHE}, + year = {2017}, + OPTinstitution = {CEA Saclay, IRFU}, + NUMBER = {EUCL-CEA-PL-8-001\_v1.39}, + PAGES = {70}, +} + +@techreport{LE3_RSD, + title = {{Euclid SGS LE3 Processing Function Requirements Specification Document}}, + author = {Branchini, E. and Abdala, F. and Starck, J.-L. and others}, + group = {OU-LE3}, + year = {2015, 2017}, + OPTinstitution = {}, + NUMBER = {EUCL-EC-RS-8-002}, + PAGES = {98}, +} + +@techreport{LE3_VP, + title = {{Euclid SGS LE3 Processing Function Validation Plan}}, + author = {Morin, B. and others}, + group = {OU-LE3}, + year = {2015, 2017}, + OPTinstitution = {}, + NUMBER = {EUCL-CEA-PL-8-002}, + PAGES = {75}, +} + +@techreport{LE3_VP_STS, + title = {{Euclid SGS LE3 Processing Function Validation Plan \& Software Tests Specifications}}, + author = {Morin, B. and others}, + group = {OU-LE3}, + year = {2015, 2017}, + OPTinstitution = {}, + NUMBER = {EUCL-CEA-PL-8-002}, + PAGES = {75}, +} + +@techreport{WLSWG_SGS_WLVal, + title = {{Validation tests for the Euclid weak lensing pipeline}}, + author = {Nakajima, R. and Joachimi, B. and Simon, P. and Hoekstra, H. and Kitching, T. and Kilbinger, M. and + Taylor, A and Schneider, P. and McCracken, H.~J. and Tisserand, P. and T\'e\'ech\'e, S. and + Massey, R. and Israel, H. and Schrabback, T.}, + group = {WLSWG + OU-VIS + OU-SHE + OU-LE3}, + year = {2015, 2017}, + OPTinstitution = {}, + NUMBER = {EUCL-UBN-TS-8-001}, + PAGES = {92}, +} + +@techreport{WLSWG_Req_LE3, + title = {{Requirements for Euclid OU-LE3 P1 algorithms}}, + author = {Kilbinger, M. and Balan, S. and Joachimi, B. and Abdala, F. and Asgari, M. and Hoekstra, H. and + Kitching, T. and Nakajima, R. and Schneider, P.}, + group = {WLSWG}, + year = {2015, 2016}, + OPTinstitution = {}, + NUMBER = {TBD}, + PAGES = {19}, +} + +@techreport{IST_forecast_spec, + title = {{Euclid Theoretical Predictions Specification Document}}, + author = {Various}, + group = {IST}, + year = {2017}, + OPTinstitution = {}, + NUMBER = {TBD}, + PAGES = {85}, +} + +%%%% In preparation +% Cov task force report +% PDD (will be put on arXiv) +% Encyclopedia (will be put on arXiv) + +%%% Other +% Estimators documents - most of it put into LE3 req. doc (?) + + %%% Theses @MastersThesis{diplom, @@ -981,6 +1331,12 @@ @MastersThesis{diplom year = 2002 } +@PhDThesis{PhD, + author = {Kilbinger, M.}, + title = {{Cosmological Parameters from Second- and Third-Order Cosmic Shear Statistics}}, + school = {Universit\"at Bonn}, + year = 2005 +} %%%%%%%%%%% CFHTLenS Papers @@ -4942,18 +5298,20 @@ @ARTICLE{2008ARNPS..58...99H } @Article{ES09, - author = {Eifler, T. and Schneider, P.}, - title = {Measuring cosmic shear with the ring statistics}, - journal = {submitted to \aap, arXiv:0907:XXXX}, - year = {2009}, - OPTkey = {}, - OPTvolume = {}, - OPTnumber = {}, - OPTpages = {}, - OPTmonth = {}, - note = {Also arXiv:0907:XXXX}, - eprint = {Also arXiv:0907.xxxx}, - OPTannote = {} + author = {{Eifler}, T. and {Schneider}, P. and {Krause}, E.}, + title = "{Measuring cosmic shear with the ring statistics}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {0907.2320}, + keywords = {gravitational lensing: weak, large-scale structure of Universe, methods: data analysis}, + year = 2010, + month = jan, + volume = 510, + eid = {A7}, + pages = {A7}, + doi = {10.1051/0004-6361/200912888}, + adsurl = {http://adsabs.harvard.edu/abs/2010A%26A...510A...7E}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} } @ARTICLE{2006JCAP...09..010E, @@ -8026,12 +8384,13 @@ @ARTICLE{2013MNRAS.tmp.1312T journal = {\mnras}, archivePrefix = "arXiv", eprint = {1212.4359}, - primaryClass = "astro-ph.CO", keywords = {methods: statistical, cosmological parameters, cosmology: theory, large-scale structure of Universe}, year = 2013, - month = may, + month = jul, + volume = 432, + pages = {1928-1946}, doi = {10.1093/mnras/stt270}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2013MNRAS.tmp.1312T}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2013MNRAS.432.1928T}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } @@ -11997,273 +12356,74 @@ @ARTICLE{2013A&A...556A..70W month = aug, volume = 556, eid = {A70}, + doi = {10.1103/PhysRevD.84.023012}, + adsurl = {http://adsabs.harvard.edu/abs/2011PhRvD..84b3012D}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } -@ARTICLE{2011ApJ...729L..11S, - author = {{Seo}, H.-J. and {Sato}, M. and {Dodelson}, S. and {Jain}, B. and - {Takada}, M.}, - title = "{Re-capturing Cosmic Information}", - journal = {\apjl}, -archivePrefix = "arXiv", - eprint = {1008.0349}, - primaryClass = "astro-ph.CO", - keywords = {cosmology: theory, gravitational lensing: weak, large-scale structure of universe}, - year = 2011, +@ARTICLE{2001MNRAS.322..107M, + author = {{Munshi}, D. and {Jain}, B.}, + title = "{Statistics of weak lensing at small angular scales: analytical predictions for lower order moments}", + journal = {\mnras}, + eprint = {astro-ph/9912330}, + keywords = {GRAVITATIONAL LENSING, METHODS: ANALYTICAL, COSMOLOGY: THEORY, LARGE-SCALE STRUCTURE OF UNIVERSE}, + year = 2001, month = mar, - volume = 729, - eid = {L11}, - pages = {L11}, - doi = {10.1088/2041-8205/729/1/L11}, - adsurl = {http://adsabs.harvard.edu/abs/2011ApJ...729L..11S}, + volume = 322, + pages = {107-120}, + doi = {10.1046/j.1365-8711.2001.04069.x}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2001MNRAS.322..107M}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } -@ARTICLE{2006astro.ph..5313U, - author = {{Uzan}, J.-P.}, - title = "{The acceleration of the universe and the physics behind it}", - journal = {General Relativity and Gravitation}, - eprint = {astro-ph/0605313}, - keywords = {Astrophysics, General Relativity and Quantum Cosmology, High Energy Physics - Phenomenology}, - year = 2007, - volume = 39, - issue = 3, - pages = {307-342}, - month = may, - adsurl = {http://adsabs.harvard.edu/abs/2006astro.ph..5313U}, +@ARTICLE{1992A&A...255....1B, + author = {{Bernardeau}, F. and {Schaeffer}, R.}, + title = "{Galaxy correlations, matter correlations and biasing}", + journal = {\aap}, + keywords = {Astronomical Models, Correlation, Galactic Clusters, Galactic Structure, Mass Distribution, Bias, Scaling Laws, Three Body Problem, Trees (Mathematics), Two Body Problem}, + year = 1992, + month = feb, + volume = 255, + pages = {1-25}, + adsurl = {http://cdsads.u-strasbg.fr/abs/1992A%26A...255....1B}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } -@ARTICLE{2001PhRvD..64h3004U, - author = {{Uzan}, J.-P. and {Bernardeau}, F.}, - title = "{Lensing at cosmological scales: A test of higher dimensional gravity}", - journal = {\prd}, - eprint = {hep-ph/0012011}, - keywords = {Gravitational lenses and luminous arcs, Gravity in more than four dimensions Kaluza-Klein theory unified field theories, alternative theories of gravity, Field theories in dimensions other than four, Cosmology}, - year = 2001, - month = oct, - volume = 64, - number = 8, - eid = {083004}, - pages = {083004}, - doi = {10.1103/PhysRevD.64.083004}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2001PhRvD..64h3004U}, +@ARTICLE{2014MNRAS.440.1296H, + author = {{Huff}, E.~M. and {Hirata}, C.~M. and {Mandelbaum}, R. and {Schlegel}, D. and + {Seljak}, U. and {Lupton}, R.~H.}, + title = "{Seeing in the dark - I. Multi-epoch alchemy}", + journal = {\mnras}, + keywords = {gravitational lensing: weak, techniques: image processing, surveys, cosmology: observations}, + year = 2014, + month = may, + volume = 440, + pages = {1296-1321}, + doi = {10.1093/mnras/stu144}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2014MNRAS.440.1296H}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } -@ARTICLE{2007JCAP...03..013J, - author = {{Jain}, B. and {Connolly}, A. and {Takada}, M.}, - title = "{Colour tomography}", - journal = {\jcap}, - eprint = {astro-ph/0609338}, - year = 2007, - month = mar, - volume = 3, - eid = {013}, - pages = {13}, - doi = {10.1088/1475-7516/2007/03/013}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2007JCAP...03..013J}, +@ARTICLE{2002ApJ...570L..51B, + author = {{Blain}, A.~W.}, + title = "{Detecting Gravitational Lensing Cosmic Shear from Samples of Several Galaxies Using Two-dimensional Spectral Imaging}", + journal = {\apjl}, + eprint = {astro-ph/0204138}, + keywords = {Galaxies: ISM, Galaxies: Kinematics and Dynamics, Galaxies: Spiral, Cosmology: Gravitational Lensing, Radio Lines: Galaxies}, + year = 2002, + month = may, + volume = 570, + pages = {L51-L54}, + doi = {10.1086/341103}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2002ApJ...570L..51B}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } -@ARTICLE{2008MNRAS.390..118L, - author = {{Lima}, M. and {Cunha}, C.~E. and {Oyaizu}, H. and {Frieman}, J. and - {Lin}, H. and {Sheldon}, E.~S.}, - title = "{Estimating the redshift distribution of photometric galaxy samples}", - journal = {\mnras}, -archivePrefix = "arXiv", - eprint = {0801.3822}, - keywords = {galaxies: distances and redshifts , galaxies: statistics , distance scale , large-scale structure of Universe}, - year = 2008, - month = oct, - volume = 390, - pages = {118-130}, - doi = {10.1111/j.1365-2966.2008.13510.x}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2008MNRAS.390..118L}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@INCOLLECTION{Soldner1804, - author = {von Soldner, J.~G.}, - editor = {Bode, J.~E.}, - publisher = {Lange, G.~A.}, - title = {\"Uber die Ablenkung eines Lichtstrals von seiner geradlinigen Bewegung, - durch die Attraktion eines Weltk\"orpers, an welchem er nahe vorbei geht.}, - booktitle = {Berliner Astron. Jahrb.}, - year = 1804, - volume = 29, - pages = {161 - 172}, -} - -@ARTICLE{2014PhRvD..89h3519L, - author = {{Li}, Y. and {Hu}, W. and {Takada}, M.}, - title = "{Super-sample covariance in simulations}", - journal = {\prd}, - year = 2014, - month = aug, - volume = 90, - number = 4, - eid = {043535}, - pages = {043535}, - doi = {10.1103/PhysRevD.90.043535}, - adsurl = {http://adsabs.harvard.edu/abs/2014PhRvD..90d3535D}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2014PhRvL.112e1303B, - author = {{Battye}, R.~A. and {Moss}, A.}, - title = "{Evidence for Massive Neutrinos from Cosmic Microwave Background and Lensing Observations}", - journal = {Physical Review Letters}, -archivePrefix = "arXiv", - eprint = {1308.5870}, - primaryClass = "astro-ph.CO", - keywords = {Observational cosmology, Neutrino mass and mixing, Gravitational lenses and luminous arcs, Background radiations}, - year = 2014, - month = feb, - volume = 112, - number = 5, - eid = {051303}, - pages = {051303}, - doi = {10.1103/PhysRevLett.112.051303}, - adsurl = {http://adsabs.harvard.edu/abs/2014PhRvL.112e1303B}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2011A&A...530A..68T, - author = {{Tereno}, I. and {Semboloni}, E. and {Schrabback}, T.}, - title = "{COSMOS weak-lensing constraints on modified gravity}", - journal = {\aap}, -archivePrefix = "arXiv", - eprint = {1012.5854}, - primaryClass = "astro-ph.CO", - keywords = {gravitational lensing: weak, large-scale structure of Universe, cosmological parameters}, - year = 2011, - month = jun, - volume = 530, - eid = {A68}, - pages = {A68}, - doi = {10.1051/0004-6361/201016273}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2011A%26A...530A..68T}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2009MNRAS.395..197T, - author = {{Thomas}, S.~A. and {Abdalla}, F.~B. and {Weller}, J.}, - title = "{Constraining modified gravity and growth with weak lensing}", - journal = {\mnras}, -archivePrefix = "arXiv", - eprint = {0810.4863}, - keywords = {gravitation , gravitational lensing , cosmological parameters , cosmology: observations , cosmology: theory , large-scale structure of Universe}, - year = 2009, - OPTmonth = may, - volume = 395, - pages = {197-209}, - doi = {10.1111/j.1365-2966.2009.14568.x}, - adsurl = {http://adsabs.harvard.edu/abs/2009MNRAS.395..197T}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2012MNRAS.426.2489M, - author = {{Morrison}, C.~B. and {Scranton}, R. and {M{\'e}nard}, B. and - {Schmidt}, S.~J. and {Tyson}, J.~A. and {Ryan}, R. and {Choi}, A. and - {Wittman}, D.~M.}, - title = "{Tomographic magnification of Lyman-break galaxies in the Deep Lens Survey}", - journal = {\mnras}, -archivePrefix = "arXiv", - eprint = {1204.2830}, - primaryClass = "astro-ph.CO", - keywords = {gravitational lensing: weak, galaxies: haloes, galaxies: high-redshift, cosmology: observations, large-scale structure of Universe}, - year = 2012, - month = nov, - volume = 426, - pages = {2489-2499}, - doi = {10.1111/j.1365-2966.2012.21826.x}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2012MNRAS.426.2489M}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2011PhRvD..84b3012D, - author = {{Dossett}, J.~N. and {Moldenhauer}, J. and {Ishak}, M.}, - title = "{Figures of merit and constraints from testing general relativity using the latest cosmological data sets including refined COSMOS 3D weak lensing}", - journal = {\prd}, -archivePrefix = "arXiv", - eprint = {1103.1195}, - primaryClass = "astro-ph.CO", - keywords = {Dark energy, Gravitational lenses and luminous arcs, Observational cosmology}, - year = 2011, - month = jul, - volume = 84, - number = 2, - eid = {023012}, - pages = {023012}, - doi = {10.1103/PhysRevD.84.023012}, - adsurl = {http://adsabs.harvard.edu/abs/2011PhRvD..84b3012D}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2001MNRAS.322..107M, - author = {{Munshi}, D. and {Jain}, B.}, - title = "{Statistics of weak lensing at small angular scales: analytical predictions for lower order moments}", - journal = {\mnras}, - eprint = {astro-ph/9912330}, - keywords = {GRAVITATIONAL LENSING, METHODS: ANALYTICAL, COSMOLOGY: THEORY, LARGE-SCALE STRUCTURE OF UNIVERSE}, - year = 2001, - month = mar, - volume = 322, - pages = {107-120}, - doi = {10.1046/j.1365-8711.2001.04069.x}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2001MNRAS.322..107M}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{1992A&A...255....1B, - author = {{Bernardeau}, F. and {Schaeffer}, R.}, - title = "{Galaxy correlations, matter correlations and biasing}", - journal = {\aap}, - keywords = {Astronomical Models, Correlation, Galactic Clusters, Galactic Structure, Mass Distribution, Bias, Scaling Laws, Three Body Problem, Trees (Mathematics), Two Body Problem}, - year = 1992, - month = feb, - volume = 255, - pages = {1-25}, - adsurl = {http://cdsads.u-strasbg.fr/abs/1992A%26A...255....1B}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2014MNRAS.440.1296H, - author = {{Huff}, E.~M. and {Hirata}, C.~M. and {Mandelbaum}, R. and {Schlegel}, D. and - {Seljak}, U. and {Lupton}, R.~H.}, - title = "{Seeing in the dark - I. Multi-epoch alchemy}", - journal = {\mnras}, - keywords = {gravitational lensing: weak, techniques: image processing, surveys, cosmology: observations}, - year = 2014, - month = may, - volume = 440, - pages = {1296-1321}, - doi = {10.1093/mnras/stu144}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2014MNRAS.440.1296H}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2002ApJ...570L..51B, - author = {{Blain}, A.~W.}, - title = "{Detecting Gravitational Lensing Cosmic Shear from Samples of Several Galaxies Using Two-dimensional Spectral Imaging}", - journal = {\apjl}, - eprint = {astro-ph/0204138}, - keywords = {Galaxies: ISM, Galaxies: Kinematics and Dynamics, Galaxies: Spiral, Cosmology: Gravitational Lensing, Radio Lines: Galaxies}, - year = 2002, - month = may, - volume = 570, - pages = {L51-L54}, - doi = {10.1086/341103}, - adsurl = {http://cdsads.u-strasbg.fr/abs/2002ApJ...570L..51B}, - adsnote = {Provided by the SAO/NASA Astrophysics Data System} -} - -@ARTICLE{2013arXiv1311.1489H, - author = {{Huff}, E.~M. and {Krause}, E. and {Eifler}, T. and {George}, M.~R. and - {Schlegel}, D.}, - title = "{Cosmic shear without shape noise}", - journal = {arXiv:1311.1489}, +@ARTICLE{2013arXiv1311.1489H, + author = {{Huff}, E.~M. and {Krause}, E. and {Eifler}, T. and {George}, M.~R. and + {Schlegel}, D.}, + title = "{Cosmic shear without shape noise}", + journal = {arXiv:1311.1489}, archivePrefix = "arXiv", eprint = {1311.1489}, primaryClass = "astro-ph.CO", @@ -16126,14 +16286,17 @@ @ARTICLE{1996A&AS..117..393B @ARTICLE{2016arXiv161104954K, author = {{Kitching}, T.~D. and {Alsing}, J. and {Heavens}, A.~F. and {Jimenez}, R. and {McEwen}, J.~D. and {Verde}, L.}, - title = "{The Limits of Cosmic Shear}", - journal = {ArXiv e-prints}, + title = "{The limits of cosmic shear}", + journal = {\mnras}, archivePrefix = "arXiv", eprint = {1611.04954}, - keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, - year = 2016, - month = nov, - adsurl = {http://cdsads.u-strasbg.fr/abs/2016arXiv161104954K}, + keywords = {large-scale structure of Universe, cosmology: theory}, + year = 2017, + month = aug, + volume = 469, + pages = {2737-2749}, + doi = {10.1093/mnras/stx1039}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017MNRAS.469.2737K}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } @@ -16229,13 +16392,32 @@ @ARTICLE{2016arXiv160605337F author = {{Fenech Conti}, I. and {Herbonnet}, R. and {Hoekstra}, H. and {Merten}, J. and {Miller}, L. and {Viola}, M.}, title = "{Calibration of weak-lensing shear in the Kilo-Degree Survey}", - journal = {ArXiv e-prints}, + journal = {\mnras}, archivePrefix = "arXiv", eprint = {1606.05337}, - keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics, Astrophysics - Instrumentation and Methods for Astrophysics}, - year = 2016, - month = jun, - adsurl = {http://cdsads.u-strasbg.fr/abs/2016arXiv160605337F}, + keywords = {gravitational lensing: weak, surveys, cosmology: observations}, + year = 2017, + month = may, + volume = 467, + pages = {1627-1651}, + doi = {10.1093/mnras/stx200}, + adsurl = {http://adsabs.harvard.edu/abs/2017MNRAS.467.1627F}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2016arXiv160903281H, + author = {{Hoekstra}, H. and {Viola}, M. and {Herbonnet}, R.}, + title = "{A study of the sensitivity of shape measurements to the input parameters of weak-lensing image simulations}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1609.03281}, + keywords = {gravitational lensing: weak, dark energy, dark matter, cosmology: observations}, + year = 2017, + month = jul, + volume = 468, + pages = {3295-3311}, + doi = {10.1093/mnras/stx724}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017MNRAS.468.3295H}, adsnote = {Provided by the SAO/NASA Astrophysics Data System} } @@ -16252,4 +16434,1359 @@ @ARTICLE{1973ApJ...185..413P adsnote = {Provided by the SAO/NASA Astrophysics Data System} } +@ARTICLE{2015MNRAS.447.1319F, + author = {{Fosalba}, P. and {Gazta{\~n}aga}, E. and {Castander}, F.~J. and + {Crocce}, M.}, + title = "{The MICE Grand Challenge light-cone simulation - III. Galaxy lensing mocks from all-sky lensing maps}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1312.2947}, + keywords = {gravitational lensing: weak, methods: analytical, methods: numerical, galaxies: general, cosmology: theory, large-scale structure of Universe}, + year = 2015, + month = feb, + volume = 447, + pages = {1319-1332}, + doi = {10.1093/mnras/stu2464}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015MNRAS.447.1319F}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2016arXiv160908621P, + author = {{Potter}, D. and {Stadel}, J. and {Teyssier}, R.}, + title = "{PKDGRAV3: Beyond Trillion Particle Cosmological Simulations for the Next Era of Galaxy Surveys}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1609.08621}, + primaryClass = "astro-ph.IM", + keywords = {Astrophysics - Instrumentation and Methods for Astrophysics, Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2016, + month = sep, + adsurl = {http://cdsads.u-strasbg.fr/abs/2016arXiv160908621P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2015PhRvD..91j3511P, + author = {{Petri}, A. and {Liu}, J. and {Haiman}, Z. and {May}, M. and + {Hui}, L. and {Kratochvil}, J.~M.}, + title = "{Emulating the CFHTLenS weak lensing data: Cosmological constraints from moments and Minkowski functionals}", + journal = {\prd}, +archivePrefix = "arXiv", + eprint = {1503.06214}, + keywords = {Cosmology, Relativity and gravitation, Dark energy, Gravitational lenses and luminous arcs}, + year = 2015, + month = may, + volume = 91, + number = 10, + eid = {103511}, + pages = {103511}, + doi = {10.1103/PhysRevD.91.103511}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015PhRvD..91j3511P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017JCAP...05..014L, + author = {{Lemos}, P. and {Challinor}, A. and {Efstathiou}, G.}, + title = "{The effect of Limber and flat-sky approximations on galaxy weak lensing}", + journal = {\jcap}, +archivePrefix = "arXiv", + eprint = {1704.01054}, + year = 2017, + month = may, + volume = 5, + eid = {014}, + pages = {014}, + doi = {10.1088/1475-7516/2017/05/014}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017JCAP...05..014L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2016arXiv161204041L, + author = {{Lin}, C.-A.}, + title = "{Cosmology with weak-lensing peak counts}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1612.04041}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2016, + month = dec, + adsurl = {http://cdsads.u-strasbg.fr/abs/2016arXiv161204041L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2004ApJ...613L...1V, + author = {{Vale}, C. and {Hoekstra}, H. and {van Waerbeke}, L. and {White}, M. + }, + title = "{Large-Scale Systematic Signals in Weak Lensing Surveys}", + journal = {\apjl}, + eprint = {astro-ph/0405268}, + keywords = {Cosmology: Theory, Cosmology: Gravitational Lensing, Cosmology: Large-Scale Structure of Universe}, + year = 2004, + month = sep, + volume = 613, + pages = {L1-L4}, + doi = {10.1086/424873}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2004ApJ...613L...1V}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2005PhRvD..72d3503G, + author = {{Guzik}, J. and {Bernstein}, G.}, + title = "{Inhomogeneous systematic signals in cosmic shear observations}", + journal = {\prd}, + eprint = {astro-ph/0507546}, + keywords = {Observational cosmology, Observation and data reduction techniques, computer modeling and simulation, Gravitational lenses and luminous arcs}, + year = 2005, + month = aug, + volume = 72, + number = 4, + eid = {043503}, + pages = {043503}, + doi = {10.1103/PhysRevD.72.043503}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2005PhRvD..72d3503G}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017SchpJ..1232440B, + author = {{Bartelmann}, M. and {Maturi}, M.}, + title = "{Weak gravitational lensing}", + journal = {Scholarpedia}, +archivePrefix = "arXiv", + eprint = {1612.06535}, + year = 2017, + volume = 12, + pages = {32440}, + doi = {10.4249/scholarpedia.32440}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017SchpJ..1232440B}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2014MNRAS.437.2471D, + author = {{Duncan}, C.~A.~J. and {Joachimi}, B. and {Heavens}, A.~F. and + {Heymans}, C. and {Hildebrandt}, H.}, + title = "{On the complementarity of galaxy clustering with cosmic shear and flux magnification}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1306.6870}, + keywords = {gravitational lensing: weak, methods: analytical, methods: statistical, cosmology: cosmological parameters, cosmology: theory, cosmology: large-scale structure of Universe}, + year = 2014, + month = jan, + volume = 437, + pages = {2471-2487}, + doi = {10.1093/mnras/stt2060}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2014MNRAS.437.2471D}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2011arXiv1104.2932L, + author = {{Lesgourgues}, J.}, + title = "{The Cosmic Linear Anisotropy Solving System (CLASS) I: Overview}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1104.2932}, + primaryClass = "astro-ph.IM", + keywords = {Astrophysics - Instrumentation and Methods for Astrophysics, Astrophysics - Cosmology and Extragalactic Astrophysics}, + year = 2011, + month = apr, + adsurl = {http://cdsads.u-strasbg.fr/abs/2011arXiv1104.2932L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2006Natur.439..437B, + author = {{Beaulieu}, J.-P. and {Bennett}, D.~P. and {Fouqu{\'e}}, P. and + {Williams}, A. and {Dominik}, M. and {J{\o}rgensen}, U.~G. and + {Kubas}, D. and {Cassan}, A. and {Coutures}, C. and {Greenhill}, J. and + {Hill}, K. and {Menzies}, J. and {Sackett}, P.~D. and {Albrow}, M. and + {Brillant}, S. and {Caldwell}, J.~A.~R. and {Calitz}, J.~J. and + {Cook}, K.~H. and {Corrales}, E. and {Desort}, M. and {Dieters}, S. and + {Dominis}, D. and {Donatowicz}, J. and {Hoffman}, M. and {Kane}, S. and + {Marquette}, J.-B. and {Martin}, R. and {Meintjes}, P. and {Pollard}, K. and + {Sahu}, K. and {Vinter}, C. and {Wambsganss}, J. and {Woller}, K. and + {Horne}, K. and {Steele}, I. and {Bramich}, D.~M. and {Burgdorf}, M. and + {Snodgrass}, C. and {Bode}, M. and {Udalski}, A. and {Szyma{\'n}ski}, M.~K. and + {Kubiak}, M. and {Wi{\c e}ckowski}, T. and {Pietrzy{\'n}ski}, G. and + {Soszy{\'n}ski}, I. and {Szewczyk}, O. and {Wyrzykowski}, {\L}. and + {Paczy{\'n}ski}, B. and {Abe}, F. and {Bond}, I.~A. and {Britton}, T.~R. and + {Gilmore}, A.~C. and {Hearnshaw}, J.~B. and {Itow}, Y. and {Kamiya}, K. and + {Kilmartin}, P.~M. and {Korpela}, A.~V. and {Masuda}, K. and + {Matsubara}, Y. and {Motomura}, M. and {Muraki}, Y. and {Nakamura}, S. and + {Okada}, C. and {Ohnishi}, K. and {Rattenbury}, N.~J. and {Sako}, T. and + {Sato}, S. and {Sasaki}, M. and {Sekiguchi}, T. and {Sullivan}, D.~J. and + {Tristram}, P.~J. and {Yock}, P.~C.~M. and {Yoshioka}, T.}, + title = "{Discovery of a cool planet of 5.5 Earth masses through gravitational microlensing}", + journal = {\nat}, + eprint = {astro-ph/0601563}, + year = 2006, + month = jan, + volume = 439, + pages = {437-440}, + doi = {10.1038/nature04441}, + adsurl = {http://adsabs.harvard.edu/abs/2006Natur.439..437B}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} +@ARTICLE{2017NatAs...1E..91H, + author = {{Hoag}, A. and {Bradac}, M. and {Trenti}, M. and {Treu}, T. and + {Schmidt}, K.~B. and {Huang}, K.-H. and {Lemaux}, B.~C. and + {He}, J. and {Bernard}, S.~R. and {Abramson}, L.~E. and {Mason}, C.~A. and + {Morishita}, T. and {Pentericci}, L. and {Schrabback}, T.}, + title = "{Spectroscopic confirmation of an ultra-faint galaxy at the epoch of reionization}", + journal = {Nature Astronomy}, +archivePrefix = "arXiv", + eprint = {1704.02970}, + year = 2017, + month = apr, + volume = 1, + eid = {0091}, + pages = {0091}, + doi = {10.1038/s41550-017-0091}, + adsurl = {http://adsabs.harvard.edu/abs/2017NatAs...1E..91H}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2004MNRAS.350..914C, + author = {{Chon}, G. and {Challinor}, A. and {Prunet}, S. and {Hivon}, E. and + {Szapudi}, I.}, + title = "{Fast estimation of polarization power spectra using correlation functions}", + journal = {\mnras}, + eprint = {astro-ph/0303414}, + keywords = {methods: analytical:, methods: numerical, cosmic microwave background}, + year = 2004, + month = may, + volume = 350, + pages = {914-926}, + doi = {10.1111/j.1365-2966.2004.07737.x}, + adsurl = {http://adsabs.harvard.edu/abs/2004MNRAS.350..914C}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2008MNRAS.390..118L, + author = {{Lima}, M. and {Cunha}, C.~E. and {Oyaizu}, H. and {Frieman}, J. and + {Lin}, H. and {Sheldon}, E.~S.}, + title = "{Estimating the redshift distribution of photometric galaxy samples}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {0801.3822}, + keywords = {galaxies: distances and redshifts , galaxies: statistics , distance scale , large-scale structure of Universe}, + year = 2008, + month = oct, + volume = 390, + pages = {118-130}, + doi = {10.1111/j.1365-2966.2008.13510.x}, + adsurl = {http://adsabs.harvard.edu/abs/2008MNRAS.390..118L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@article{BLANCO199719, +title = "Evaluation of the rotation matrices in the basis of real spherical harmonics", +journal = "Journal of Molecular Structure: THEOCHEM", +volume = "419", +number = "1", +pages = "19 - 27", +year = "1997", +note = "", +issn = "0166-1280", +doi = "http://dx.doi.org/10.1016/S0166-1280(97)00185-1", +url = "http://www.sciencedirect.com/science/article/pii/S0166128097001851", +author = "Miguel A. Blanco and M. Flórez and M. Bermejo", +keywords = "Wigner functions", +keywords = "Real spherical harmonics", +keywords = "Electronic structure calculations", +keywords = "Rotation matrices" +} + +@ARTICLE{2016arXiv161206873C, + author = {{Codis}, S.}, + title = "{Nuisance parameters for large galaxy surveys}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1612.06873}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2016, + month = dec, + adsurl = {http://adsabs.harvard.edu/abs/2016arXiv161206873C}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@INPROCEEDINGS{2009AAS...21332204M, + author = {{Marshall}, P.~J.}, + title = "{The HST Archive Galaxy-scale Gravitational Lens Search}", +booktitle = {American Astronomical Society Meeting Abstracts \#213}, + year = 2009, + series = {Bulletin of the American Astronomical Society}, + volume = 41, + month = jan, + eid = {322.04}, + pages = {377}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2009AAS...21332204M}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2015MNRAS.453..561I, + author = {{Israel}, H. and {Massey}, R. and {Prod'homme}, T. and {Cropper}, M. and + {Cordes}, O. and {Gow}, J. and {Kohley}, R. and {Marggraf}, O. and + {Niemi}, S. and {Rhodes}, J. and {Short}, A. and {Verhoeve}, P. + }, + title = "{How well can charge transfer inefficiency be corrected? A parameter sensitivity study for iterative correction}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1506.07831}, + primaryClass = "astro-ph.IM", + keywords = {instrumentation: detectors, methods: data analysis, space vehicles: instruments}, + year = 2015, + month = oct, + volume = 453, + pages = {561-580}, + doi = {10.1093/mnras/stv1660}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015MNRAS.453..561I}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2015JInst..10C5032G, + author = {{Gruen}, D. and {Bernstein}, G.~M. and {Jarvis}, M. and {Rowe}, B. and + {Vikram}, V. and {Plazas}, A.~A. and {Seitz}, S.}, + title = "{Characterization and correction of charge-induced pixel shifts in DECam}", + journal = {Journal of Instrumentation}, +archivePrefix = "arXiv", + eprint = {1501.02802}, + primaryClass = "astro-ph.IM", + year = 2015, + month = may, + volume = 10, + eid = {C05032}, + pages = {C05032}, + doi = {10.1088/1748-0221/10/05/C05032}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015JInst..10C5032G}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2015ExA....39..207N, + author = {{Niemi}, S.-M. and {Cropper}, M. and {Szafraniec}, M. and {Kitching}, T. + }, + title = "{Measuring a charge-coupled device point spread function. Euclid visible instrument CCD273-84 PSF performance}", + journal = {Experimental Astronomy}, +archivePrefix = "arXiv", + eprint = {1412.5382}, + primaryClass = "astro-ph.IM", + year = 2015, + month = jun, + volume = 39, + pages = {207-231}, + doi = {10.1007/s10686-015-9440-7}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015ExA....39..207N}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170605004V, + author = {{van Uitert}, E. and {Joachimi}, B. and {Joudaki}, S. and {Amon}, A. and + {Heymans}, C. and {K{\"o}hlinger}, F. and {Asgari}, M. and {Blake}, C. and + {Choi}, A. and {Erben}, T. and {Farrow}, D.~J. and {Harnois-D{\'e}raps}, J. and + {Hildebrandt}, H. and {Hoekstra}, H. and {Kitching}, T.~D. and + {Klaes}, D. and {Kuijken}, K. and {Merten}, J. and {Miller}, L. and + {Nakajima}, R. and {Schneider}, P. and {Valentijn}, E. and {Viola}, M. + }, + title = "{KiDS+GAMA: cosmology constraints from a joint analysis of cosmic shear, galaxy-galaxy lensing, and angular clustering}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1706.05004}, + keywords = {methods: data analysis, methods: statistical, large-scale structure of Universe}, + year = 2018, + month = jun, + volume = 476, + pages = {4662-4689}, + doi = {10.1093/mnras/sty551}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2018MNRAS.476.4662V}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2016arXiv161204664A, + author = {{Asgari}, M. and {Taylor}, A. and {Joachimi}, B. and {Kitching}, T.~D. + }, + title = "{Flat-Sky Pseudo-Cls Analysis for Weak Gravitational Lensing}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1612.04664}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2016, + month = dec, + adsurl = {http://adsabs.harvard.edu/abs/2016arXiv161204664A}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2016PhRvL.116t1301B, + author = {{Bird}, S. and {Cholis}, I. and {Mu{\~n}oz}, J.~B. and {Ali-Ha{\"i}moud}, Y. and + {Kamionkowski}, M. and {Kovetz}, E.~D. and {Raccanelli}, A. and + {Riess}, A.~G.}, + title = "{Did LIGO Detect Dark Matter?}", + journal = {Physical Review Letters}, +archivePrefix = "arXiv", + eprint = {1603.00464}, + year = 2016, + month = may, + volume = 116, + number = 20, + eid = {201301}, + pages = {201301}, + doi = {10.1103/PhysRevLett.116.201301}, + adsurl = {http://adsabs.harvard.edu/abs/2016PhRvL.116t1301B}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170801531D, + author = {{Drlica-Wagner}, A. and {Sevilla-Noarbe}, I. and {Rykoff}, E.~S. and + {Gruendl}, R.~A. and {Yanny}, B. and {Tucker}, D.~L. and {Hoyle}, B. and + {Carnero Rosell}, A. and {Bernstein}, G.~M. and {Bechtol}, K. and + {Becker}, M.~R. and {Benoit-Levy}, A. and {Bertin}, E. and {Carrasco Kind}, M. and + {Davis}, C. and {de Vicente}, J. and {Diehl}, H.~T. and {Gruen}, D. and + {Hartley}, W.~G. and {Leistedt}, B. and {Li}, T.~S. and {Marshall}, J.~L. and + {Neilsen}, E. and {Rau}, M.~M. and {Sheldon}, E. and {Smith}, J. and + {Troxel}, M.~A. and {Wyatt}, S. and {Zhang}, Y. and {Abbott}, T.~M.~C. and + {Abdalla}, F.~B. and {Allam}, S. and {Banerji}, M. and {Brooks}, D. and + {Buckley-Geer}, E. and {Burke}, D.~L. and {Capozzi}, D. and + {Carretero}, J. and {Cunha}, C.~E. and {D'Andrea}, C.~B. and + {da Costa}, L.~N. and {DePoy}, D.~L. and {Desai}, S. and {Dietrich}, J.~P. and + {Doel}, P. and {Evrard}, A.~E. and {Fausti Neto}, A. and {Flaugher}, B. and + {Fosalba}, P. and {Frieman}, J. and {Garcia-Bellido}, J. and + {Gerdes}, D.~W. and {Giannantonio}, T. and {Gschwend}, J. and + {Gutierrez}, G. and {Honscheid}, K. and {James}, D.~J. and {Jeltema}, T. and + {Kuehn}, K. and {Kuhlmann}, S. and {Kuropatkin}, N. and {Lahav}, O. and + {Lima}, M. and {Lin}, H. and {Maia}, M.~A.~G. and {Martini}, P. and + {McMahon}, R.~G. and {Melchior}, P. and {Menanteau}, F. and + {Miquel}, R. and {Nichol}, R.~C. and {Ogando}, R.~L.~C. and + {Plazas}, A.~A. and {Romer}, A.~K. and {Roodman}, A. and {Sanchez}, E. and + {Scarpine}, V. and {Schindler}, R. and {Schubnell}, M. and {Smith}, M. and + {Smith}, R.~C. and {Soares-Santos}, M. and {Sobreira}, F. and + {Suchyta}, E. and {Tarle}, G. and {Vikram}, V. and {Walker}, A.~R. and + {Wechsler}, R.~H. and {Zuntz}, J.}, + title = "{Dark Energy Survey Year 1 Results: Photometric Data Set for Cosmology}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1708.01531}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics, Astrophysics - Instrumentation and Methods for Astrophysics}, + year = 2017, + month = aug, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv170801531D}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@MISC{2015ascl.soft08008S, + author = {{Sheldon}, E.}, + title = "{NGMIX: Gaussian mixture models for 2D images}", + keywords = {Software}, +howpublished = {Astrophysics Source Code Library}, + year = 2015, + month = aug, +archivePrefix = "ascl", + eprint = {1508.008}, + adsurl = {http://adsabs.harvard.edu/abs/2015ascl.soft08008S}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017ApJ...841...24S, + author = {{Sheldon}, E.~S. and {Huff}, E.~M.}, + title = "{Practical Weak-lensing Shear Measurement with Metacalibration}", + journal = {\apj}, +archivePrefix = "arXiv", + eprint = {1702.02601}, + keywords = {cosmology: observations, gravitational lensing: weak, methods: observational}, + year = 2017, + month = may, + volume = 841, + eid = {24}, + pages = {24}, + doi = {10.3847/1538-4357/aa704b}, + adsurl = {http://adsabs.harvard.edu/abs/2017ApJ...841...24S}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170202600H, + author = {{Huff}, E. and {Mandelbaum}, R.}, + title = "{Metacalibration: Direct Self-Calibration of Biases in Shear Measurement}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1702.02600}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = feb, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv170202600H}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170801538T, + author = {{Troxel}, M.~A. and {MacCrann}, N. and {Zuntz}, J. and {Eifler}, T.~F. and + {Krause}, E. and {Dodelson}, S. and {Gruen}, D. and {Blazek}, J. and + {Friedrich}, O. and {Samuroff}, S. and {Prat}, J. and {Secco}, L.~F. and + {Davis}, C. and {Fert{\'e}}, A. and {DeRose}, J. and {Alarcon}, A. and + {Amara}, A. and {Baxter}, E. and {Becker}, M.~R. and {Bernstein}, G.~M. and + {Bridle}, S.~L. and {Cawthon}, R. and {Chang}, C. and {Choi}, A. and + {De Vicente}, J. and {Drlica-Wagner}, A. and {Elvin-Poole}, J. and + {Frieman}, J. and {Gatti}, M. and {Hartley}, W.~G. and {Honscheid}, K. and + {Hoyle}, B. and {Huff}, E.~M. and {Huterer}, D. and {Jain}, B. and + {Jarvis}, M. and {Kacprzak}, T. and {Kirk}, D. and {Kokron}, N. and + {Krawiec}, C. and {Lahav}, O. and {Liddle}, A.~R. and {Peacock}, J. and + {Rau}, M.~M. and {Refregier}, A. and {Rollins}, R.~P. and {Rozo}, E. and + {Rykoff}, E.~S. and {S{\'a}nchez}, C. and {Sevilla-Noarbe}, I. and + {Sheldon}, E. and {Stebbins}, A. and {Varga}, T.~N. and {Vielzeuf}, P. and + {Wang}, M. and {Wechsler}, R.~H. and {Yanny}, B. and {Abbott}, T.~M.~C. and + {Abdalla}, F.~B. and {Allam}, S. and {Annis}, J. and {Bechtol}, K. and + {Benoit-L{\'e}vy}, A. and {Bertin}, E. and {Brooks}, D. and + {Buckley-Geer}, E. and {Burke}, D.~L. and {Carnero Rosell}, A. and + {Carrasco Kind}, M. and {Carretero}, J. and {Castander}, F.~J. and + {Crocce}, M. and {Cunha}, C.~E. and {D'Andrea}, C.~B. and {da Costa}, L.~N. and + {DePoy}, D.~L. and {Desai}, S. and {Diehl}, H.~T. and {Dietrich}, J.~P. and + {Doel}, P. and {Fernandez}, E. and {Flaugher}, B. and {Fosalba}, P. and + {Garc{\'{\i}}a-Bellido}, J. and {Gaztanaga}, E. and {Gerdes}, D.~W. and + {Giannantonio}, T. and {Goldstein}, D.~A. and {Gruendl}, R.~A. and + {Gschwend}, J. and {Gutierrez}, G. and {James}, D.~J. and {Jeltema}, T. and + {Johnson}, M.~W.~G. and {Johnson}, M.~D. and {Kent}, S. and + {Kuehn}, K. and {Kuhlmann}, S. and {Kuropatkin}, N. and {Li}, T.~S. and + {Lima}, M. and {Lin}, H. and {Maia}, M.~A.~G. and {March}, M. and + {Marshall}, J.~L. and {Martini}, P. and {Melchior}, P. and {Menanteau}, F. and + {Miquel}, R. and {Mohr}, J.~J. and {Neilsen}, E. and {Nichol}, R.~C. and + {Nord}, B. and {Petravick}, D. and {Plazas}, A.~A. and {Romer}, A.~K. and + {Roodman}, A. and {Sako}, M. and {Sanchez}, E. and {Scarpine}, V. and + {Schindler}, R. and {Schubnell}, M. and {Smith}, M. and {Smith}, R.~C. and + {Soares-Santos}, M. and {Sobreira}, F. and {Suchyta}, E. and + {Swanson}, M.~E.~C. and {Tarle}, G. and {Thomas}, D. and {Tucker}, D.~L. and + {Vikram}, V. and {Walker}, A.~R. and {Weller}, J. and {Zhang}, Y. + }, + title = "{Dark Energy Survey Year 1 Results: Cosmological Constraints from Cosmic Shear}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1708.01538}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = aug, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv170801538T}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +%author = {{DES Collaboration} and {Abbott}, T.~M.~C. and {Abdalla}, F.~B. and + +@ARTICLE{2017arXiv170801530D, + author = {{DES Coll.} and {Abbott}, T.~M.~C. and {Abdalla}, F.~B. and + {Alarcon}, A. and {Aleksi{\'c}}, J. and {Allam}, S. and {Allen}, S. and + {Amara}, A. and {Annis}, J. and {Asorey}, J. and {Avila}, S. and + {Bacon}, D. and {Balbinot}, E. and {Banerji}, M. and {Banik}, N. and + {Barkhouse}, W. and {Baumer}, M. and {Baxter}, E. and {Bechtol}, K. and + {Becker}, M.~R. and {Benoit-L{\'e}vy}, A. and {Benson}, B.~A. and + {Bernstein}, G.~M. and {Bertin}, E. and {Blazek}, J. and {Bridle}, S.~L. and + {Brooks}, D. and {Brout}, D. and {Buckley-Geer}, E. and {Burke}, D.~L. and + {Busha}, M.~T. and {Capozzi}, D. and {Carnero Rosell}, A. and + {Carrasco Kind}, M. and {Carretero}, J. and {Castander}, F.~J. and + {Cawthon}, R. and {Chang}, C. and {Chen}, N. and {Childress}, M. and + {Choi}, A. and {Conselice}, C. and {Crittenden}, R. and {Crocce}, M. and + {Cunha}, C.~E. and {D'Andrea}, C.~B. and {da Costa}, L.~N. and + {Das}, R. and {Davis}, T.~M. and {Davis}, C. and {De Vicente}, J. and + {DePoy}, D.~L. and {DeRose}, J. and {Desai}, S. and {Diehl}, H.~T. and + {Dietrich}, J.~P. and {Dodelson}, S. and {Doel}, P. and {Drlica-Wagner}, A. and + {Eifler}, T.~F. and {Elliott}, A.~E. and {Elsner}, F. and {Elvin-Poole}, J. and + {Estrada}, J. and {Evrard}, A.~E. and {Fang}, Y. and {Fernandez}, E. and + {Fert{\'e}}, A. and {Finley}, D.~A. and {Flaugher}, B. and {Fosalba}, P. and + {Friedrich}, O. and {Frieman}, J. and {Garc{\'{\i}}a-Bellido}, J. and + {Garcia-Fernandez}, M. and {Gatti}, M. and {Gaztanaga}, E. and + {Gerdes}, D.~W. and {Giannantonio}, T. and {Gill}, M.~S.~S. and + {Glazebrook}, K. and {Goldstein}, D.~A. and {Gruen}, D. and + {Gruendl}, R.~A. and {Gschwend}, J. and {Gutierrez}, G. and + {Hamilton}, S. and {Hartley}, W.~G. and {Hinton}, S.~R. and + {Honscheid}, K. and {Hoyle}, B. and {Huterer}, D. and {Jain}, B. and + {James}, D.~J. and {Jarvis}, M. and {Jeltema}, T. and {Johnson}, M.~D. and + {Johnson}, M.~W.~G. and {Kacprzak}, T. and {Kent}, S. and {Kim}, A.~G. and + {King}, A. and {Kirk}, D. and {Kokron}, N. and {Kovacs}, A. and + {Krause}, E. and {Krawiec}, C. and {Kremin}, A. and {Kuehn}, K. and + {Kuhlmann}, S. and {Kuropatkin}, N. and {Lacasa}, F. and {Lahav}, O. and + {Li}, T.~S. and {Liddle}, A.~R. and {Lidman}, C. and {Lima}, M. and + {Lin}, H. and {MacCrann}, N. and {Maia}, M.~A.~G. and {Makler}, M. and + {Manera}, M. and {March}, M. and {Marshall}, J.~L. and {Martini}, P. and + {McMahon}, R.~G. and {Melchior}, P. and {Menanteau}, F. and + {Miquel}, R. and {Miranda}, V. and {Mudd}, D. and {Muir}, J. and + {M{\"o}ller}, A. and {Neilsen}, E. and {Nichol}, R.~C. and {Nord}, B. and + {Nugent}, P. and {Ogando}, R.~L.~C. and {Palmese}, A. and {Peacock}, J. and + {Peiris}, H.~V. and {Peoples}, J. and {Percival}, W.~J. and + {Petravick}, D. and {Plazas}, A.~A. and {Porredon}, A. and {Prat}, J. and + {Pujol}, A. and {Rau}, M.~M. and {Refregier}, A. and {Ricker}, P.~M. and + {Roe}, N. and {Rollins}, R.~P. and {Romer}, A.~K. and {Roodman}, A. and + {Rosenfeld}, R. and {Ross}, A.~J. and {Rozo}, E. and {Rykoff}, E.~S. and + {Sako}, M. and {Salvador}, A.~I. and {Samuroff}, S. and {S{\'a}nchez}, C. and + {Sanchez}, E. and {Santiago}, B. and {Scarpine}, V. and {Schindler}, R. and + {Scolnic}, D. and {Secco}, L.~F. and {Serrano}, S. and {Sevilla-Noarbe}, I. and + {Sheldon}, E. and {Smith}, R.~C. and {Smith}, M. and {Smith}, J. and + {Soares-Santos}, M. and {Sobreira}, F. and {Suchyta}, E. and + {Tarle}, G. and {Thomas}, D. and {Troxel}, M.~A. and {Tucker}, D.~L. and + {Tucker}, B.~E. and {Uddin}, S.~A. and {Varga}, T.~N. and {Vielzeuf}, P. and + {Vikram}, V. and {Vivas}, A.~K. and {Walker}, A.~R. and {Wang}, M. and + {Wechsler}, R.~H. and {Weller}, J. and {Wester}, W. and {Wolf}, R.~C. and + {Yanny}, B. and {Yuan}, F. and {Zenteno}, A. and {Zhang}, B. and + {Zhang}, Y. and {Zuntz}, J.}, + title = "{Dark Energy Survey Year 1 Results: Cosmological Constraints from Galaxy Clustering and Weak Lensing}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1708.01530}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = aug, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv170801530D}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017MNRAS.468.2590S, + author = {{Suyu}, S.~H. and {Bonvin}, V. and {Courbin}, F. and {Fassnacht}, C.~D. and + {Rusu}, C.~E. and {Sluse}, D. and {Treu}, T. and {Wong}, K.~C. and + {Auger}, M.~W. and {Ding}, X. and {Hilbert}, S. and {Marshall}, P.~J. and + {Rumbaugh}, N. and {Sonnenfeld}, A. and {Tewes}, M. and {Tihhonova}, O. and + {Agnello}, A. and {Blandford}, R.~D. and {Chen}, G.~C.-F. and + {Collett}, T. and {Koopmans}, L.~V.~E. and {Liao}, K. and {Meylan}, G. and + {Spiniello}, C.}, + title = "{H0LiCOW - I. H$_{0}$ Lenses in COSMOGRAIL's Wellspring: program overview}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1607.00017}, + keywords = {gravitational lensing: strong, quasars: individual: B1608+656, RXJ1131-1231, HE 0435-1223, WFI2033-4723, HE 1104-1805, galaxies: structure, cosmological parameters, distance scale}, + year = 2017, + month = jul, + volume = 468, + pages = {2590-2604}, + doi = {10.1093/mnras/stx483}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017MNRAS.468.2590S}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017A&A...603A..60F, + author = {{Frontera-Pons}, J. and {Sureau}, F. and {Bobin}, J. and {Le Floc'h}, E. + }, + title = "{Unsupervised feature-learning for galaxy SEDs with denoising autoencoders}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {1705.05620}, + primaryClass = "astro-ph.IM", + keywords = {methods: statistical, galaxies: star formation, methods: data analysis, galaxies: photometry}, + year = 2017, + month = jul, + volume = 603, + eid = {A60}, + pages = {A60}, + doi = {10.1051/0004-6361/201630240}, + adsurl = {http://adsabs.harvard.edu/abs/2017A%26A...603A..60F}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017JCAP...07..017L, + author = {{Laurent}, P. and {Eftekharzadeh}, S. and {Le Goff}, J.-M. and + {Myers}, A. and {Burtin}, E. and {White}, M. and {Ross}, A.~J. and + {Tinker}, J. and {Tojeiro}, R. and {Bautista}, J. and {Brinkmann}, J. and + {Comparat}, J. and {Dawson}, K. and {du Mas des Bourboux}, H. and + {Kneib}, J.-P. and {McGreer}, I.~D. and {Palanque-Delabrouille}, N. and + {Percival}, W.~J. and {Prada}, F. and {Rossi}, G. and {Schneider}, D.~P. and + {Weinberg}, D. and {Y{\`e}che}, C. and {Zarrouk}, P. and {Zhao}, G.-B. + }, + title = "{Clustering of quasars in SDSS-IV eBOSS: study of potential systematics and bias determination}", + journal = {\jcap}, +archivePrefix = "arXiv", + eprint = {1705.04718}, + year = 2017, + month = jul, + volume = 7, + eid = {017}, + pages = {017}, + doi = {10.1088/1475-7516/2017/07/017}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017JCAP...07..017L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170806356I, + author = {{Ibata}, R. and {McConnachie}, A. and {Cuillandre}, J.-C. and + {Fantin}, N. and {Haywood}, M. and {Martin}, N.~F. and {Bergeron}, P. and + {Beckmann}, V. and {Bernard}, E. and {Bonifacio}, P. and {Caffau}, E. and + {Carlberg}, R. and {C{\^o}t{\'e}}, P. and {Cabanac}, R. and + {Chapman}, S. and {Duc}, P.-A. and {Durret}, F. and {Famaey}, B. and + {Frabbro}, S. and {Gwyn}, S. and {Hammer}, F. and {Hill}, V. and + {Hudson}, M.~J. and {Lan{\c c}on}, A. and {Lewis}, G. and {Malhan}, K. and + {di Matteo}, P. and {McCracken}, H. and {Mei}, S. and {Mellier}, Y. and + {Navarro}, J. and {Pires}, S. and {Pritchet}, C. and {Reyl{\'e}}, C. and + {Richer}, H. and {Robin}, A.~C. and {S{\'a}nchez Jannsen}, R. and + {Sawicki}, M. and {Scott}, D. and {Scottez}, V. and {Spekkens}, K. and + {Starkenburg}, E. and {Thomas}, G. and {Venn}, K.}, + title = "{The Canada-France Imaging Survey: First results from the u-band component}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1708.06356}, + keywords = {Astrophysics - Astrophysics of Galaxies}, + year = 2017, + month = aug, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv170806356I}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170502629S, + author = {{Scottez}, V. and {Benoit-L{\'e}vy}, A. and {Coupon}, J. and + {Ilbert}, O. and {Mellier}, Y.}, + title = "{Testing the accuracy of clustering redshift with simulations}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1705.02629}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = may, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv170502629S}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170701285P, + author = {{Pujol}, A. and {Sureau}, F. and {Bobin}, J. and {Courbin}, F. and + {Gentile}, M. and {Kilbinger}, M.}, + title = "{Shear measurement bias: dependencies on methods, simulation parameters and measured parameters}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1707.01285}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = jul, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv170701285P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2015A&A...575A..41G, + author = {{Guyonnet}, A. and {Astier}, P. and {Antilogus}, P. and {Regnault}, N. and + {Doherty}, P.}, + title = "{Evidence for self-interaction of charge distribution in charge-coupled devices}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {1501.01577}, + primaryClass = "astro-ph.IM", + keywords = {instrumentation: detectors, methods: data analysis, techniques: photometric, astronomical databases: miscellaneous, telescopes, techniques: image processing}, + year = 2015, + month = mar, + volume = 575, + eid = {A41}, + pages = {A41}, + doi = {10.1051/0004-6361/201424897}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015A%26A...575A..41G}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017A&A...604A.104L, + author = {{Lacasa}, F. and {Kunz}, M.}, + title = "{Inadequacy of internal covariance estimation for super-sample covariance}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {1703.03337}, + keywords = {large-scale structure of Universe, methods: analytical}, + year = 2017, + month = aug, + volume = 604, + eid = {A104}, + pages = {A104}, + doi = {10.1051/0004-6361/201730784}, + adsurl = {http://adsabs.harvard.edu/abs/2017A%26A...604A.104L}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2016MNRAS.456L.132S, + author = {{Sellentin}, E. and {Heavens}, A.~F.}, + title = "{Parameter inference with estimated covariance matrices}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1511.05969}, + keywords = {methods: data analysis, methods: statistical, cosmology: observations}, + year = 2016, + month = feb, + volume = 456, + pages = {L132-L136}, + doi = {10.1093/mnrasl/slv190}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2016MNRAS.456L.132S}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017MNRAS.466.1444C, + author = {{Clerkin}, L. and {Kirk}, D. and {Manera}, M. and {Lahav}, O. and + {Abdalla}, F. and {Amara}, A. and {Bacon}, D. and {Chang}, C. and + {Gazta{\~n}aga}, E. and {Hawken}, A. and {Jain}, B. and {Joachimi}, B. and + {Vikram}, V. and {Abbott}, T. and {Allam}, S. and {Armstrong}, R. and + {Benoit-L{\'e}vy}, A. and {Bernstein}, G.~M. and {Bernstein}, R.~A. and + {Bertin}, E. and {Brooks}, D. and {Burke}, D.~L. and {Rosell}, A.~C. and + {Carrasco Kind}, M. and {Crocce}, M. and {Cunha}, C.~E. and + {D'Andrea}, C.~B. and {da Costa}, L.~N. and {Desai}, S. and + {Diehl}, H.~T. and {Dietrich}, J.~P. and {Eifler}, T.~F. and + {Evrard}, A.~E. and {Flaugher}, B. and {Fosalba}, P. and {Frieman}, J. and + {Gerdes}, D.~W. and {Gruen}, D. and {Gruendl}, R.~A. and {Gutierrez}, G. and + {Honscheid}, K. and {James}, D.~J. and {Kent}, S. and {Kuehn}, K. and + {Kuropatkin}, N. and {Lima}, M. and {Melchior}, P. and {Miquel}, R. and + {Nord}, B. and {Plazas}, A.~A. and {Romer}, A.~K. and {Roodman}, A. and + {Sanchez}, E. and {Schubnell}, M. and {Sevilla-Noarbe}, I. and + {Smith}, R.~C. and {Soares-Santos}, M. and {Sobreira}, F. and + {Suchyta}, E. and {Swanson}, M.~E.~C. and {Tarle}, G. and {Walker}, A.~R. + }, + title = "{Testing the lognormality of the galaxy and weak lensing convergence distributions from Dark Energy Survey maps}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1605.02036}, + keywords = {gravitational lensing: weak, cosmology: observations, large-scale structure of Universe}, + year = 2017, + month = apr, + volume = 466, + pages = {1444-1461}, + doi = {10.1093/mnras/stw2106}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017MNRAS.466.1444C}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170801533Z, + author = {{Zuntz}, J. and {Sheldon}, E. and {Samuroff}, S. and {Troxel}, M.~A. and + {Jarvis}, M. and {MacCrann}, N. and {Gruen}, D. and {Prat}, J. and + {S{\'a}nchez}, C. and {Choi}, A. and {Bridle}, S.~L. and {Bernstein}, G.~M. and + {Dodelson}, S. and {Drlica-Wagner}, A. and {Fang}, Y. and {Gruendl}, R.~A. and + {Hoyle}, B. and {Huff}, E.~M. and {Jain}, B. and {Kirk}, D. and + {Kacprzak}, T. and {Krawiec}, C. and {Plazas}, A.~A. and {Rollins}, R.~P. and + {Rykoff}, E.~S. and {Sevilla-Noarbe}, I. and {Soergel}, B. and + {Varga}, T.~N. and {Abbott}, T.~M.~C. and {Abdalla}, F.~B. and + {Allam}, S. and {Annis}, J. and {Bechtol}, K. and {Benoit-L{\'e}vy}, A. and + {Bertin}, E. and {Buckley-Geer}, E. and {Burke}, D.~L. and {Carnero Rosell}, A. and + {Carrasco Kind}, M. and {Carretero}, J. and {Castander}, F.~J. and + {Crocce}, M. and {Cunha}, C.~E. and {D'Andrea}, C.~B. and {da Costa}, L.~N. and + {Davis}, C. and {Desai}, S. and {Diehl}, H.~T. and {Dietrich}, J.~P. and + {Doel}, P. and {Eifler}, T.~F. and {Estrada}, J. and {Evrard}, A.~E. and + {Fausti Neto}, A. and {Fernandez}, E. and {Flaugher}, B. and + {Fosalba}, P. and {Frieman}, J. and {Garc{\'{\i}}a-Bellido}, J. and + {Gaztanaga}, E. and {Gerdes}, D.~W. and {Giannantonio}, T. and + {Gschwend}, J. and {Gutierrez}, G. and {Hartley}, W.~G. and + {Honscheid}, K. and {James}, D.~J. and {Jeltema}, T. and {Johnson}, M.~W.~G. and + {Johnson}, M.~D. and {Kuehn}, K. and {Kuhlmann}, S. and {Kuropatkin}, N. and + {Lahav}, O. and {Li}, T.~S. and {Lima}, M. and {Maia}, M.~A.~G. and + {March}, M. and {Martini}, P. and {Melchior}, P. and {Menanteau}, F. and + {Miller}, C.~J. and {Miquel}, R. and {Mohr}, J.~J. and {Neilsen}, E. and + {Nichol}, R.~C. and {Ogando}, R.~L.~C. and {Roe}, N. and {Romer}, A.~K. and + {Roodman}, A. and {Sanchez}, E. and {Scarpine}, V. and {Schindler}, R. and + {Schubnell}, M. and {Smith}, M. and {Smith}, R.~C. and {Soares-Santos}, M. and + {Sobreira}, F. and {Suchyta}, E. and {Swanson}, M.~E.~C. and + {Tarle}, G. and {Thomas}, D. and {Tucker}, D.~L. and {Vikram}, V. and + {Walker}, A.~R. and {Wechsler}, R.~H. and {Zhang}, Y.}, + title = "{Dark Energy Survey Year 1 Results: Weak Lensing Shape Catalogues}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1708.01533}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = aug, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv170801533Z}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017A&A...601A..66F, + author = {{Farrens}, S. and {Ngol{\`e} Mboula}, F.~M. and {Starck}, J.-L. + }, + title = "{Space variant deconvolution of galaxy survey images}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {1703.02305}, + primaryClass = "astro-ph.IM", + keywords = {methods: numerical, techniques: image processing, surveys}, + year = 2017, + month = may, + volume = 601, + eid = {A66}, + pages = {A66}, + doi = {10.1051/0004-6361/201629709}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017A%26A...601A..66F}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2013PhRvD..87d3509Z, + author = {{Zentner}, A.~R. and {Semboloni}, E. and {Dodelson}, S. and + {Eifler}, T. and {Krause}, E. and {Hearin}, A.~P.}, + title = "{Accounting for baryons in cosmological constraints from cosmic shear}", + journal = {\prd}, +archivePrefix = "arXiv", + eprint = {1212.1177}, + keywords = {Cosmology, Galactic halo, Distances redshifts radial velocities, spatial distribution of galaxies}, + year = 2013, + month = feb, + volume = 87, + number = 4, + eid = {043509}, + pages = {043509}, + doi = {10.1103/PhysRevD.87.043509}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2013PhRvD..87d3509Z}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2013MNRAS.436..819J, + author = {{Joachimi}, B. and {Semboloni}, E. and {Hilbert}, S. and {Bett}, P.~E. and + {Hartlap}, J. and {Hoekstra}, H. and {Schneider}, P.}, + title = "{Intrinsic galaxy shapes and alignments - II. Modelling the intrinsic alignment contamination of weak lensing surveys}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1305.5791}, + primaryClass = "astro-ph.CO", + keywords = {gravitational lensing: weak, methods: numerical, methods: statistical, galaxies: evolution, cosmology: observations, large-scale structure of Universe}, + year = 2013, + month = nov, + volume = 436, + pages = {819-838}, + doi = {10.1093/mnras/stt1618}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2013MNRAS.436..819J}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2015SSRv..193..139K, + author = {{Kirk}, D. and {Brown}, M.~L. and {Hoekstra}, H. and {Joachimi}, B. and + {Kitching}, T.~D. and {Mandelbaum}, R. and {Sif{\'o}n}, C. and + {Cacciato}, M. and {Choi}, A. and {Kiessling}, A. and {Leonard}, A. and + {Rassat}, A. and {Sch{\"a}fer}, B.~M.}, + title = "{Galaxy Alignments: Observations and Impact on Cosmology}", + journal = {\ssr}, +archivePrefix = "arXiv", + eprint = {1504.05465}, + keywords = {Galaxies: evolution, Galaxies: haloes, Galaxies: interactions, Large-scale structure of Universe, Gravitational lensing: weak}, + year = 2015, + month = nov, + volume = 193, + pages = {139-211}, + doi = {10.1007/s11214-015-0213-4}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2015SSRv..193..139K}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2012MNRAS.423..909C, + author = {{Cunha}, C.~E. and {Huterer}, D. and {Busha}, M.~T. and {Wechsler}, R.~H. + }, + title = "{Sample variance in photometric redshift calibration: cosmological biases and survey requirements}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1109.5691}, + keywords = {cosmological parameters, cosmology: observations, cosmology: theory, dark energy, large-scale structure of Universe}, + year = 2012, + month = jun, + volume = 423, + pages = {909-924}, + doi = {10.1111/j.1365-2966.2012.20927.x}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2012MNRAS.423..909C}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170706627J, + author = {{Joudaki}, S. and {Blake}, C. and {Johnson}, A. and {Amon}, A. and + {Asgari}, M. and {Choi}, A. and {Erben}, T. and {Glazebrook}, K. and + {Harnois-Deraps}, J. and {Heymans}, C. and {Hildebrandt}, H. and + {Hoekstra}, H. and {Klaes}, D. and {Kuijken}, K. and {Lidman}, C. and + {Mead}, A. and {Miller}, L. and {Parkinson}, D. and {Poole}, G.~B. and + {Schneider}, P. and {Viola}, M. and {Wolf}, C.}, + title = "{KiDS-450 + 2dFLenS: Cosmological parameter constraints from weak gravitational lensing tomography and overlapping redshift-space galaxy clustering}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1707.06627}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = jul, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv170706627J}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{1915SPAW.......844E, + author = {{Einstein}, A.}, + title = "{Die Feldgleichungen der Gravitation}", + journal = {Sitzungsberichte der K{\"o}niglich Preu{\ss}ischen Akademie der Wissenschaften (Berlin), Seite 844-847.}, + year = 1915, + adsurl = {http://cdsads.u-strasbg.fr/abs/1915SPAW.......844E}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170306066N, + author = {{Ngol{\`e} Mboula}, F.~M. and {Starck}, J.-L.}, + title = "{PSF field learning based on Optimal Transport Distances}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1703.06066}, + primaryClass = "cs.CV", + keywords = {Computer Science - Computer Vision and Pattern Recognition, Astrophysics - Instrumentation and Methods for Astrophysics, 49M99}, + year = 2017, + month = mar, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv170306066N}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2016arXiv160808104N, + author = {{Ngol{\`e} Mboula}, F.~M. and {Starck}, J.-L. and {Okumura}, K. and + {Amiaux}, J. and {Hudelot}, P.}, + title = "{Constraint matrix factorization for space variant PSFs field restoration}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1608.08104}, + primaryClass = "cs.CV", + keywords = {Computer Science - Computer Vision and Pattern Recognition, Astrophysics - Instrumentation and Methods for Astrophysics, 00}, + year = 2016, + month = aug, + adsurl = {http://cdsads.u-strasbg.fr/abs/2016arXiv160808104N}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2014MNRAS.442.2728T, + author = {{Taylor}, A. and {Joachimi}, B.}, + title = "{Estimating cosmological parameter covariance}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1402.6983}, + keywords = {methods: data analysis, methods: statistical, cosmological parameters, large-scale structure of Universe}, + year = 2014, + month = aug, + volume = 442, + pages = {2728-2738}, + doi = {10.1093/mnras/stu996}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2014MNRAS.442.2728T}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv170302049D, + author = {{Durkalec}, A. and {Le F{\'e}vre}, O. and {Pollo}, A. and {Zamorani}, G. and + {Lemaux}, B.~C. and {Garilli}, B. and {Bardelli}, S. and {Hathi}, N. and + {Koekemoer}, A. and {Pforr}, J. and {Zucca}, E.}, + title = "{The VIMOS Ultra Deep Survey. Luminosity and stellar mass dependence of galaxy clustering at z\~{}3}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1703.02049}, + keywords = {Astrophysics - Astrophysics of Galaxies, Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = mar, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv170302049D}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2018MNRAS.474.1116S, + author = {{Shan}, H. and {Liu}, X. and {Hildebrandt}, H. and {Pan}, C. and + {Martinet}, N. and {Fan}, Z. and {Schneider}, P. and {Asgari}, M. and + {Harnois-D{\'e}raps}, J. and {Hoekstra}, H. and {Wright}, A. and + {Dietrich}, J.~P. and {Erben}, T. and {Getman}, F. and {Grado}, A. and + {Heymans}, C. and {Klaes}, D. and {Kuijken}, K. and {Merten}, J. and + {Puddu}, E. and {Radovich}, M. and {Wang}, Q.}, + title = "{KiDS-450: cosmological constraints from weak lensing peak statistics - I. Inference from analytical prediction of high signal-to-noise ratio convergence peaks}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1709.07651}, + keywords = {gravitational lensing: weak, dark matter, large-scale structure of Universe}, + year = 2018, + month = feb, + volume = 474, + pages = {1116-1134}, + doi = {10.1093/mnras/stx2837}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2018MNRAS.474.1116S}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + + +@ARTICLE{2018MNRAS.474..712M, + author = {{Martinet}, N. and {Schneider}, P. and {Hildebrandt}, H. and + {Shan}, H. and {Asgari}, M. and {Dietrich}, J.~P. and {Harnois-D{\'e}raps}, J. and + {Erben}, T. and {Grado}, A. and {Heymans}, C. and {Hoekstra}, H. and + {Klaes}, D. and {Kuijken}, K. and {Merten}, J. and {Nakajima}, R. + }, + title = "{KiDS-450: cosmological constraints from weak-lensing peak statistics - II: Inference from shear peaks using N-body simulations}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1709.07678}, + keywords = {gravitational lensing: weak, surveys, cosmological parameters, cosmology: observations}, + year = 2018, + month = feb, + volume = 474, + pages = {712-730}, + doi = {10.1093/mnras/stx2793}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2018MNRAS.474..712M}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv171005045G, + author = {{Gruen}, D. and {Friedrich}, O. and {Krause}, E. and {DeRose}, J. and + {Cawthon}, R. and {Davis}, C. and {Elvin-Poole}, J. and {Rykoff}, E.~S. and + {Wechsler}, R.~H. and {Alarcon}, A. and {Bernstein}, G.~M. and + {Blazek}, J. and {Chang}, C. and {Clampitt}, J. and {Crocce}, M. and + {De Vicente}, J. and {Gatti}, M. and {Gill}, M.~S.~S. and {Hartley}, W.~G. and + {Hilbert}, S. and {Hoyle}, B. and {Jain}, B. and {Jarvis}, M. and + {Lahav}, O. and {MacCrann}, N. and {McClintock}, T. and {Prat}, J. and + {Rollins}, R.~P. and {Ross}, A.~J. and {Rozo}, E. and {Samuroff}, S. and + {S{\'a}nchez}, C. and {Sheldon}, E. and {Troxel}, M.~A. and + {Zuntz}, J. and {Abbott}, T.~M.~C. and {Abdalla}, F.~B. and + {Allam}, S. and {Annis}, J. and {Bechtol}, K. and {Benoit-L{\'e}vy}, A. and + {Bertin}, E. and {Bridle}, S.~L. and {Brooks}, D. and {Buckley-Geer}, E. and + {Carnero Rosell}, A. and {Carrasco Kind}, M. and {Carretero}, J. and + {Cunha}, C.~E. and {D'Andrea}, C.~B. and {da Costa}, L.~N. and + {Desai}, S. and {Diehl}, H.~T. and {Dietrich}, J.~P. and {Doel}, P. and + {Drlica-Wagner}, A. and {Fernandez}, E. and {Flaugher}, B. and + {Fosalba}, P. and {Frieman}, J. and {Garc{\'{\i}}a-Bellido}, J. and + {Gaztanaga}, E. and {Giannantonio}, T. and {Gruendl}, R.~A. and + {Gschwend}, J. and {Gutierrez}, G. and {Honscheid}, K. and {James}, D.~J. and + {Jeltema}, T. and {Kuehn}, K. and {Kuropatkin}, N. and {Lima}, M. and + {March}, M. and {Marshall}, J.~L. and {Martini}, P. and {Melchior}, P. and + {Menanteau}, F. and {Miquel}, R. and {Mohr}, J.~J. and {Plazas}, A.~A. and + {Roodman}, A. and {Sanchez}, E. and {Scarpine}, V. and {Schubnell}, M. and + {Sevilla-Noarbe}, I. and {Smith}, M. and {Smith}, R.~C. and + {Soares-Santos}, M. and {Sobreira}, F. and {Swanson}, M.~E.~C. and + {Tarle}, G. and {Thomas}, D. and {Vikram}, V. and {Walker}, A.~R. and + {Weller}, J. and {Zhang}, Y.}, + title = "{Density split statistics: Cosmological constraints from counts and lensing in cells in DES Y1 and SDSS}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1710.05045}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = oct, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv171005045G}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2011arXiv1101.0955M, + author = {{Marin}, J.-M. and {Pudlo}, P. and {Robert}, C.~P. and {Ryder}, R. + }, + title = "{Approximate Bayesian Computational methods}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1101.0955}, + primaryClass = "stat.CO", + keywords = {Statistics - Computation}, + year = 2011, + month = jan, + adsurl = {http://adsabs.harvard.edu/abs/2011arXiv1101.0955M}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2012MNRAS.425...44C, + author = {{Cameron}, E. and {Pettitt}, A.~N.}, + title = "{Approximate Bayesian Computation for astronomical model analysis: a case study in galaxy demographics and morphological transformation at high redshift}", + journal = {\mnras}, +archivePrefix = "arXiv", + eprint = {1202.1426}, + primaryClass = "astro-ph.IM", + keywords = {methods: statistical, galaxies: evolution, galaxies: formation }, + year = 2012, + month = sep, + volume = 425, + pages = {44-65}, + doi = {10.1111/j.1365-2966.2012.21371.x}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2012MNRAS.425...44C}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{McKinley09, +title = {Inference in Epidemic Models without Likelihoods}, +author = {Trevelyan, McKinley and R, Cook Alex and Robert, Deardon}, +year = {2009}, +journal = {The International Journal of Biostatistics}, +volume = {5}, +number = {1}, +pages = {1-40}, +abstract = {Likelihood-based inference for epidemic models can be challenging, in part due to difficulties in evaluating the likelihood. The problem is particularly acute in models of large-scale outbreaks, and unobserved or partially observed data further complicates this process. Here we investigate the performance of Markov Chain Monte Carlo and Sequential Monte Carlo algorithms for parameter inference, where the routines are based on approximate likelihoods generated from model simulations. We compare our results to a gold-standard data-augmented MCMC for both complete and incomplete data. We illustrate our techniques using simulated epidemics as well as data from a recent outbreak of Ebola Haemorrhagic Fever in the Democratic Republic of Congo and discuss situations in which we think simulation-based inference may be preferable to likelihood-based inference.}, +url = {https://EconPapers.repec.org/RePEc:bpj:ijbist:v:5:y:2009:i:1:n:24} +} + +@ARTICLE{2017arXiv171003235M, + author = {{Mandelbaum}, R.}, + title = "{Weak lensing for precision cosmology}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1710.03235}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = oct, + adsurl = {http://cdsads.u-strasbg.fr/abs/2017arXiv171003235M}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2015IJMPD..2430011F, + author = {{Futamase}, T.}, + title = "{Gravitational lensing in cosmology}", + journal = {International Journal of Modern Physics D}, + keywords = {Cosmology, gravitational lensing, strong lensing, weak lensing, Observational cosmology}, + year = 2015, + month = feb, + volume = 24, + eid = {1530011}, + pages = {1530011}, + doi = {10.1142/S0218271815300116}, + adsurl = {http://adsabs.harvard.edu/abs/2015IJMPD..2430011F}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2006astro.ph..5313U, + author = {{Uzan}, J.-P.}, + title = "{The acceleration of the universe and the physics behind it}", + journal = {ArXiv Astrophysics e-prints}, + eprint = {astro-ph/0605313}, + keywords = {Astrophysics, General Relativity and Quantum Cosmology, High Energy Physics - Phenomenology}, + year = 2006, + month = may, + adsurl = {http://adsabs.harvard.edu/abs/2006astro.ph..5313U}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2001PhRvD..64h3004U, + author = {{Uzan}, J.-P. and {Bernardeau}, F.}, + title = "{Lensing at cosmological scales: A test of higher dimensional gravity}", + journal = {\prd}, + eprint = {hep-ph/0012011}, + keywords = {Gravitational lenses and luminous arcs, Gravity in more than four dimensions Kaluza-Klein theory unified field theories, alternative theories of gravity, Field theories in dimensions other than four, Cosmology}, + year = 2001, + month = oct, + volume = 64, + number = 8, + eid = {083004}, + pages = {083004}, + doi = {10.1103/PhysRevD.64.083004}, + adsurl = {http://adsabs.harvard.edu/abs/2001PhRvD..64h3004U}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{Soldner1804, + author = {von Soldner, J.~G.}, + title = "{{\"U}ber die Ablenkung eines Lichtstrahls von seiner + geradlinigen Bewegung durch die Attraktion eines + Weltk{\"o}rpers, an welchem er n{\"a}he vorbeigeht}", + year = {1804}, + journal = "{Berliner Astron.~Jahrb.}", + volume = 29, + pages = {161 -- 172}, +} + +@ARTICLE{2011ApJ...742...15T, + author = {{Takahashi}, R. and {Oguri}, M. and {Sato}, M. and {Hamana}, T. + }, + title = "{Probability Distribution Functions of Cosmological Lensing: Convergence, Shear, and Magnification}", + journal = {\apj}, +archivePrefix = "arXiv", + eprint = {1106.3823}, + keywords = {cosmology: theory, dark matter, gravitational lensing: weak, large-scale structure of universe, methods: numerical}, + year = 2011, + month = nov, + volume = 742, + eid = {15}, + pages = {15}, + doi = {10.1088/0004-637X/742/1/15}, + adsurl = {http://adsabs.harvard.edu/abs/2011ApJ...742...15T}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2014A&A...566A..54P, + author = {{Planck Collaboration} and {Ade}, P.~A.~R. and {Aghanim}, N. and + {Arnaud}, M. and {Ashdown}, M. and {Aumont}, J. and {Baccigalupi}, C. and + {Banday}, A.~J. and {Barreiro}, R.~B. and {Bartlett}, J.~G. and + {Battaner}, E. and {Benabed}, K. and {Benoit-L{\'e}vy}, A. and + {Bernard}, J.-P. and {Bersanelli}, M. and {Bielewicz}, P. and + {Bobin}, J. and {Bonaldi}, A. and {Bond}, J.~R. and {Bouchet}, F.~R. and + {Burigana}, C. and {Cardoso}, J.-F. and {Catalano}, A. and {Chamballu}, A. and + {Chiang}, H.~C. and {Christensen}, P.~R. and {Clements}, D.~L. and + {Colombi}, S. and {Colombo}, L.~P.~L. and {Couchot}, F. and + {Cuttaia}, F. and {Danese}, L. and {Davies}, R.~D. and {Davis}, R.~J. and + {de Bernardis}, P. and {de Rosa}, A. and {de Zotti}, G. and + {Delabrouille}, J. and {Dickinson}, C. and {Diego}, J.~M. and + {Dole}, H. and {Donzelli}, S. and {Dor{\'e}}, O. and {Douspis}, M. and + {Dupac}, X. and {En{\ss}lin}, T.~A. and {Eriksen}, H.~K. and + {Finelli}, F. and {Forni}, O. and {Frailis}, M. and {Franceschi}, E. and + {Galeotta}, S. and {Galli}, S. and {Ganga}, K. and {Giard}, M. and + {Giraud-H{\'e}raud}, Y. and {Gonz{\'a}lez-Nuevo}, J. and {G{\'o}rski}, K.~M. and + {Gregorio}, A. and {Gruppuso}, A. and {Hansen}, F.~K. and {Harrison}, D.~L. and + {Henrot-Versill{\'e}}, S. and {Hern{\'a}ndez-Monteagudo}, C. and + {Herranz}, D. and {Hildebrandt}, S.~R. and {Hivon}, E. and {Hobson}, M. and + {Holmes}, W.~A. and {Hornstrup}, A. and {Hovest}, W. and {Huffenberger}, K.~M. and + {Jaffe}, A.~H. and {Jaffe}, T.~R. and {Jones}, W.~C. and {Juvela}, M. and + {Keih{\"a}nen}, E. and {Keskitalo}, R. and {Kisner}, T.~S. and + {Kneissl}, R. and {Knoche}, J. and {Knox}, L. and {Kunz}, M. and + {Kurki-Suonio}, H. and {Lagache}, G. and {L{\"a}hteenm{\"a}ki}, A. and + {Lamarre}, J.-M. and {Lasenby}, A. and {Lawrence}, C.~R. and + {Leonardi}, R. and {Liddle}, A. and {Liguori}, M. and {Lilje}, P.~B. and + {Linden-V{\o}rnle}, M. and {L{\'o}pez-Caniego}, M. and {Lubin}, P.~M. and + {Mac{\'{\i}}as-P{\'e}rez}, J.~F. and {Maffei}, B. and {Maino}, D. and + {Mandolesi}, N. and {Maris}, M. and {Martin}, P.~G. and {Mart{\'{\i}}nez-Gonz{\'a}lez}, E. and + {Masi}, S. and {Massardi}, M. and {Matarrese}, S. and {Mazzotta}, P. and + {Melchiorri}, A. and {Mendes}, L. and {Mennella}, A. and {Migliaccio}, M. and + {Mitra}, S. and {Miville-Desch{\^e}nes}, M.-A. and {Moneti}, A. and + {Montier}, L. and {Morgante}, G. and {Munshi}, D. and {Murphy}, J.~A. and + {Naselsky}, P. and {Nati}, F. and {Natoli}, P. and {Noviello}, F. and + {Novikov}, D. and {Novikov}, I. and {Oxborrow}, C.~A. and {Pagano}, L. and + {Pajot}, F. and {Paoletti}, D. and {Pasian}, F. and {Perdereau}, O. and + {Perotto}, L. and {Perrotta}, F. and {Pettorino}, V. and {Piacentini}, F. and + {Piat}, M. and {Pierpaoli}, E. and {Pietrobon}, D. and {Plaszczynski{\lowast}}, S. and + {Pointecouteau}, E. and {Polenta}, G. and {Popa}, L. and {Pratt}, G.~W. and + {Puget}, J.-L. and {Rachen}, J.~P. and {Rebolo}, R. and {Reinecke}, M. and + {Remazeilles}, M. and {Renault}, C. and {Ricciardi}, S. and + {Riller}, T. and {Ristorcelli}, I. and {Rocha}, G. and {Rosset}, C. and + {Roudier}, G. and {Rouill{\'e} d'Orfeuil}, B. and {Rubi{\~n}o-Mart{\'{\i}}n}, J.~A. and + {Rusholme}, B. and {Sandri}, M. and {Savelainen}, M. and {Savini}, G. and + {Spencer}, L.~D. and {Spinelli}, M. and {Starck}, J.-L. and + {Sureau}, F. and {Sutton}, D. and {Suur-Uski}, A.-S. and {Sygnet}, J.-F. and + {Tauber}, J.~A. and {Terenzi}, L. and {Toffolatti}, L. and {Tomasi}, M. and + {Tristram}, M. and {Tucci}, M. and {Umana}, G. and {Valenziano}, L. and + {Valiviita}, J. and {Van Tent}, B. and {Vielva}, P. and {Villa}, F. and + {Wade}, L.~A. and {Wandelt}, B.~D. and {White}, M. and {Yvon}, D. and + {Zacchei}, A. and {Zonca}, A.}, + title = "{Planck intermediate results. XVI. Profile likelihoods for cosmological parameters}", + journal = {\aap}, +archivePrefix = "arXiv", + eprint = {1311.1657}, + keywords = {cosmic background radiation, cosmology: observations, cosmology: theory, cosmological parameters, methods: statistical}, + year = 2014, + month = jun, + volume = 566, + eid = {A54}, + pages = {A54}, + doi = {10.1051/0004-6361/201323003}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2014A%26A...566A..54P}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2017arXiv171207541S, + author = {{Simard}, G. and {Omori}, Y. and {Aylor}, K. and {Baxter}, E.~J. and + {Benson}, B.~A. and {Bleem}, L.~E. and {Carlstrom}, J.~E. and + {Chang}, C.~L. and {Cho}, H. and {Chown}, R. and {Crawford}, T.~M. and + {Crites}, A.~T. and {de Haan}, T. and {Dobbs}, M.~A. and {Everett}, W.~B. and + {George}, E.~M. and {Halverson}, N.~W. and {Harrington}, N.~L. and + {Henning}, J.~W. and {Holder}, G.~P. and {Hou}, Z. and {Holzapfel}, W.~L. and + {Hrubes}, J.~D. and {Knox}, L. and {Lee}, A.~T. and {Leitch}, E.~M. and + {Luong-Van}, D. and {Manzotti}, A. and {McMahon}, J.~J. and + {Meyer}, S.~S. and {Mocanu}, L.~M. and {Mohr}, J.~J. and {Natoli}, T. and + {Padin}, S. and {Pryke}, C. and {Reichardt}, C.~L. and {Ruhl}, J.~E. and + {Sayre}, J.~T. and {Schaffer}, K.~K. and {Shirokoff}, E. and + {Staniszewski}, Z. and {Stark}, A.~A. and {Story}, K.~T. and + {Vanderlinde}, K. and {Vieira}, J.~D. and {Williamson}, R. and + {Wu}, W.~L.~K.}, + title = "{Constraints on Cosmological Parameters from the Angular Power Spectrum of a Combined 2500 deg$^2$ SPT-SZ and Planck Gravitational Lensing Map}", + journal = {ArXiv e-prints}, +archivePrefix = "arXiv", + eprint = {1712.07541}, + keywords = {Astrophysics - Cosmology and Nongalactic Astrophysics}, + year = 2017, + month = dec, + adsurl = {http://adsabs.harvard.edu/abs/2017arXiv171207541S}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2009PhRvD..80l3020K, + author = {{Kainulainen}, K. and {Marra}, V.}, + title = "{New stochastic approach to cumulative weak lensing}", + journal = {\prd}, +archivePrefix = "arXiv", + eprint = {0909.0822}, + primaryClass = "astro-ph.CO", + keywords = {Gravitational lenses and luminous arcs, Superclusters, large-scale structure of the Universe, Observational cosmology}, + year = 2009, + month = dec, + volume = 80, + number = 12, + eid = {123020}, + pages = {123020}, + doi = {10.1103/PhysRevD.80.123020}, + adsurl = {http://cdsads.u-strasbg.fr/abs/2009PhRvD..80l3020K}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} + +@ARTICLE{2014PhRvL.112e1303B, + author = {{Battye}, R.~A. and {Moss}, A.}, + title = "{Evidence for Massive Neutrinos from Cosmic Microwave Background and Lensing Observations}", + journal = {Physical Review Letters}, +archivePrefix = "arXiv", + eprint = {1308.5870}, + keywords = {Observational cosmology, Neutrino mass and mixing, Gravitational lenses and luminous arcs, Background radiations}, + year = 2014, + month = feb, + volume = 112, + number = 5, + eid = {051303}, + pages = {051303}, + doi = {10.1103/PhysRevLett.112.051303}, + adsurl = {http://adsabs.harvard.edu/abs/2014PhRvL.112e1303B}, + adsnote = {Provided by the SAO/NASA Astrophysics Data System} +} diff --git a/docs/index.rst b/docs/index.rst index 420234d..9b6df85 100644 --- a/docs/index.rst +++ b/docs/index.rst @@ -3,51 +3,16 @@ You can adapt this file completely to your liking, but it should at least contain the root `toctree` directive. -nicaea : NumerIcal Cosmology And lEnsing cAlculations -===================================================== -http://cosmostat.org/nicaea +nicaea documentation +==================== - -nicaea is the cosmology part of cosmo_pmc, which can be downloaded for free at -http://www.cosmopmc.info. From that site, the cosmo_pmc manual is available for -further information about nicaea, which are more detailed than covered in this -readme. - - -Authors: - - Martin Kilbinger - - Karim Benabed - - Jean Coupon (HOD, halomodel) - - Henry J. McCracken (HOD) - -Contributors: - - Liping Fu (decomp_eb) - - Catherine Heymans (intrinsic alignment) - - -Documentation -============= +Contents: .. toctree:: :maxdepth: 4 - nicaea_2.7 + nicaea -Acknowledgements -================ - -We thank Alexandre Boucaud, Jan Hartlap, Alina Kiessling, Jasmin Pielorz, Peter -Schneider, Rob E. Smith, Patrick Simon, Masahiro Takada, and Melody Wolk for -helpful suggestions. - -Contact -======= - -Feel free to email me at martin.kilbinger@cea.fr - - -Have fun! - Martin Kilbinger Indices and tables ================== @@ -55,3 +20,4 @@ Indices and tables * :ref:`genindex` * :ref:`modindex` * :ref:`search` + diff --git a/docs/nicaea_2.7.rst b/docs/nicaea.rst similarity index 77% rename from docs/nicaea_2.7.rst rename to docs/nicaea.rst index 4b87a6d..960672f 100644 --- a/docs/nicaea_2.7.rst +++ b/docs/nicaea.rst @@ -1,13 +1,63 @@ :numbered: +###### +nicaea +###### + +NumerIcal Cosmology And lEnsing cAlculations + +Version 2.7.2 (04/2018) + +Web page: https://github.com/CosmoStat/nicaea + +******** +Authors: +******** + +Martin Kilbinger + +Karim Benabed + +Jean Coupon (HOD, halomodel) + +Henry J. McCracken (HOD) + +Liping Fu (decomp_eb) + +Catherine Heymans (intrinsic alignment) + +Francois Lanusse (enhancements and interface) + +Documentation +============= + +nicaea is the cosmology part of cosmo_pmc, which can be downloaded for free at +http://www.cosmopmc.info. From that site, the cosmo_pmc manual is available for +further information about nicaea, which are more detailed than covered in this +readme. + +References +========== + +To reference nicaea, please use the publication :cite:`KB09` +(https://arxiv.org/abs/0810.5129), in which something that resembles the +first version of nicaea has been used. + + Download, compile, and run nicaea ================================= Download the code ----------------- -Download the file nicaea_2.7.tgz from http://cosmostat.org/nicaea and un-tar -the archive. The packages fftw3 and gsl are required to compile and run nicaea. +Reommended: Clone the most recent stable version from github with:: + + git clone https://github.com/CosmoStat/nicaea + +Alternatively, download the file ``nicaea_.tgz`` from http://cosmostat.org/nicaea and un-tar +the archive. + +The packages fftw3 and gsl are required to compile and run nicaea. You can install fftw3 from http://www.fftw.org, and gsl from www.gnu.org/software/gsl. @@ -24,9 +74,9 @@ Option 1: using cmake, *recommended*:: make && make install The last command will copy the executable demo programs (e.g. lensingdemo) -to /bin, the library libnicaea.a to /lib, and the include -files to /include/nicaea . The default base directory is -=nicaea_2.7 . +to ``/bin``, the library ``libnicaea.a`` to ``/lib``, and the include +files to ``/include/nicaea``. The default base directory is +``=nicaea_``. If the necessary libraries are found on the system, the python module pynicaea is also installed. @@ -35,26 +85,26 @@ The code can be tested with:: ctest -vv -To run the demo programs (see below), go to nicaea_2.7/par_files . +To run the demo programs (see below), go to ``nicaea_/par_files`` . Option 2: using make.:: cd Demo make -If fftw3 and gsl are not installed in a standard directory (e.g. /usr, -/usr/local), set the variables 'FFTW' and 'GSL' in the Makefile. The header -file fftw3.h is looked for in $(FFTW)/include and libfftw3.a in $(FFTW)/lib. -The gsl header files are looked for in $(GSL)/include, the libraries libgsl.a -and libgslcblas.a in $(GSL)/lib. +If fftw3 and gsl are not installed in a standard directory (e.g. ``/usr``, +``/usr/local``), set the variables 'FFTW' and 'GSL' in the Makefile. The header +file ``fftw3.h`` is looked for in ``$(FFTW)/include`` and ``libfftw3.a`` in ``$(FFTW)/lib``. +The gsl header files are looked for in ``$(GSL)/include``, the libraries ``libgsl.a`` +and ``libgslcblas.a`` in ``$(GSL)/lib``. -Various demo programs can be run in ./Demo, see below. +Various demo programs can be run in ``./Demo``, see below. Run the demo programs --------------------- The demo programs need parameter files in the working directory, which can be -found in par_files. +found in ``par_files``. +------------------------+--------------+-----------------------------------------------------------------------+ | Program name | Category | Functionality | @@ -78,45 +128,49 @@ found in par_files. Main functions ============== -The main functions listed below have as some of their parameters:: - - model: cosmo_lens* structure (see Sect. 4) - Lensing and cosmological paramaters and pre-computed tables - theta, THETA_MIN, THETA_MAX, Psimin, Psimax: double - Angular scale [rad] - R: double[3] - Array of angular scale tripes - i_bin, j_bin, k_bin: int - Redshift bin indices - err: error* (see Sect. 4) - Error structure - n: integer - COSEBIs mode. - path: string - Path to COSEBIs files with zeros for given Psimin and Psimax. Default - is */path/to/nicaea/par_files/COSEBIs/*. - B_cosebi: double* - On output, B_mode is written to this pointer if non zero. - aa: array of doubles - Pre-calculated array of coefficients, see decomp_eb.c. - N: integer - Polynomial order, default 6 - poly: poly_t enumeration type - Polyonmial type, default *cheby2* - wfilter: filter_t enumeration - Aperture-mass filter type, see lensing_3rd.h, default *fgauss*. - a: double - Scale factor, max(0.01,1/(1+zmax))<=a<1.0 - k: double - 3d Fourier wave-mode in h/Mpc - s: double - 2d Fourier wave-mode, 1e-2<=ell<=1e6 - ell: integer - 2D harmonic mode, ell>=2 +The main functions listed below have as some of their parameters: + ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| Name | Type | Description | ++=====================+=====================================+================================================================================================================+ +| model | cosmo_lens* structure (see Sect. 4) | Lensing and cosmological paramaters and pre-computed tables | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| theta, THETA_MIN, | double | Angular scale [rad] | +| THETA_MAX, Psimin, | | | +| Psimax | | | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| R | double[3] | Array of angular scale tripes | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| i_bin, j_bin, k_bin | int | Redshift bin indices | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| err | error* (see Sect. 4) | Error structure | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| n | integer | COSEBIs mode. | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| path | string | Path to COSEBIs files with zeros for given Psimin and Psimax. Default is */path/to/nicaea/par_files/COSEBIs/*. | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| B_cosebi | double* | On output, B_mode is written to this pointer if non zero. | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| aa | array of doubles | Pre-calculated array of coefficients, see decomp_eb.c. | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| N | integer | Polynomial order, default 6 | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| poly | poly_t enumeration type | Polyonmial type, default *cheby2* | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| wfilter | filter_t enumeration | Aperture-mass filter type, see lensing_3rd.h, default *fgauss*. | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| a | double | Scale factor, max(0.01,1/(1+zmax))<=a<1.0 | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| k | double | 3d Fourier wave-mode in h/Mpc | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| s | double | 2d Fourier wave-mode, 1e-2<=ell<=1e6 | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ +| ell | integer | 2D harmonic mode, ell>=2 | ++---------------------+-------------------------------------+----------------------------------------------------------------------------------------------------------------+ The value of the corresponding two- and three-point function is returned as -double. +double. Second-order shear statistics ----------------------------- @@ -137,7 +191,7 @@ Aperture-mass variance, polynomial filter:: Aperture-mass variance, Gaussian filter:: - map2_gauss(model, theta, i_bin, j_bin, err) + map2_gauss(model, theta, i_bin, j_bin, err) COSEBIs (Complete Orthogonal E-/B-mode Integrals), :cite:`COSEBIs`:: @@ -153,7 +207,7 @@ Third-order shear statistics Third-order aperture-mass generalized moment, :cite:`SKL05`:: - map3(model, R, i_bin, i_bin, k_bin, wfilter, err) + map3(model, R, i_bin, i_bin, k_bin, wfilter, err) Power spectra @@ -161,13 +215,13 @@ Power spectra 3d power spectrum of delta:: - P_NL(model, a, k, err) + P_NL(model, a, k, err) 2d shear power spectrum: Pshear or Pshear+Pg^(1) if reduced-shear correction is switched on with key "sreduced = K10" in cosmo_lens.par parameter file. Returns error if sprojection==full:: - Pshear(model, s, i_bin, j_bin, err) + Pshear(model, s, i_bin, j_bin, err) 2d shear power spectrum Pshear for integer ell. Computes full spherical projection for sprojection==full (Kilbinger et al. 2017). Calls Pshear for @@ -178,7 +232,7 @@ other cases of sprojection:: 2d reduced-shear correction power spectrum Pg^(1), see Kilbinger (2010). The totel (reduced-shear) power spectrum is Pkappa + Pg1:: - Pg1(model, s, i_bin, j_bin, err) + Pg1(model, s, i_bin, j_bin, err) Ranges ------ @@ -483,7 +537,8 @@ Flags | | camb | Using camb for T(k) (not yet supported) | +---------------+-------------------+---------------------------------------------------------------------------+ | growth | heath | Heath (1977) analytical expression for linear growth factor (valid only | -| | | for no or a pure cosmological constant, i.e. w0_de=-1, w1_de=0) | +| | | for no or a pure cosmological constant, i.e. w0_de=-1, w1_de=0), | +| | | :cite:`hea:77` | +---------------+-------------------+---------------------------------------------------------------------------+ | | growth_de | General dark energy model | +---------------+-------------------+---------------------------------------------------------------------------+ @@ -596,6 +651,7 @@ Universe there is a maximum redshift, and if the redshift distribution extends over this maximum, the angular diameter distance is undefined and an error is produced. + Extrapolation ============= @@ -616,12 +672,13 @@ called after the first time. The tables are recalculated when cosmological parameters have changed since the previous call. The correlation functions are calculated using a fast Hankel transform. + Known bugs and shortcomings =========================== - Some parameter combinations cause undefined behaviour of the program. These are (hopefully) intercepted and an error is created - (see Sect. 5). E.g., for n_spec<0.7, f_NL (Peacock&Dodds) is not + (see Sect. 5). E.g., for n_spec<0.7, f_NL :cite:`PD96`) is not defined. For a closed Universe, the probed redshift can be larger than the maximum redshift. @@ -631,7 +688,7 @@ Known bugs and shortcomings for the inverse Fisher matrix, numerical derivatives have to be very accurate, and the interpolations between tabulated values (linear and spline) in nicaea introduce numerical noise that can render the Fisher - matrix numerically singular (Wolz et al. 2012). + matrix numerically singular :cite`WKWG12`. - Dark-energy models, in particular with varying w(z), are not recommended for the non_linear models smith03, and smith03_de. Instead, use the @@ -644,10 +701,10 @@ martin.kilbinger@cea.fr . Questions and comments are welcome! Changes compared to the Rob Smith's original halofit ==================================================== -Parts of the program 'cosmo.c' is based on Rob Smiths' halofit (Smith et al. -2003). The code for determining the non-linear power spectrum has been improved +Parts of the program 'cosmo.c' is based on Rob Smiths' halofit :cite:`2003MNRAS.341.1311S`. +The code for determining the non-linear power spectrum has been improved and made more efficient. The main changes are listed below. The code also -includes the non-linear fitting formulae of Peacock & Dodds (1996). +includes the non-linear fitting formulae of :cite:`PD96`. - Tabulation of the linear and non-linear power spectrum, constants are calculated only once. @@ -660,12 +717,18 @@ includes the non-linear fitting formulae of Peacock & Dodds (1996). 10^6 h/Mpc), the bisection is canceled and the linear power spectrum is used. - Slope and curvature are calculated only once, after knl is fixed. -- The Eisenstein&Hu (1998) fit for the transfer function is used +- The Eisenstein & Hu (1998) :cite:`1998ApJ...496..605E` fit for the transfer function is used instead of Bond&Efstathiou (1984). -- The exact linear growth factor is used instead of the CPT92 fitting +- The exact linear growth factor is used instead of the :cite:`CPT:92` fitting formula. Dark energy models are incorporated. +Acknowledgements +================ + +We thank Alexandre Boucaud, Jan Hartlap, Alina Kiessling, Jasmin Pielorz, Peter +Schneider, Rob E. Smith, Patrick Simon, Masahiro Takada, Melody Wolk, and the +CosmoSIS development team for helpful suggestions. References ========== @@ -674,3 +737,14 @@ References :cited: :style: mystyle :encoding: utf + + + +Contact +======= + +Feel free to email me at martin.kilbinger@cea.fr + +Have fun! + Martin Kilbinger + diff --git a/halomodel/include/halomodel.h b/halomodel/include/halomodel.h index 938e1d8..452186b 100644 --- a/halomodel/include/halomodel.h +++ b/halomodel/include/halomodel.h @@ -6,10 +6,6 @@ #ifndef __HALOMODEL_H #define __HALOMODEL_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -28,10 +24,6 @@ extern "C" { #include "cosmo.h" #include "nofz.h" -#ifdef __cplusplus -namespace nicaea { -#endif - #define hm_base -1900 #define hm_hodtype hm_base + 1 #define hm_Mmin hm_base + 2 @@ -329,8 +321,6 @@ CHANGE(Pth); #undef CHANGE -#ifdef __cplusplus -}} -#endif #endif + diff --git a/halomodel/include/hod.h b/halomodel/include/hod.h index 31958b9..de88299 100644 --- a/halomodel/include/hod.h +++ b/halomodel/include/hod.h @@ -6,10 +6,6 @@ #ifndef __HOD_H #define __HOD_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -73,10 +69,6 @@ extern "C" { #define getCharValue(array,col) array+NCHAR*(col-1) #define getLine(array,i) array+NFIELD*NCHAR*i -#ifdef __cplusplus -namespace nicaea { -#endif - #define Nhalodata_t 4 typedef enum {w_of_theta, wp_rp, deltaSigma, smf} halodata_t; #define shalodata_t(i) ( \ @@ -338,8 +330,5 @@ double wp_mwolk(cosmo_hm *model, double rp, error **err); double compute_chisq_wp(cosmo_hm *model, const wt_t *wth, double ngd_obs, double ngd_err, ngal_fit_t ngal_fit_type, double *ngd, int dologw, error **err); -#ifdef __cplusplus -}} -#endif #endif diff --git a/halomodel/src/halomodel.c b/halomodel/src/halomodel.c index b7ea3a1..4a2e8c9 100644 --- a/halomodel/src/halomodel.c +++ b/halomodel/src/halomodel.c @@ -318,7 +318,8 @@ cosmo_hm *set_cosmological_parameters_to_default_hm(error **err) 0.0, 10.0, smith03, eisenhu, growth_de, linder, norm_s8, 9.0, 1.5, 0.13, st2, halo_bias_sc, 11.0, 12.0, 11.0, 0.3, 0.75, - 1.0e11, 0.5, 0.6, 1.5, 1.5, 10.62, -0.13, 0.9, 10.0, -1, 1.0, 0.15, 0.5, hamana04, 60.0, err); + 11.0, 0.5, 0.6, 1.5, 1.5, 10.62, -0.13, 0.9, 10.0, -1, 1.0, 0.15, 0.5, hamana04, 60.0, err); + /* MKDEBUG 04/12/2017: fixed 1e11 -> 11 for log10Mstar0 */ } #undef NZBIN #undef NNZ diff --git a/par_files/cosmo.par b/par_files/cosmo.par index 89d2e97..315f1bd 100644 --- a/par_files/cosmo.par +++ b/par_files/cosmo.par @@ -1,6 +1,6 @@ ### Cosmological parameters ### -Omega_m 0.27 # Matter density, cold dark matter + baryons +Omega_m 0.27 # Matter density, cold dark matter + baryons Omega_de 0.73 # Dark-energy density w0_de -1.0 # Dark-energy equation of state parameter (constant term) w1_de 0.0 # Dark-energy equation of state parameter (linear term) @@ -8,7 +8,7 @@ h_100 0.73 # Dimensionless Hubble parameter Omega_b 0.049 # Baryon density Omega_nu_mass 0.0 # Massive neutrino density (so far only for CMB) Neff_nu_mass 0.0 # Effective number of massive neutrinos (only CMB) -normalization 0.79 # This is sigma_8 if normmode=0 below +normalization 0.9 # This is sigma_8 if normmode=0 below #normalization 2.12650000e-09 # This is A_S if normmode=0 below n_spec 0.96 # Scalar power-spectrum index @@ -42,9 +42,11 @@ sgrowth growth_de # linder w(a) = w_0 + w_1*(1-a) sde_param linder -normmode 0 # Normalization mode. +# Normalization mode. # 0: normalization=sigma_8 # 1: normalization=A_s +normmode 0 # Minimum scale factor a_min 0.1 # For late Universe stuff. Is updated if n(z) goes deeper + diff --git a/par_files/cosmo_lens.par b/par_files/cosmo_lens.par index 33cf46b..64d2e26 100644 --- a/par_files/cosmo_lens.par +++ b/par_files/cosmo_lens.par @@ -26,7 +26,7 @@ stomo tomo_auto_only # limber2_la08_hyb 2nd-order extended Limber, flat sky, hybrid [ExtL2FlHyb] # limber2_la08_sph 2nd-order Limber (LA08) with spherical prefactor [ExtL2Sph] # full Full projection [Full] -sprojection limber2_la08_sph +sprojection limber2_la08_hyb # Reduced-shear correction # none No correction diff --git a/python/bindings.cpp b/python/bindings.cpp new file mode 100644 index 0000000..c6060f7 --- /dev/null +++ b/python/bindings.cpp @@ -0,0 +1,191 @@ +// This file has been generated by Py++. + +#include "boost/python.hpp" + +#include "cosmo.hpp" + +#include "../Cosmo/include/cosmo.h" + +namespace bp = boost::python; + +struct cosmo_wrapper : nicaea::cosmo, bp::wrapper< nicaea::cosmo > { + + cosmo_wrapper(nicaea::cosmo const & arg ) + : nicaea::cosmo( arg ) + , bp::wrapper< nicaea::cosmo >(){ + // copy constructor + + } + + cosmo_wrapper() + : nicaea::cosmo() + , bp::wrapper< nicaea::cosmo >(){ + // null constructor + + } + + static ::nicaea::interTable2D * get_P_NL(nicaea::cosmo const & inst ){ + return inst.P_NL; + } + + static void set_P_NL( nicaea::cosmo & inst, ::nicaea::interTable2D * new_value ){ + inst.P_NL = new_value; + } + + static ::nicaea::interTable * get_linearGrowth(nicaea::cosmo const & inst ){ + return inst.linearGrowth; + } + + static void set_linearGrowth( nicaea::cosmo & inst, ::nicaea::interTable * new_value ){ + inst.linearGrowth = new_value; + } + + static ::nicaea::interTable * get_slope(nicaea::cosmo const & inst ){ + return inst.slope; + } + + static void set_slope( nicaea::cosmo & inst, ::nicaea::interTable * new_value ){ + inst.slope = new_value; + } + + static ::nicaea::interTable * get_transferBE(nicaea::cosmo const & inst ){ + return inst.transferBE; + } + + static void set_transferBE( nicaea::cosmo & inst, ::nicaea::interTable * new_value ){ + inst.transferBE = new_value; + } + + static ::nicaea::interTable * get_transferFct(nicaea::cosmo const & inst ){ + return inst.transferFct; + } + + static void set_transferFct( nicaea::cosmo & inst, ::nicaea::interTable * new_value ){ + inst.transferFct = new_value; + } + + static ::nicaea::interTable * get_w(nicaea::cosmo const & inst ){ + return inst.w; + } + + static void set_w( nicaea::cosmo & inst, ::nicaea::interTable * new_value ){ + inst.w = new_value; + } + +}; + +BOOST_PYTHON_MODULE(nicaea){ + bp::class_< cosmo_wrapper >( "cosmo" ) + .def_readwrite( "As", &nicaea::cosmo::As ) + .def_readwrite( "N_a", &nicaea::cosmo::N_a ) + .def_readwrite( "N_poly_de", &nicaea::cosmo::N_poly_de ) + .def_readwrite( "Neff_nu_mass", &nicaea::cosmo::Neff_nu_mass ) + .def_readwrite( "Omega_b", &nicaea::cosmo::Omega_b ) + .def_readwrite( "Omega_de", &nicaea::cosmo::Omega_de ) + .def_readwrite( "Omega_m", &nicaea::cosmo::Omega_m ) + .def_readwrite( "Omega_nu_mass", &nicaea::cosmo::Omega_nu_mass ) + .add_property( "P_NL" + , bp::make_function( (::nicaea::interTable2D * (*)( ::nicaea::cosmo const & ))(&cosmo_wrapper::get_P_NL), bp::return_internal_reference< >() ) + , bp::make_function( (void (*)( ::nicaea::cosmo &,::nicaea::interTable2D * ))(&cosmo_wrapper::set_P_NL), bp::with_custodian_and_ward_postcall< 1, 2 >() ) ) + .def_readwrite( "a_min", &nicaea::cosmo::a_min ) + .def_readwrite( "cmp_sigma8", &nicaea::cosmo::cmp_sigma8 ) + .def_readwrite( "de_param", &nicaea::cosmo::de_param ) + .def_readwrite( "growth", &nicaea::cosmo::growth ) + .def_readwrite( "growth_delta0", &nicaea::cosmo::growth_delta0 ) + .def_readwrite( "h_100", &nicaea::cosmo::h_100 ) + .add_property( "linearGrowth" + , bp::make_function( (::nicaea::interTable * (*)( ::nicaea::cosmo const & ))(&cosmo_wrapper::get_linearGrowth), bp::return_internal_reference< >() ) + , bp::make_function( (void (*)( ::nicaea::cosmo &,::nicaea::interTable * ))(&cosmo_wrapper::set_linearGrowth), bp::with_custodian_and_ward_postcall< 1, 2 >() ) ) + .def_readwrite( "n_spec", &nicaea::cosmo::n_spec ) + .def_readwrite( "nonlinear", &nicaea::cosmo::nonlinear ) + .def_readwrite( "normalization", &nicaea::cosmo::normalization ) + .def_readwrite( "normmode", &nicaea::cosmo::normmode ) + .def_readwrite( "sigma_8", &nicaea::cosmo::sigma_8 ) + .add_property( "slope" + , bp::make_function( (::nicaea::interTable * (*)( ::nicaea::cosmo const & ))(&cosmo_wrapper::get_slope), bp::return_internal_reference< >() ) + , bp::make_function( (void (*)( ::nicaea::cosmo &,::nicaea::interTable * ))(&cosmo_wrapper::set_slope), bp::with_custodian_and_ward_postcall< 1, 2 >() ) ) + .def_readwrite( "transfer", &nicaea::cosmo::transfer ) + .add_property( "transferBE" + , bp::make_function( (::nicaea::interTable * (*)( ::nicaea::cosmo const & ))(&cosmo_wrapper::get_transferBE), bp::return_internal_reference< >() ) + , bp::make_function( (void (*)( ::nicaea::cosmo &,::nicaea::interTable * ))(&cosmo_wrapper::set_transferBE), bp::with_custodian_and_ward_postcall< 1, 2 >() ) ) + .add_property( "transferFct" + , bp::make_function( (::nicaea::interTable * (*)( ::nicaea::cosmo const & ))(&cosmo_wrapper::get_transferFct), bp::return_internal_reference< >() ) + , bp::make_function( (void (*)( ::nicaea::cosmo &,::nicaea::interTable * ))(&cosmo_wrapper::set_transferFct), bp::with_custodian_and_ward_postcall< 1, 2 >() ) ) + .def_readwrite( "transfer_alpha_Gamma", &nicaea::cosmo::transfer_alpha_Gamma ) + .def_readwrite( "transfer_s", &nicaea::cosmo::transfer_s ) + .add_property( "w" + , bp::make_function( (::nicaea::interTable * (*)( ::nicaea::cosmo const & ))(&cosmo_wrapper::get_w), bp::return_internal_reference< >() ) + , bp::make_function( (void (*)( ::nicaea::cosmo &,::nicaea::interTable * ))(&cosmo_wrapper::set_w), bp::with_custodian_and_ward_postcall< 1, 2 >() ) ) + .def_readwrite( "w0_de", &nicaea::cosmo::w0_de ) + .def_readwrite( "w1_de", &nicaea::cosmo::w1_de ); + + bp::class_< cosmology, bp::bases< nicaea::cosmo > >( "cosmology", bp::init< >() ) + .def( + "D_a" + , (double ( ::cosmology::* )( double ))( &::cosmology::D_a ) + , ( bp::arg("a") ) ) + .def( + "D_a12" + , (double ( ::cosmology::* )( double,double ))( &::cosmology::D_a12 ) + , ( bp::arg("a1"), bp::arg("a2") ) ) + .def( + "D_lum" + , (double ( ::cosmology::* )( double ))( &::cosmology::D_lum ) + , ( bp::arg("a") ) ) + .def( + "Esqr" + , (double ( ::cosmology::* )( double,int ))( &::cosmology::Esqr ) + , ( bp::arg("a"), bp::arg("wOmegar") ) ) + .def( + "Omega_de_a" + , (double ( ::cosmology::* )( double,double ))( &::cosmology::Omega_de_a ) + , ( bp::arg("a"), bp::arg("Esqrpre") ) ) + .def( + "Omega_m_a" + , (double ( ::cosmology::* )( double,double ))( &::cosmology::Omega_m_a ) + , ( bp::arg("a"), bp::arg("Esqrpre") ) ) + .def( + "P" + , (double ( ::cosmology::* )( double,double ))( &::cosmology::P ) + , ( bp::arg("a"), bp::arg("k") ) ) + .def( + "P_L" + , (double ( ::cosmology::* )( double,double ))( &::cosmology::P_L ) + , ( bp::arg("a"), bp::arg("k") ) ) + .def( + "da_dtau" + , (double ( ::cosmology::* )( double ))( &::cosmology::da_dtau ) + , ( bp::arg("a") ) ) + .def( + "drdz" + , (double ( ::cosmology::* )( double ))( &::cosmology::drdz ) + , ( bp::arg("a") ) ) + .def( + "dvdz" + , (double ( ::cosmology::* )( double ))( &::cosmology::dvdz ) + , ( bp::arg("a") ) ) + .def( + "dwoverda" + , (double ( ::cosmology::* )( double ))( &::cosmology::dwoverda ) + , ( bp::arg("a") ) ) + .def( + "f_K" + , (double ( ::cosmology::* )( double ))( &::cosmology::f_K ) + , ( bp::arg("wr") ) ) + .def( + "f_de" + , (double ( ::cosmology::* )( double ))( &::cosmology::f_de ) + , ( bp::arg("a") ) ) + .def( + "w_a" + , (double ( ::cosmology::* )( double,int ))( &::cosmology::w_a ) + , ( bp::arg("a"), bp::arg("wOmegar") ) ) + .def( + "w_de" + , (double ( ::cosmology::* )( double ))( &::cosmology::w_de ) + , ( bp::arg("a") ) ) + .def( + "w_nu_mass" + , (double ( ::cosmology::* )( double ))( &::cosmology::w_nu_mass ) + , ( bp::arg("a") ) ); +} diff --git a/python/cosmo.cpp b/python/cosmo.cpp new file mode 100644 index 0000000..71e2ca8 --- /dev/null +++ b/python/cosmo.cpp @@ -0,0 +1,92 @@ +/* + * + * Copyright (C) 2015 Francois + * + * This program is free software: you can redistribute it and/or modify + * it under the terms of the GNU General Public License as published by + * the Free Software Foundation, either version 3 of the License, or + * (at your option) any later version. + * + * This program is distributed in the hope that it will be useful, + * but WITHOUT ANY WARRANTY; without even the implied warranty of + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + * GNU General Public License for more details. + * + * You should have received a copy of the GNU General Public License + * along with this program. If not, see . + * + */ + +#include "cosmo.hpp" +#include + + +void cosmology::init(double OMEGAM, double OMEGADE, double W0_DE, double W1_DE, double* W_POLY_DE, int N_POLY_DE, double H100, double OMEGAB, double OMEGANUMASS, double NEFFNUMASS, double NORM, double NSPEC, nonlinear_t NONLINEAR, transfer_t TRANSFER, growth_t GROWTH, de_param_t DEPARAM, norm_t normmode, double AMIN) +{ + err = &myerr; + + int N_a_min; + Omega_m = OMEGAM; + Omega_de = OMEGADE; + + if (DEPARAM != poly_DE) { + w0_de = W0_DE; + w1_de = W1_DE; + w_poly_de = NULL; + N_poly_de = 0; + } else { + set_w_poly_de(&w_poly_de, &N_poly_de, W_POLY_DE, N_POLY_DE, 1, err); + + /* MDKDEBUG: know what we are doing here! */ + w0_de = w_poly_de[0]; + w1_de = -1.0e30; + } + + h_100 = H100; + Omega_b = OMEGAB; + Omega_nu_mass = OMEGANUMASS; + Neff_nu_mass = NEFFNUMASS; + normalization = NORM; + n_spec = NSPEC; + + nonlinear = NONLINEAR; + transfer = TRANSFER; + growth = GROWTH; + de_param = DEPARAM; + normmode = normmode; + + if (AMIN>0.0) a_min = AMIN; + else a_min = a_minmin; + + /* Reset pre-computed numbers and tables */ + + /* New 06/2014: Set N_a such that da >= 0.001 */ + N_a_min = (int)((1.0 - a_min) / 0.001) + 1; + if ( N_a_min < _N_a) { + N_a = _N_a; + } else { + N_a = N_a_min; + } + + //printf("N_a, da = %d %g\n", N_a, (1.0 - a_min) / (N_a - 1)); //, N_a_min); + + linearGrowth = NULL; + growth_delta0 = -1; + transferFct = NULL; + transfer_alpha_Gamma = -1; + transfer_s = -1; + transferBE = NULL; + cmp_sigma8 = -1; + P_NL = NULL; + slope = NULL; + w = NULL; + //k_NL = NULL; + ystar_allz = NULL; + + //dump_param(res, stdout); + + set_norm(this, err); + // MKDEBUG NEW + consistency_parameters(this, err); +} + diff --git a/python/cosmo.hpp b/python/cosmo.hpp new file mode 100644 index 0000000..c8b79dc --- /dev/null +++ b/python/cosmo.hpp @@ -0,0 +1,145 @@ +/* + * + * Copyright (C) 2015 Francois + * + * This program is free software: you can redistribute it and/or modify + * it under the terms of the GNU General Public License as published by + * the Free Software Foundation, either version 3 of the License, or + * (at your option) any later version. + * + * This program is distributed in the hope that it will be useful, + * but WITHOUT ANY WARRANTY; without even the implied warranty of + * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + * GNU General Public License for more details. + * + * You should have received a copy of the GNU General Public License + * along with this program. If not, see . + * + */ + +#ifndef COSMO_HPP +#define COSMO_HPP + +#include "cosmo.h" + +using namespace nicaea; + +class cosmology: public cosmo +{ + void init( double OMEGAM, double OMEGADE, double W0_DE, double W1_DE, + double *W_POLY_DE, int N_POLY_DE, + double H100, double OMEGAB, double OMEGANUMASS, + double NEFFNUMASS, double NORM, double NSPEC, + nonlinear_t NONLINEAR, transfer_t TRANSFER, growth_t GROWTH, + de_param_t DEPARAM, norm_t normmode, double AMIN); +public: + + /* Parameters are: + Om Od w0 w1 h Ob Onu Neffnu s8 ns + nonlin transfer growth deparam norm amin */ + cosmology():myerr(NULL) { + init(0.25, 0.75, -1.0, 0.0, NULL, 0, 0.70, 0.044, 0.0, 0.0, 0.80, 0.96, + smith03, eisenhu, growth_de, linder, norm_s8, 0.0); + } + + ~cosmology() { + if (de_param == poly_DE) { + free(w_poly_de); + } + del_interTable(&linearGrowth); + del_interTable(&transferFct); + del_interTable(&transferBE); + del_interTable2D(&P_NL); + del_interTable(&slope); + del_interTable(&w); + delete *err; + } + + /* ============================================================ * + * Cosmology. * + * ============================================================ */ + + /* Homogeneous Universe */ + double da_dtau(double a) { + return ::da_dtau(this,a,err); + } + double w_de(double a) { + return ::w_de(this,a,err); + } + double f_de(double a) { + return ::f_de(this,a,err); + } + double Esqr(double a, int wOmegar) { + return ::Esqr(this,a, wOmegar,err); + } + double Omega_m_a(double a, double Esqrpre) { + return ::Omega_m_a(this,a,Esqrpre,err); + } + double Omega_de_a(double a, double Esqrpre) { + return ::Omega_de_a(this,a,Esqrpre,err); + } + double w_nu_mass(double a) { + return ::w_nu_mass(this,a); + } + + /* Geometry, distances */ + double w_a(double a, int wOmegar) { + return ::w(this,a,wOmegar,err); + } + double dwoverda(double a) { + return ::dwoverda(this,a,err); + } + double drdz(double a) { + return ::drdz(this,a,err); + } + double dvdz(double a) { + return ::dvdz(this,a,err); + } + double f_K(double wr) { + return ::f_K(this,wr,err); + } + double D_a(double a) { + return ::D_a(this,a,err); + } + double D_a12(double a1, double a2) { + return ::D_a12(this,a1,a2,err); + } + double D_lum(double a) { + return ::D_lum(this,a,err); + } + + +// +// /* Growth factor */ +// double D_plus(cosmo*, double a, int normalised, error **err); +// double g(cosmo*, double a); +// +// /* Transfer function */ +// double r_sound(cosmo *model); +// double r_sound_integral(cosmo *self, double a, error **err); +// double r_sound_drag_fit(cosmo *model, error **err); +// double r_sound_drag_analytical(cosmo *self, error **err); +// double k_silk(const cosmo *model); +// double ratio_b_gamma(cosmo *self, double a); +// double z_drag(cosmo *self); +// double T_tilde(const cosmo *self, double k, double alpha_c, double beta_c); +// double Tsqr_one(cosmo*,double k,double Gamma_eff,error **err); +// double Tsqr(cosmo*,double k,error **err);*/ + + + /* Linear power spectrum */ + double P_L(double a, double k){ + return ::P_L(this,a,k,err); + } + + /* Smith et al. non-linear power spectrum (halofit) */ + double P(double a, double k){ + return ::P_NL(this,a,k,err); + } + +private: + error** err; + error *myerr; +}; + +#endif // COSMO_HPP diff --git a/python/nicaea_builder.py b/python/nicaea_builder.py new file mode 100644 index 0000000..9a60fd1 --- /dev/null +++ b/python/nicaea_builder.py @@ -0,0 +1,15 @@ +import os +from pyplusplus import module_builder +from pyplusplus.module_builder import call_policies + +mb = module_builder.module_builder_t( [r"cosmo.hpp", "../cosmo/cosmo.h"] + , gccxml_path=r"" + , include_paths=['../cosmo', '../coyote', '../halomodel', '../tools', '../cosmo'] + , define_symbols=['_NOFFTW_'] ) +mb.decls().exclude() +mb.classes('cosmo').include() +mb.classes('cosmology').include() + +mb.build_code_creator(module_name='pynicaea') + +mb.write_module('./bindings.cpp') diff --git a/tools/include/config.h b/tools/include/config.h index 959c523..32f57e1 100644 --- a/tools/include/config.h +++ b/tools/include/config.h @@ -6,10 +6,6 @@ #ifndef __CONFIG_H #define __CONFIG_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -28,9 +24,6 @@ extern "C" { /* Maximal length of a short string config entry */ #define CSLENS 1024 -#ifdef __cplusplus -namespace nicaea { -#endif typedef enum {c_i, c_d, c_s} config_element_t; #define sconfig_element_t(i) ( \ @@ -116,8 +109,6 @@ config_element read_element(FILE *F, char *key, config_element c, "String \"%s\" expected but \"%s\" found instead in config file", *err, __LINE__,, str, stmp); -#ifdef __cplusplus -}} -#endif #endif + diff --git a/tools/include/errorlist.h b/tools/include/errorlist.h index 0f57556..25e0519 100644 --- a/tools/include/errorlist.h +++ b/tools/include/errorlist.h @@ -10,9 +10,6 @@ #ifndef __ERRORLIST_H #define __ERRORLIST_H -#ifdef __cplusplus -extern "C" { -#endif #include #include @@ -24,10 +21,6 @@ extern "C" { #define WHR_SZ 2048 #define TOT_SZ TXT_SZ+WHR_SZ -#ifdef __cplusplus -namespace nicaea { -#endif - typedef struct _err { char errWhere[WHR_SZ]; char errText[TXT_SZ]; @@ -50,7 +43,7 @@ void stringError(char* str, error *err); void printError(FILE* flog,error* err); int getErrorValue(error* err); -void purgeError(error **err); +void purgeError(error **err); error* unpickleError(void* buf, int len); int pickleError(error* err, void** buf); @@ -69,9 +62,9 @@ void endError(error **err); -#define _DEBUGHERE_(extra,...) fprintf(stderr,"%s:(" __FILE__":%d) "extra"\n",__func__,__LINE__,__VA_ARGS__); +#define _DEBUGHERE_(extra,...) fprintf(stderr,"%s:("__FILE__":%d) "extra"\n",__func__,__LINE__,__VA_ARGS__); -#define someErrorVA(errV,txt,prev,next,li,...) newErrorVA(errV,__func__,"(" __FILE__":"#li")",txt,prev,next,__VA_ARGS__) +#define someErrorVA(errV,txt,prev,next,li,...) newErrorVA(errV,__func__,"("__FILE__":"#li")",txt,prev,next,__VA_ARGS__) #define topErrorVA(errV,txt,next,li,...) someErrorVA(errV,txt,NULL,next,li,__VA_ARGS__) #define oneErrorVA(errV,txt,li,...) someErrorVA(errV,txt,NULL,NULL,li,__VA_ARGS__) #define addErrorVA(errV,txt,prev,li,...) someErrorVA(errV,txt,prev,NULL,li,__VA_ARGS__) @@ -109,7 +102,7 @@ void endError(error **err); isErrorReturn(err,ret) \ } -// tests +// tests #define testErrorVA(test,error_type,message,err,line,...) { \ if (test) { \ err=addErrorVA(error_type,message,err,line,__VA_ARGS__); \ @@ -154,10 +147,4 @@ void endError(error **err); error* initError(void); void endError(error **err); int _isError(error *err); - -#ifdef __cplusplus -}} -#endif - - #endif diff --git a/tools/include/io.h b/tools/include/io.h index 89d0c43..09ae029 100644 --- a/tools/include/io.h +++ b/tools/include/io.h @@ -6,10 +6,6 @@ #ifndef __IO_H #define __IO_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -33,9 +29,7 @@ extern "C" { #define io_inconsistent -5 + io_base #define io_directory -6 + io_base -#ifdef __cplusplus -namespace nicaea { -#endif + unsigned int numberoflines(const char *, error **err); unsigned int numberoflines_comments(const char *name, unsigned int *ncomment, error **err); @@ -80,8 +74,4 @@ time_t start_time(FILE *FOUT); void end_time(time_t t_start, FILE *FOUT); void end_clock(clock_t c_start, FILE *FOUT); -#ifdef __cplusplus -}} -#endif - #endif diff --git a/tools/include/maths.h b/tools/include/maths.h index d09268f..9ec6862 100644 --- a/tools/include/maths.h +++ b/tools/include/maths.h @@ -6,10 +6,12 @@ #ifndef __MATHS_H #define __MATHS_H + #ifdef __cplusplus extern "C" { #endif + #ifndef _NOFFTW_ #include #endif @@ -24,19 +26,21 @@ extern "C" { #include "io.h" #endif -#define NR_END 1 -#define FREE_ARG char* #ifdef __cplusplus namespace nicaea { #endif + +#define NR_END 1 +#define FREE_ARG char* + /* See cosmo.h */ typedef enum {comp_c=0, comp_b=1, comp_nu=2} comp_t; #define NCOMP 3 /* The following scales are Used for Hankel transforms */ -#define theta_min 3.0e-7 +#define theta_min 3.0e-7 #define theta_max 0.12 #define l_min 0.0001 @@ -158,7 +162,7 @@ double sm2_qromberg(funcwithpars, double *intpar, double a, double b, double EPS, error **err); double sm2_qrombergo(funcwithpars func, void *intpar, double a, double b, - double (*choose)(double(*)(double,void *,error**), void *, double, double, + double (*choose)(double(*)(double,void *,error**), void *, double, double, int, double *,error**), double EPS,error **err); double sm2_midpntberg(funcwithpars func, void *intpar, double a, double b, int n, double *s,error **err); @@ -201,7 +205,7 @@ interTable2D* init_interTable2D(int n1, double a1, double b1, double dx1, int n2 interTable2D* copy_interTable2D(interTable2D* self, error **err); void del_interTable2D(interTable2D** self); -interTable2D** init_interTable2D_arr(int N, int n1, double a1, double b1, double dx1, int n2, double a2, double b2, +interTable2D** init_interTable2D_arr(int N, int n1, double a1, double b1, double dx1, int n2, double a2, double b2, double dx2, double lower, double upper, error **err); interTable2D** copy_interTable2D_arr(interTable2D **self, int N, error **err); void del_interTable2D_arr(interTable2D*** self, int N); @@ -242,4 +246,5 @@ void hankel_kernel_tophat(double k, fftw_complex *res, error **err); }} #endif + #endif diff --git a/tools/include/maths_base.h b/tools/include/maths_base.h index 2d4fa15..fd0a363 100644 --- a/tools/include/maths_base.h +++ b/tools/include/maths_base.h @@ -10,10 +10,6 @@ #ifndef __MATHS_BASE_H #define __MATHS_BASE_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -47,10 +43,6 @@ extern "C" { #define math_overflow -12 + math_base #define math_unknown -13 + math_base -#ifdef __cplusplus -namespace nicaea { -#endif - typedef double my_complex[2]; @@ -80,8 +72,6 @@ typedef double my_complex[2]; /* Scalar product (x,y) */ #define SP(x,y) ((x)[0]*(y)[0]+(x)[1]*(y)[1]) -#ifdef __cplusplus -}} -#endif #endif + diff --git a/tools/include/mvdens.h b/tools/include/mvdens.h index a2ada83..98a51b9 100644 --- a/tools/include/mvdens.h +++ b/tools/include/mvdens.h @@ -23,10 +23,6 @@ #endif -#ifdef __cplusplus -extern "C" { -#endif - #include #include #include @@ -51,9 +47,6 @@ extern "C" { #endif #endif -#ifdef __cplusplus -namespace nicaea { -#endif #define __MVDENS_PARANOID_DEBUG__ @@ -180,8 +173,5 @@ mvdens* mvdens_hdfdwnp(char *fname,error **err); mix_mvdens* mix_mvdens_hdfdwnp(char *fname,error **err); #endif -#ifdef __cplusplus -}} #endif -#endif diff --git a/tools/include/par.h b/tools/include/par.h index 7599841..0c46f9b 100644 --- a/tools/include/par.h +++ b/tools/include/par.h @@ -1,20 +1,12 @@ #ifndef __PAR_H #define __PAR_H -#ifdef __cplusplus -extern "C" { -#endif - #include #include "errorlist.h" #include "io.h" #include "config.h" -#ifdef __cplusplus -namespace nicaea { -#endif - /* Parameters */ typedef enum { p_Omegam, p_Omegab, p_Omegade, p_h100, p_Omeganumass, @@ -153,8 +145,4 @@ par_t *copy_par_t(const par_t *par, int npar, error **err); void spar_to_par(par_t **par, int npar, const char *spar[], error **err); -#ifdef __cplusplus -}} -#endif - #endif diff --git a/tools/src/maths.c b/tools/src/maths.c index e1d5e8d..360da51 100644 --- a/tools/src/maths.c +++ b/tools/src/maths.c @@ -1915,32 +1915,32 @@ void tpstat_via_hankel(void* self, double **xi, double *logthetamin, double *log switch (tpstat) { case tp_xipm : case tp_w : - q = 0.0; - mu = 0.0; - norm = 2.0*pi; - break; + q = 0.0; + mu = 0.0; + norm = 2.0*pi; + break; case tp_gt : q = 0.0; mu = 2.0; norm = 2.0*pi; break; case tp_gsqr : - q = -2.0; - mu = 1.0; - norm = 2.0*pi/4.0; - break; + q = -2.0; + mu = 1.0; + norm = 2.0*pi/4.0; + break; case tp_map2_poly : - q = -4.0; - mu = 4.0; - norm = 2.0*pi/24.0/24.0; - break; + q = -4.0; + mu = 4.0; + norm = 2.0*pi/24.0/24.0; + break; case tp_map2_gauss : - q = mu = 0.0; /* unused */ - norm = 4.0*2.0*pi; - break; + q = mu = 0.0; /* unused */ + norm = 4.0*2.0*pi; + break; case tp_xir : - q = mu = 0.0; /* unused */ - norm = 2.0*pi*pi; + q = mu = 0.0; /* unused */ + norm = 2.0*pi*pi; break; default : *err = addErrorVA(math_unknown, "Unknown tpstat_t %d", *err, __LINE__, tpstat); @@ -1953,33 +1953,33 @@ void tpstat_via_hankel(void* self, double **xi, double *logthetamin, double *log /* Perform the convolution, negative sign for kernel (complex conj.!) */ for(i=0; i