-
Notifications
You must be signed in to change notification settings - Fork 12
/
Copy pathC_xi.c
385 lines (349 loc) · 12 KB
/
C_xi.c
1
2
3
4
5
6
7
8
9
10
11
12
13
14
15
16
17
18
19
20
21
22
23
24
25
26
27
28
29
30
31
32
33
34
35
36
37
38
39
40
41
42
43
44
45
46
47
48
49
50
51
52
53
54
55
56
57
58
59
60
61
62
63
64
65
66
67
68
69
70
71
72
73
74
75
76
77
78
79
80
81
82
83
84
85
86
87
88
89
90
91
92
93
94
95
96
97
98
99
100
101
102
103
104
105
106
107
108
109
110
111
112
113
114
115
116
117
118
119
120
121
122
123
124
125
126
127
128
129
130
131
132
133
134
135
136
137
138
139
140
141
142
143
144
145
146
147
148
149
150
151
152
153
154
155
156
157
158
159
160
161
162
163
164
165
166
167
168
169
170
171
172
173
174
175
176
177
178
179
180
181
182
183
184
185
186
187
188
189
190
191
192
193
194
195
196
197
198
199
200
201
202
203
204
205
206
207
208
209
210
211
212
213
214
215
216
217
218
219
220
221
222
223
224
225
226
227
228
229
230
231
232
233
234
235
236
237
238
239
240
241
242
243
244
245
246
247
248
249
250
251
252
253
254
255
256
257
258
259
260
261
262
263
264
265
266
267
268
269
270
271
272
273
274
275
276
277
278
279
280
281
282
283
284
285
286
287
288
289
290
291
292
293
294
295
296
297
298
299
300
301
302
303
304
305
306
307
308
309
310
311
312
313
314
315
316
317
318
319
320
321
322
323
324
325
326
327
328
329
330
331
332
333
334
335
336
337
338
339
340
341
342
343
344
345
346
347
348
349
350
351
352
353
354
355
356
357
358
359
360
361
362
363
364
365
366
367
368
369
370
371
372
373
374
375
376
377
378
379
380
381
382
383
384
385
#include "C_xi.h"
#include "C_peak_height.h"
#include "C_power.h"
#include "gsl/gsl_integration.h"
#include "gsl/gsl_spline.h"
#include "gsl/gsl_sf_gamma.h"
#include "gsl/gsl_errno.h"
#include <math.h>
#include <stdio.h>
#define rhomconst 2.77533742639e+11
//1e4*3.*Mpcperkm*Mpcperkm/(8.*PI*G); units are SM h^2/Mpc^3
/** @brief The NFW correlation function profile.
*
* The NFW correlation function profile of a halo a distance r from the center,
* assuming the halo has a given mass and concentration. It works
* with any overdensity parameter and arbitrary matter fraction.
* This function calls xi_nfw_at_r_arr().
*
* @param r Distance from the center of the halo in Mpc/h comoving.
* @param M Halo mass in Msun/h.
* @param c Concentration.
* @delta Halo overdensity.
* @Omega_m Matter fraction.
* @return NFW halo correlation function.
*/
double xi_nfw_at_r(double r, double Mass, double conc, int delta, double om){
double xi;
calc_xi_nfw(&r, 1, Mass, conc, delta, om, &xi);
return xi;
}
int calc_xi_nfw(double*r, int Nr, double Mass, double conc, int delta, double om, double*xi_nfw){
int i;
double rhom = om*rhomconst;//SM h^2/Mpc^3
//double rho0_rhom = delta/(3.*(log(1.+conc)-conc/(1.+conc)));
double rdelta = pow(Mass/(1.33333333333*M_PI*rhom*delta), 0.33333333333);
double rscale = rdelta/conc;
double fc = log(1.+conc)-conc/(1.+conc);
double r_rs;
for(i = 0; i < Nr; i++){
r_rs = r[i]/rscale;
//xi_nfw[i] = rho0_rhom/(r_rs*(1+r_rs)*(1+r_rs)) - 1.;
xi_nfw[i] = Mass/(4.*M_PI*rscale*rscale*rscale*fc)/(r_rs*(1+r_rs)*(1+r_rs))/rhom - 1.0;
}
return 0;
}
double rhos_einasto_at_M(double Mass, double conc, double alpha, int delta,
double Omega_m){
double rhom = Omega_m*rhomconst;//Msun h^2/Mpc^3
// rdelta in Mpc/h comoving
double rdelta = pow(Mass/(1.3333333333333*M_PI*rhom*delta), 0.333333333333);
double rs = rdelta/conc; //Scale radius in Mpc/h
double x = 2./alpha * pow(conc, alpha); //pow(rdelta/rs, alpha);
double a = 3./alpha;
double gam = gsl_sf_gamma(a) * gsl_sf_gamma_inc_P(a, x);
double num = delta * rhom * rdelta*rdelta*rdelta * alpha * pow(2./alpha, a);
double den = 3. * rs*rs*rs * gam;
return num/den;
}
int calc_xi_einasto(double*r, int Nr, double Mass, double rhos, double conc,
double alpha, int delta, double Omega_m, double*xi_einasto){
double rhom = Omega_m*rhomconst;//SM h^2/Mpc^3
double rdelta = pow(Mass/(1.3333333333333*M_PI*rhom*delta), 0.333333333333);
double rs = rdelta/conc; //Scale radius in Mpc/h
double x;
int i;
if (rhos < 0)
rhos = rhos_einasto_at_M(Mass, conc, alpha, delta, Omega_m);
for(i = 0; i < Nr; i++){
x = 2./alpha * pow(r[i]/rs, alpha);
xi_einasto[i] = rhos/rhom * exp(-x) - 1;
}
return 0;
}
int calc_xi_2halo(int Nr, double bias, double*xi_mm, double*xi_2halo){
int i;
for(i = 0; i < Nr; i++){
xi_2halo[i] = bias * xi_mm[i];
}
return 0;
}
int calc_xi_hm(int Nr, double*xi_1h, double*xi_2h, double*xi_hm, int flag){
//Flag specifies how to combine the two terms
int i;
if (flag == 0) { //Take the max
for(i = 0; i < Nr; i++){
if(xi_1h[i] >= xi_2h[i]) xi_hm[i] = xi_1h[i];
else xi_hm[i] = xi_2h[i];
}
} else if (flag == 1) { //Take the sum
for(i = 0; i < Nr; i++){
xi_hm[i] = 1 + xi_1h[i] + xi_2h[i];
}
}
return 0;
}
int calc_xi_mm(double*r, int Nr, double*k, double*P, int Nk, double*xi, int N, double h){
int i,j;
double PI_h = M_PI/h;
double PI_2 = M_PI*0.5;
double sum;
static int init_flag = 0;
static gsl_spline*Pspl = NULL;
static gsl_interp_accel*acc = NULL;
static double h_old = -1;
static int N_old = -1;
static double*x = NULL;
static double*xsinx = NULL;
static double*dpsi = NULL;
static double*xsdpsi = NULL;
double t, psi, PIsinht;
//Create the spline and accelerator
if (init_flag == 0){
Pspl = gsl_spline_alloc(gsl_interp_cspline, Nk);
acc = gsl_interp_accel_alloc();
}
gsl_spline_init(Pspl, k, P, Nk);
//Compute things
if ((init_flag == 0) || (h_old != h) || (N_old < N)){
h_old = h;
N_old = N;
init_flag = 1; //been initiated
if (x!=NULL) free(x);
if (xsinx!=NULL) free(xsinx);
if (dpsi!=NULL) free(dpsi);
if (xsdpsi!=NULL) free(xsdpsi);
x = malloc(N*sizeof(double));
xsinx = malloc(N*sizeof(double));
dpsi = malloc(N*sizeof(double));
xsdpsi = malloc(N*sizeof(double));
for(i = 0; i < N; i++){
t = h*(i+1);
psi = t*tanh(sinh(t)*PI_2);
x[i] = psi*PI_h;
xsinx[i] = x[i]*sin(x[i]);
PIsinht = M_PI*sinh(t);
dpsi[i] = (M_PI*t*cosh(t) + sinh(PIsinht))/(1+cosh(PIsinht));
if (dpsi[i]!=dpsi[i]) dpsi[i]=1.0;
xsdpsi[i] = xsinx[i]*dpsi[i];
}
}
//Compute the transform
for(j = 0; j < Nr; j++){
sum = 0;
for(i = 0; i < N; i++){
sum += xsdpsi[i] * get_P(x[i], r[j], k, P, Nk, Pspl, acc);
}
xi[j] = sum/(r[j]*r[j]*r[j]*M_PI*2);
}
return 0; //Note: factor of pi picked up in the quadrature rule
//See Ogata 2005 for details, especially eq. 5.2
}
///////Functions for calc_xi_mm/////////
//////////////////////////////////////////
//////////////Xi(r) exact below //////////
//////////////////////////////////////////
#define workspace_size 10000
#define workspace_num 500
#define ABSERR 0.0
#define RELERR 1e-3
//#define RELERR 1.8e-4
typedef struct integrand_params_xi_mm_exact{
gsl_spline*spline;
gsl_interp_accel*acc;
double r; //3d r; Mpc/h, or inverse units of k
double*kp; //pointer to wavenumbers
double*Pp; //pointer to P(k) array
int Nk; //length of k and P arrays
}integrand_params_xi_mm_exact;
double integrand_xi_mm_exact(double k, void*params){
integrand_params_xi_mm_exact pars = *(integrand_params_xi_mm_exact*)params;
gsl_spline*spline = pars.spline;
gsl_interp_accel*acc = pars.acc;
double*kp = pars.kp;
double*Pp = pars.Pp;
int Nk = pars.Nk;
double r = pars.r;
double x = k*r;
double P = get_P(x, r, kp, Pp, Nk, spline, acc);
return P*k/r; //Note - sin(kr) is taken care of in the qawo table
}
int calc_xi_mm_exact(double*r, int Nr, double*k, double*P, int Nk, double*xi){
gsl_function F;
double kmax = 4e3;
double kmin = 5e-8;
double result, err;
int i;
int status;
gsl_spline*Pspl = gsl_spline_alloc(gsl_interp_cspline, Nk);
gsl_interp_accel*acc= gsl_interp_accel_alloc();
gsl_spline_init(Pspl, k, P, Nk);
gsl_integration_workspace*workspace = gsl_integration_workspace_alloc(workspace_size);
gsl_integration_qawo_table*wf;
integrand_params_xi_mm_exact params;
params.acc = acc;
params.spline = Pspl;
params.kp = k;
params.Pp = P;
params.Nk = Nk;
F.function = &integrand_xi_mm_exact;
F.params = ¶ms;
wf = gsl_integration_qawo_table_alloc(r[0], kmax-kmin, GSL_INTEG_SINE, (size_t)workspace_num);
for(i = 0; i < Nr; i++){
status = gsl_integration_qawo_table_set(wf, r[i], kmax-kmin, GSL_INTEG_SINE);
if (status){
printf("Error in calc_xi_mm_exact, first integral.\n");
exit(-1);
}
params.r=r[i];
status = gsl_integration_qawo(&F, kmin, ABSERR, RELERR, (size_t)workspace_num,
workspace, wf, &result, &err);
if (status){
printf("Error in calc_xi_mm_exact, second integral.\n");
exit(-1);
}
xi[i] = result/(M_PI*M_PI*2);
}
gsl_spline_free(Pspl);
gsl_interp_accel_free(acc);
gsl_integration_workspace_free(workspace);
gsl_integration_qawo_table_free(wf);
return 0;
}
double xi_mm_at_r_exact(double r, double*k, double*P, int Nk){
double xi;
calc_xi_mm_exact(&r, 1, k, P, Nk, &xi);
return xi;
}
/*
* Diemer-Kravtsov 2014 profiles below.
*/
int calc_xi_DK(double*r, int Nr, double M, double rhos, double conc, double be, double se, double alpha, double beta, double gamma, int delta, double*k, double*P, int Nk, double om, double*xi){
double rhom = rhomconst*om; //SM h^2/Mpc^3
//Compute rDeltam
double rdelta = pow(M/(1.33333333333*M_PI*rhom*delta), 0.33333333333);
xi[0] = 0;
double*rho_ein = malloc(Nr*sizeof(double));
double*f_trans = malloc(Nr*sizeof(double));
double*rho_outer = malloc(Nr*sizeof(double));
int i;
double nu = nu_at_M(M, k, P, Nk, om);
if (alpha < 0){ //means it wasn't passed in
alpha = 0.155 + 0.0095*nu*nu;
}
if (beta < 0){ //means it wasn't passed in
beta = 4;
}
if (gamma < 0){ //means it wasn't passed in
gamma = 8;
}
if (rhos < 0){ //means it wasn't passed in
rhos = rhos_einasto_at_M(M, conc, alpha, delta, om);
}
double g_b = gamma/beta;
double r_t = (1.9-0.18*nu)*rdelta;
calc_xi_einasto(r, Nr, M, rhos, conc, alpha, delta, om, rho_ein);
//here convert xi_ein to rho_ein
for(i = 0; i < Nr; i++){
rho_ein[i] = rhom*(1+rho_ein[i]); //rho_ein had xi_ein in it
f_trans[i] = pow(1+pow(r[i]/r_t,beta), -g_b);
rho_outer[i] = rhom*(be*pow(r[i]/(5*rdelta), -se) + 1);
xi[i] = (rho_ein[i]*f_trans[i] + rho_outer[i])/rhom - 1;
}
free(rho_ein);
free(f_trans);
free(rho_outer);
return 0;
}
//////////////////////////////
//////Appendix version 1//////
//////////////////////////////
int calc_xi_DK_app1(double*r, int Nr, double M, double rhos, double conc, double be, double se, double alpha, double beta, double gamma, int delta, double*k, double*P, int Nk, double om, double bias, double*xi_mm, double*xi){
double rhom = rhomconst*om; //SM h^2/Mpc^3
//Compute r200m
double rdelta = pow(M/(1.33333333333*M_PI*rhom*delta), 0.33333333333);
//double rs = rdelta / conc; //compute scale radius from concentration
xi[0] = 0;
double*rho_ein = malloc(Nr*sizeof(double));
double*f_trans = malloc(Nr*sizeof(double));
double*rho_outer = malloc(Nr*sizeof(double));
int i;
double nu = nu_at_M(M, k, P, Nk, om);
if (alpha < 0){ //means it wasn't passed in
alpha = 0.155 + 0.0095*nu*nu;
}
if (beta < 0){ //means it wasn't passed in
beta = 4;
}
if (gamma < 0){ //means it wasn't passed in
gamma = 8;
}
if (rhos < 0){ //means it wasn't passed in
rhos = rhos_einasto_at_M(M, conc, alpha, delta, om);
}
double g_b = gamma/beta;
double r_t = (1.9-0.18*nu)*rdelta; //NEED nu for this
calc_xi_einasto(r, Nr, M, rhos, conc, alpha, delta, om, rho_ein);
//here convert xi_ein to rho_ein
for(i = 0; i < Nr; i++){
rho_ein[i] = rhom*(1+rho_ein[i]); //rho_ein had xi_ein in it
f_trans[i] = pow(1+pow(r[i]/r_t,beta), -g_b);
rho_outer[i] = rhom*(be*pow(r[i]/(5*rdelta), -se) * bias * xi_mm[i] + 1);
xi[i] = (rho_ein[i]*f_trans[i] + rho_outer[i])/rhom - 1;
}
free(rho_ein);
free(f_trans);
free(rho_outer);
return 0;
}
//////////////////////////////
//////Appendix version 2//////
//////////////////////////////
int calc_xi_DK_app2(double*r, int Nr, double M, double rhos, double conc, double be, double se, double alpha, double beta, double gamma, int delta, double*k, double*P, int Nk, double om, double bias, double*xi_mm, double*xi){
double rhom = rhomconst*om; //SM h^2/Mpc^3
//Compute r200m
double rdelta = pow(M/(1.33333333333*M_PI*rhom*delta), 0.33333333333);
//double rs = rdelta / conc; //compute scale radius from concentration
xi[0] = 0;
double*rho_ein = malloc(Nr*sizeof(double));
double*f_trans = malloc(Nr*sizeof(double));
double*rho_outer = malloc(Nr*sizeof(double));
int i;
double nu = nu_at_M(M, k, P, Nk, om);
if (alpha < 0){ //means it wasn't passed in
alpha = 0.155 + 0.0095*nu*nu;
}
if (beta < 0){ //means it wasn't passed in
beta = 4;
}
if (gamma < 0){ //means it wasn't passed in
gamma = 8;
}
if (rhos < 0){ //means it wasn't passed in
rhos = rhos_einasto_at_M(M, conc, alpha, delta, om);
}
double g_b = gamma/beta;
double r_t = (1.9-0.18*nu)*rdelta; //NEED nu for this
calc_xi_einasto(r, Nr, M, rhos, conc, alpha, delta, om, rho_ein);
//here convert xi_ein to rho_ein
for(i = 0; i < Nr; i++){
rho_ein[i] = rhom*(1+rho_ein[i]); //rho_ein had xi_ein in it
f_trans[i] = pow(1+pow(r[i]/r_t,beta), -g_b);
rho_outer[i] = rhom*((1+be*pow(r[i]/(5*rdelta), -se))*bias*xi_mm[i] + 1);
xi[i] = (rho_ein[i]*f_trans[i] + rho_outer[i])/rhom - 1;
}
free(rho_ein);
free(f_trans);
free(rho_outer);
return 0;
}