LALSimulation  5.4.0.1-fe68b98
LALSimIMRPhenomD_internals.c File Reference

Internal function for IMRPhenomD phenomenological waveform model. See LALSimIMRPhenom.c for more details. More...

Prototypes

static double chiPN (double Seta, double eta, double chi1, double chi2)
 PN reduced spin parameter See Eq 5.9 in http://arxiv.org/pdf/1107.1267v2.pdf. More...
 
static size_t NextPow2 (const size_t n)
 Return the closest higher power of 2. More...
 
static bool StepFunc_boolean (const double t, const double t1)
 ‍** More...
 
static double FinalSpin0815_s (double eta, double s)
 Formula to predict the final spin. More...
 
static double FinalSpin0815 (double eta, double chi1, double chi2)
 Wrapper function for FinalSpin0815_s. More...
 
static double fring (double eta, double chi1, double chi2, double finspin)
 fring is the real part of the ringdown frequency 1508.07250 figure 9 More...
 
static double fdamp (double eta, double chi1, double chi2, double finspin)
 fdamp is the complex part of the ringdown frequency 1508.07250 figure 9 More...
 
static int init_useful_powers (UsefulPowers *p, REAL8 number)
 
static double amp0Func (double eta)
 amplitude scaling factor defined by eq. More...
 
static double rho1_fun (double eta, double eta2, double xi)
 rho_1 phenom coefficient. More...
 
static double rho2_fun (double eta, double eta2, double xi)
 rho_2 phenom coefficient. More...
 
static double rho3_fun (double eta, double eta2, double xi)
 rho_3 phenom coefficient. More...
 
static double AmpInsAnsatz (double Mf, UsefulPowers *powers_of_Mf, AmpInsPrefactors *prefactors)
 Inspiral amplitude plus rho phenom coefficents. More...
 
static int init_amp_ins_prefactors (AmpInsPrefactors *prefactors, IMRPhenomDAmplitudeCoefficients *p)
 
static double DAmpInsAnsatz (double Mf, UsefulPowers *powers_of_Mf, IMRPhenomDAmplitudeCoefficients *p)
 Take the AmpInsAnsatz expression and compute the first derivative with respect to frequency to get the expression below. More...
 
static double gamma1_fun (double eta, double eta2, double xi)
 gamma 1 phenom coefficient. More...
 
static double gamma2_fun (double eta, double eta2, double xi)
 gamma 2 phenom coefficient. More...
 
static double gamma3_fun (double eta, double eta2, double xi)
 gamma 3 phenom coefficient. More...
 
static double AmpMRDAnsatz (double f, IMRPhenomDAmplitudeCoefficients *p)
 Ansatz for the merger-ringdown amplitude. More...
 
static double DAmpMRDAnsatz (double f, IMRPhenomDAmplitudeCoefficients *p)
 first frequency derivative of AmpMRDAnsatz More...
 
static double fmaxCalc (IMRPhenomDAmplitudeCoefficients *p)
 Equation 20 arXiv:1508.07253 (called f_peak in paper) analytic location of maximum of AmpMRDAnsatz. More...
 
static double AmpIntAnsatz (double Mf, IMRPhenomDAmplitudeCoefficients *p)
 Ansatz for the intermediate amplitude. More...
 
static double AmpIntColFitCoeff (double eta, double eta2, double chi)
 The function name stands for 'Amplitude Intermediate Collocation Fit Coefficient' This is the 'v2' value in Table 5 of arXiv:1508.07253. More...
 
static double delta0_fun (IMRPhenomDAmplitudeCoefficients *p, DeltaUtility *d)
 The following functions (delta{0,1,2,3,4}_fun) were derived in mathematica according to the constraints detailed in arXiv:1508.07253, section 'Region IIa - intermediate'. More...
 
static double delta1_fun (IMRPhenomDAmplitudeCoefficients *p, DeltaUtility *d)
 
static double delta2_fun (IMRPhenomDAmplitudeCoefficients *p, DeltaUtility *d)
 
static double delta3_fun (IMRPhenomDAmplitudeCoefficients *p, DeltaUtility *d)
 
static double delta4_fun (IMRPhenomDAmplitudeCoefficients *p, DeltaUtility *d)
 
static void ComputeDeltasFromCollocation (IMRPhenomDAmplitudeCoefficients *p)
 Calculates delta_i's Method described in arXiv:1508.07253 section 'Region IIa - intermediate'. More...
 
static void ComputeIMRPhenomDAmplitudeCoefficients (IMRPhenomDAmplitudeCoefficients *p, double eta, double chi1, double chi2, double finspin)
 A struct containing all the parameters that need to be calculated to compute the phenomenological amplitude. More...
 
static double IMRPhenDAmplitude (double f, IMRPhenomDAmplitudeCoefficients *p, UsefulPowers *powers_of_f, AmpInsPrefactors *prefactors)
 This function computes the IMR amplitude given phenom coefficients. More...
 
static double alpha1Fit (double eta, double eta2, double xi)
 alpha 1 phenom coefficient. More...
 
static double alpha2Fit (double eta, double eta2, double xi)
 alpha 2 phenom coefficient. More...
 
static double alpha3Fit (double eta, double eta2, double xi)
 alpha 3 phenom coefficient. More...
 
static double alpha4Fit (double eta, double eta2, double xi)
 alpha 4 phenom coefficient. More...
 
static double alpha5Fit (double eta, double eta2, double xi)
 alpha 5 phenom coefficient. More...
 
static double PhiMRDAnsatzInt (double f, IMRPhenomDPhaseCoefficients *p, double Rholm, double Taulm)
 Ansatz for the merger-ringdown phase Equation 14 arXiv:1508.07253 Rholm was added when IMRPhenomHM (high mode) was added. More...
 
static double DPhiMRD (double f, IMRPhenomDPhaseCoefficients *p, double Rholm, double Taulm)
 First frequency derivative of PhiMRDAnsatzInt Rholm was added when IMRPhenomHM (high mode) was added. More...
 
static double beta1Fit (double eta, double eta2, double xi)
 beta 1 phenom coefficient. More...
 
static double beta2Fit (double eta, double eta2, double xi)
 beta 2 phenom coefficient. More...
 
static double beta3Fit (double eta, double eta2, double xi)
 beta 3 phenom coefficient. More...
 
static double PhiIntAnsatz (double Mf, IMRPhenomDPhaseCoefficients *p)
 ansatz for the intermediate phase defined by Equation 16 arXiv:1508.07253 More...
 
static double DPhiIntAnsatz (double Mf, IMRPhenomDPhaseCoefficients *p)
 First frequency derivative of PhiIntAnsatz (this time with 1. More...
 
static double DPhiIntTemp (double ff, IMRPhenomDPhaseCoefficients *p)
 temporary instance of DPhiIntAnsatz used when computing coefficients to make the phase C(1) continuous between regions. More...
 
static double sigma1Fit (double eta, double eta2, double xi)
 sigma 1 phenom coefficient. More...
 
static double sigma2Fit (double eta, double eta2, double xi)
 sigma 2 phenom coefficient. More...
 
static double sigma3Fit (double eta, double eta2, double xi)
 sigma 3 phenom coefficient. More...
 
static double sigma4Fit (double eta, double eta2, double xi)
 sigma 4 phenom coefficient. More...
 
static double PhiInsAnsatzInt (double Mf, UsefulPowers *powers_of_Mf, PhiInsPrefactors *prefactors, IMRPhenomDPhaseCoefficients *p, PNPhasingSeries *pn)
 Ansatz for the inspiral phase. More...
 
static int init_phi_ins_prefactors (PhiInsPrefactors *prefactors, IMRPhenomDPhaseCoefficients *p, PNPhasingSeries *pn)
 
static double DPhiInsAnsatzInt (double Mf, IMRPhenomDPhaseCoefficients *p, PNPhasingSeries *pn)
 First frequency derivative of PhiInsAnsatzInt. More...
 
static void ComputeIMRPhenomDPhaseCoefficients (IMRPhenomDPhaseCoefficients *p, double eta, double chi1, double chi2, double finspin, LALDict *extraParams)
 A struct containing all the parameters that need to be calculated to compute the phenomenological phase. More...
 
static void ComputeIMRPhenDPhaseConnectionCoefficients (IMRPhenomDPhaseCoefficients *p, PNPhasingSeries *pn, PhiInsPrefactors *prefactors, double Rholm, double Taulm)
 This function aligns the three phase parts (inspiral, intermediate and merger-rindown) such that they are c^1 continuous at the transition frequencies Defined in VIII. More...
 
static double IMRPhenDPhase (double f, IMRPhenomDPhaseCoefficients *p, PNPhasingSeries *pn, UsefulPowers *powers_of_f, PhiInsPrefactors *prefactors, double Rholm, double Taulm)
 This function computes the IMR phase given phenom coefficients. More...
 
static double Subtract3PNSS (double m1, double m2, double M, double eta, double chi1, double chi2)
 Subtract 3PN spin-spin term below as this is in LAL's TaylorF2 implementation (LALSimInspiralPNCoefficients.c -> XLALSimInspiralPNPhasing_F2), but was not available when PhenomD was tuned. More...
 

Detailed Description

Internal function for IMRPhenomD phenomenological waveform model. See LALSimIMRPhenom.c for more details.

Author
Michael Puerrer, Sebastian Khan, Frank Ohme, Ofek Birnholtz, Lionel London, Francesco Pannarale

Note that the functions defined here in LALSimIMRPhenomD_internals.c / .h must be used by BOTH LALSimIMRPhenomD.c AND LALSimIMRPhenomP.c.

Definition in file LALSimIMRPhenomD_internals.c.

Go to the source code of this file.

Function Documentation

◆ chiPN()

static double chiPN ( double  Seta,
double  eta,
double  chi1,
double  chi2 
)
static

PN reduced spin parameter See Eq 5.9 in http://arxiv.org/pdf/1107.1267v2.pdf.

Definition at line 97 of file LALSimIMRPhenomD_internals.c.

◆ NextPow2()

static size_t NextPow2 ( const size_t  n)
static

Return the closest higher power of 2.

Definition at line 111 of file LALSimIMRPhenomD_internals.c.

◆ StepFunc_boolean()

static bool StepFunc_boolean ( const double  t,
const double  t1 
)
static

‍**

Step function in boolean version

Definition at line 130 of file LALSimIMRPhenomD_internals.c.

◆ FinalSpin0815_s()

static double FinalSpin0815_s ( double  eta,
double  s 
)
static

Formula to predict the final spin.

Equation 3.6 arXiv:1508.07250 s defined around Equation 3.6.

Definition at line 142 of file LALSimIMRPhenomD_internals.c.

◆ FinalSpin0815()

static double FinalSpin0815 ( double  eta,
double  chi1,
double  chi2 
)
static

Wrapper function for FinalSpin0815_s.

Definition at line 161 of file LALSimIMRPhenomD_internals.c.

◆ fring()

static double fring ( double  eta,
double  chi1,
double  chi2,
double  finspin 
)
static

fring is the real part of the ringdown frequency 1508.07250 figure 9

Definition at line 177 of file LALSimIMRPhenomD_internals.c.

◆ fdamp()

static double fdamp ( double  eta,
double  chi1,
double  chi2,
double  finspin 
)
static

fdamp is the complex part of the ringdown frequency 1508.07250 figure 9

Definition at line 197 of file LALSimIMRPhenomD_internals.c.

◆ init_useful_powers()

static int init_useful_powers ( UsefulPowers p,
REAL8  number 
)
static

Definition at line 213 of file LALSimIMRPhenomD_internals.c.

◆ amp0Func()

static double amp0Func ( double  eta)
static

amplitude scaling factor defined by eq.

17 in 1508.07253

Definition at line 243 of file LALSimIMRPhenomD_internals.c.

◆ rho1_fun()

static double rho1_fun ( double  eta,
double  eta2,
double  xi 
)
static

rho_1 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 255 of file LALSimIMRPhenomD_internals.c.

◆ rho2_fun()

static double rho2_fun ( double  eta,
double  eta2,
double  xi 
)
static

rho_2 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 267 of file LALSimIMRPhenomD_internals.c.

◆ rho3_fun()

static double rho3_fun ( double  eta,
double  eta2,
double  xi 
)
static

rho_3 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 278 of file LALSimIMRPhenomD_internals.c.

◆ AmpInsAnsatz()

static double AmpInsAnsatz ( double  Mf,
UsefulPowers powers_of_Mf,
AmpInsPrefactors prefactors 
)
static

Inspiral amplitude plus rho phenom coefficents.

rho coefficients computed in rho1_fun, rho2_fun, rho3_fun functions. Amplitude is a re-expansion. See 1508.07253 and Equation 29, 30 and Appendix B arXiv:1508.07253 for details

Definition at line 293 of file LALSimIMRPhenomD_internals.c.

◆ init_amp_ins_prefactors()

static int init_amp_ins_prefactors ( AmpInsPrefactors prefactors,
IMRPhenomDAmplitudeCoefficients p 
)
static

Definition at line 302 of file LALSimIMRPhenomD_internals.c.

◆ DAmpInsAnsatz()

static double DAmpInsAnsatz ( double  Mf,
UsefulPowers powers_of_Mf,
IMRPhenomDAmplitudeCoefficients p 
)
static

Take the AmpInsAnsatz expression and compute the first derivative with respect to frequency to get the expression below.

Definition at line 358 of file LALSimIMRPhenomD_internals.c.

◆ gamma1_fun()

static double gamma1_fun ( double  eta,
double  eta2,
double  xi 
)
static

gamma 1 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 399 of file LALSimIMRPhenomD_internals.c.

◆ gamma2_fun()

static double gamma2_fun ( double  eta,
double  eta2,
double  xi 
)
static

gamma 2 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 410 of file LALSimIMRPhenomD_internals.c.

◆ gamma3_fun()

static double gamma3_fun ( double  eta,
double  eta2,
double  xi 
)
static

gamma 3 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 421 of file LALSimIMRPhenomD_internals.c.

◆ AmpMRDAnsatz()

static double AmpMRDAnsatz ( double  f,
IMRPhenomDAmplitudeCoefficients p 
)
static

Ansatz for the merger-ringdown amplitude.

Equation 19 arXiv:1508.07253

Definition at line 432 of file LALSimIMRPhenomD_internals.c.

◆ DAmpMRDAnsatz()

static double DAmpMRDAnsatz ( double  f,
IMRPhenomDAmplitudeCoefficients p 
)
static

first frequency derivative of AmpMRDAnsatz

Definition at line 447 of file LALSimIMRPhenomD_internals.c.

◆ fmaxCalc()

static double fmaxCalc ( IMRPhenomDAmplitudeCoefficients p)
static

Equation 20 arXiv:1508.07253 (called f_peak in paper) analytic location of maximum of AmpMRDAnsatz.

Definition at line 468 of file LALSimIMRPhenomD_internals.c.

◆ AmpIntAnsatz()

static double AmpIntAnsatz ( double  Mf,
IMRPhenomDAmplitudeCoefficients p 
)
static

Ansatz for the intermediate amplitude.

Equation 21 arXiv:1508.07253

Definition at line 491 of file LALSimIMRPhenomD_internals.c.

◆ AmpIntColFitCoeff()

static double AmpIntColFitCoeff ( double  eta,
double  eta2,
double  chi 
)
static

The function name stands for 'Amplitude Intermediate Collocation Fit Coefficient' This is the 'v2' value in Table 5 of arXiv:1508.07253.

Definition at line 500 of file LALSimIMRPhenomD_internals.c.

◆ delta0_fun()

static double delta0_fun ( IMRPhenomDAmplitudeCoefficients p,
DeltaUtility d 
)
static

The following functions (delta{0,1,2,3,4}_fun) were derived in mathematica according to the constraints detailed in arXiv:1508.07253, section 'Region IIa - intermediate'.

These are not given in the paper. Can be rederived by solving Equation 21 for the constraints given in Equations 22-26 in arXiv:1508.07253

Definition at line 518 of file LALSimIMRPhenomD_internals.c.

◆ delta1_fun()

static double delta1_fun ( IMRPhenomDAmplitudeCoefficients p,
DeltaUtility d 
)
static

Definition at line 551 of file LALSimIMRPhenomD_internals.c.

◆ delta2_fun()

static double delta2_fun ( IMRPhenomDAmplitudeCoefficients p,
DeltaUtility d 
)
static

Definition at line 584 of file LALSimIMRPhenomD_internals.c.

◆ delta3_fun()

static double delta3_fun ( IMRPhenomDAmplitudeCoefficients p,
DeltaUtility d 
)
static

Definition at line 616 of file LALSimIMRPhenomD_internals.c.

◆ delta4_fun()

static double delta4_fun ( IMRPhenomDAmplitudeCoefficients p,
DeltaUtility d 
)
static

Definition at line 646 of file LALSimIMRPhenomD_internals.c.

◆ ComputeDeltasFromCollocation()

static void ComputeDeltasFromCollocation ( IMRPhenomDAmplitudeCoefficients p)
static

Calculates delta_i's Method described in arXiv:1508.07253 section 'Region IIa - intermediate'.

Definition at line 675 of file LALSimIMRPhenomD_internals.c.

◆ ComputeIMRPhenomDAmplitudeCoefficients()

static void ComputeIMRPhenomDAmplitudeCoefficients ( IMRPhenomDAmplitudeCoefficients p,
double  eta,
double  chi1,
double  chi2,
double  finspin 
)
static

A struct containing all the parameters that need to be calculated to compute the phenomenological amplitude.

Definition at line 742 of file LALSimIMRPhenomD_internals.c.

◆ IMRPhenDAmplitude()

static double IMRPhenDAmplitude ( double  f,
IMRPhenomDAmplitudeCoefficients p,
UsefulPowers powers_of_f,
AmpInsPrefactors prefactors 
)
static

This function computes the IMR amplitude given phenom coefficients.

Defined in VIII. Full IMR Waveforms arXiv:1508.07253

Definition at line 785 of file LALSimIMRPhenomD_internals.c.

◆ alpha1Fit()

static double alpha1Fit ( double  eta,
double  eta2,
double  xi 
)
static

alpha 1 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 824 of file LALSimIMRPhenomD_internals.c.

◆ alpha2Fit()

static double alpha2Fit ( double  eta,
double  eta2,
double  xi 
)
static

alpha 2 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 835 of file LALSimIMRPhenomD_internals.c.

◆ alpha3Fit()

static double alpha3Fit ( double  eta,
double  eta2,
double  xi 
)
static

alpha 3 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 846 of file LALSimIMRPhenomD_internals.c.

◆ alpha4Fit()

static double alpha4Fit ( double  eta,
double  eta2,
double  xi 
)
static

alpha 4 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 857 of file LALSimIMRPhenomD_internals.c.

◆ alpha5Fit()

static double alpha5Fit ( double  eta,
double  eta2,
double  xi 
)
static

alpha 5 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 868 of file LALSimIMRPhenomD_internals.c.

◆ PhiMRDAnsatzInt()

static double PhiMRDAnsatzInt ( double  f,
IMRPhenomDPhaseCoefficients p,
double  Rholm,
double  Taulm 
)
static

Ansatz for the merger-ringdown phase Equation 14 arXiv:1508.07253 Rholm was added when IMRPhenomHM (high mode) was added.

Rholm = fRD22/fRDlm. For PhenomD (only (l,m)=(2,2)) this is just equal to 1. and PhenomD is recovered. Taulm = fDMlm/fDM22. Ratio of ringdown damping times. Again, when Taulm = 1.0 then PhenomD is recovered.

Definition at line 884 of file LALSimIMRPhenomD_internals.c.

◆ DPhiMRD()

static double DPhiMRD ( double  f,
IMRPhenomDPhaseCoefficients p,
double  Rholm,
double  Taulm 
)
static

First frequency derivative of PhiMRDAnsatzInt Rholm was added when IMRPhenomHM (high mode) was added.

Rholm = fRD22/fRDlm. For PhenomD (only (l,m)=(2,2)) this is just equal to 1. and PhenomD is recovered. Taulm = fDMlm/fDM22. Ratio of ringdown damping times. Again, when Taulm = 1.0 then PhenomD is recovered.

Definition at line 905 of file LALSimIMRPhenomD_internals.c.

◆ beta1Fit()

static double beta1Fit ( double  eta,
double  eta2,
double  xi 
)
static

beta 1 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 920 of file LALSimIMRPhenomD_internals.c.

◆ beta2Fit()

static double beta2Fit ( double  eta,
double  eta2,
double  xi 
)
static

beta 2 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 931 of file LALSimIMRPhenomD_internals.c.

◆ beta3Fit()

static double beta3Fit ( double  eta,
double  eta2,
double  xi 
)
static

beta 3 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 942 of file LALSimIMRPhenomD_internals.c.

◆ PhiIntAnsatz()

static double PhiIntAnsatz ( double  Mf,
IMRPhenomDPhaseCoefficients p 
)
static

ansatz for the intermediate phase defined by Equation 16 arXiv:1508.07253

Definition at line 954 of file LALSimIMRPhenomD_internals.c.

◆ DPhiIntAnsatz()

static double DPhiIntAnsatz ( double  Mf,
IMRPhenomDPhaseCoefficients p 
)
static

First frequency derivative of PhiIntAnsatz (this time with 1.

/eta explicitly factored in)

Definition at line 965 of file LALSimIMRPhenomD_internals.c.

◆ DPhiIntTemp()

static double DPhiIntTemp ( double  ff,
IMRPhenomDPhaseCoefficients p 
)
static

temporary instance of DPhiIntAnsatz used when computing coefficients to make the phase C(1) continuous between regions.

Definition at line 973 of file LALSimIMRPhenomD_internals.c.

◆ sigma1Fit()

static double sigma1Fit ( double  eta,
double  eta2,
double  xi 
)
static

sigma 1 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 991 of file LALSimIMRPhenomD_internals.c.

◆ sigma2Fit()

static double sigma2Fit ( double  eta,
double  eta2,
double  xi 
)
static

sigma 2 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 1002 of file LALSimIMRPhenomD_internals.c.

◆ sigma3Fit()

static double sigma3Fit ( double  eta,
double  eta2,
double  xi 
)
static

sigma 3 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 1013 of file LALSimIMRPhenomD_internals.c.

◆ sigma4Fit()

static double sigma4Fit ( double  eta,
double  eta2,
double  xi 
)
static

sigma 4 phenom coefficient.

See corresponding row in Table 5 arXiv:1508.07253

Definition at line 1024 of file LALSimIMRPhenomD_internals.c.

◆ PhiInsAnsatzInt()

static double PhiInsAnsatzInt ( double  Mf,
UsefulPowers powers_of_Mf,
PhiInsPrefactors prefactors,
IMRPhenomDPhaseCoefficients p,
PNPhasingSeries pn 
)
static

Ansatz for the inspiral phase.

We call the LAL TF2 coefficients here. The exact values of the coefficients used are given as comments in the top of this file Defined by Equation 27 and 28 arXiv:1508.07253

Definition at line 1039 of file LALSimIMRPhenomD_internals.c.

◆ init_phi_ins_prefactors()

static int init_phi_ins_prefactors ( PhiInsPrefactors prefactors,
IMRPhenomDPhaseCoefficients p,
PNPhasingSeries pn 
)
static

Definition at line 1068 of file LALSimIMRPhenomD_internals.c.

◆ DPhiInsAnsatzInt()

static double DPhiInsAnsatzInt ( double  Mf,
IMRPhenomDPhaseCoefficients p,
PNPhasingSeries pn 
)
static

First frequency derivative of PhiInsAnsatzInt.

Definition at line 1102 of file LALSimIMRPhenomD_internals.c.

◆ ComputeIMRPhenomDPhaseCoefficients()

static void ComputeIMRPhenomDPhaseCoefficients ( IMRPhenomDPhaseCoefficients p,
double  eta,
double  chi1,
double  chi2,
double  finspin,
LALDict *  extraParams 
)
static

A struct containing all the parameters that need to be calculated to compute the phenomenological phase.

Definition at line 1151 of file LALSimIMRPhenomD_internals.c.

◆ ComputeIMRPhenDPhaseConnectionCoefficients()

static void ComputeIMRPhenDPhaseConnectionCoefficients ( IMRPhenomDPhaseCoefficients p,
PNPhasingSeries pn,
PhiInsPrefactors prefactors,
double  Rholm,
double  Taulm 
)
static

This function aligns the three phase parts (inspiral, intermediate and merger-rindown) such that they are c^1 continuous at the transition frequencies Defined in VIII.

Full IMR Waveforms arXiv:1508.07253 Rholm was added when IMRPhenomHM (high mode) was added. Rholm = fRD22/fRDlm. For PhenomD (only (l,m)=(2,2)) this is just equal to 1. and PhenomD is recovered. Taulm = fDMlm/fDM22. Ratio of ringdown damping times. Again, when Taulm = 1.0 then PhenomD is recovered.

Definition at line 1209 of file LALSimIMRPhenomD_internals.c.

◆ IMRPhenDPhase()

static double IMRPhenDPhase ( double  f,
IMRPhenomDPhaseCoefficients p,
PNPhasingSeries pn,
UsefulPowers powers_of_f,
PhiInsPrefactors prefactors,
double  Rholm,
double  Taulm 
)
static

This function computes the IMR phase given phenom coefficients.

Defined in VIII. Full IMR Waveforms arXiv:1508.07253 Rholm was added when IMRPhenomHM (high mode) was added. Rholm = fRD22/fRDlm. For PhenomD (only (l,m)=(2,2)) this is just equal to 1. and PhenomD is recovered. Taulm = fDMlm/fDM22. Ratio of ringdown damping times. Again, when Taulm = 1.0 then PhenomD is recovered.

Definition at line 1257 of file LALSimIMRPhenomD_internals.c.

◆ Subtract3PNSS()

static double Subtract3PNSS ( double  m1,
double  m2,
double  M,
double  eta,
double  chi1,
double  chi2 
)
static

Subtract 3PN spin-spin term below as this is in LAL's TaylorF2 implementation (LALSimInspiralPNCoefficients.c -> XLALSimInspiralPNPhasing_F2), but was not available when PhenomD was tuned.

Definition at line 1285 of file LALSimIMRPhenomD_internals.c.