gambit is hosted by Hepforge, IPPP Durham
GAMBIT  v1.5.0-2191-ga4742ac
a Global And Modular Bsm Inference Tool
ScalarSingletDM.cpp
Go to the documentation of this file.
1 // GAMBIT: Global and Modular BSM Inference Tool
2 // *********************************************
23 
28 #include "boost/make_shared.hpp"
30 
31 namespace Gambit
32 {
33 
34  namespace DarkBit
35  {
36  //#define DARKBIT_DEBUG
37 
38  class ScalarSingletDM
39  {
40  public:
42  ScalarSingletDM(
43  TH_ProcessCatalog* const catalog,
44  double gammaH,
45  double vev,
46  double alpha_strong,
47  double vSigma_s)
48  : Gamma_mh(gammaH), v0 (vev),
49  alpha_s (alpha_strong), vSigma_semi (vSigma_s)
50  {
51  mh = catalog->getParticleProperty("h0_1").mass;
52  mb = catalog->getParticleProperty("d_3").mass;
53  mc = catalog->getParticleProperty("u_2").mass;
54  mtau = catalog->getParticleProperty("e-_3").mass;
55  mt = catalog->getParticleProperty("u_3").mass;
56  mZ0 = catalog->getParticleProperty("Z0").mass;
57  mW = catalog->getParticleProperty("W+").mass;
58  mS = catalog->getParticleProperty("S").mass;
59  };
60  ~ScalarSingletDM() {}
61 
63  double Dh2 (double s)
64  {
65  return 1/((s-mh*mh)*(s-mh*mh)+mh*mh*Gamma_mh*Gamma_mh);
66  }
67 
74  double sv(std::string channel, double lambda, double mass, double v)
75  {
76 
77  // Note: Valid for mass > 45 GeV
78  double s = 4*mass*mass/(1-v*v/4);
79  double sqrt_s = sqrt(s);
80  if ( sqrt_s < 90 )
81  {
83  "SingletDM sigmav called with sqrt_s < 90 GeV.");
84  return 0;
85  }
86 
87  if ( channel == "Sh" )
88  {
89  if (sqrt_s > (mh+mS)) return vSigma_semi;
90  else return 0;
91  }
92 
93  if ( channel == "hh" )
94  {
95  if ( sqrt_s > mh*2 )
96  {
97  double GeV2tocm3s1 = gev2cm2*s2cm;
98  return sv_hh(lambda, mass, v)*GeV2tocm3s1;
99  }
100  else return 0;
101  }
102 
103  if ( channel == "bb" and sqrt_s < mb*2 ) return 0;
104  if ( channel == "cc" and sqrt_s < mc*2 ) return 0;
105  if ( channel == "tautau" and sqrt_s < mtau*2 ) return 0;
106  if ( channel == "tt" and sqrt_s < mt*2 ) return 0;
107  if ( channel == "ZZ" and sqrt_s < mZ0*2) return 0;
108  if ( channel == "WW" and sqrt_s < mW*2) return 0;
109 
110  if ( sqrt_s < 300 )
111  {
112  double br = virtual_SMHiggs_widths(channel,sqrt_s);
113  double Gamma_s = virtual_SMHiggs_widths("Gamma",sqrt_s);
114  double GeV2tocm3s1 = gev2cm2*s2cm;
115 
116  // Explicitly close channel for off-shell top quarks
117  if ( channel == "tt" and sqrt_s < mt*2) return 0;
118 
119  double res = 2*lambda*lambda*v0*v0/
120  sqrt_s*Dh2(s)*Gamma_s*GeV2tocm3s1*br;
121  return res;
122  }
123  else
124  {
125  if ( channel == "bb" ) return sv_ff(lambda, mass, v, mb, true);
126  if ( channel == "cc" ) return sv_ff(lambda, mass, v, mc, true);
127  if ( channel == "tautau" ) return sv_ff(lambda, mass, v, mtau, false);
128  if ( channel == "tt" ) return sv_ff(lambda, mass, v, mt, true);
129  if ( channel == "ZZ" ) return sv_ZZ(lambda, mass, v);
130  if ( channel == "WW" ) return sv_WW(lambda, mass, v);
131  }
132  return 0;
133  }
134 
135  // Annihilation into W bosons.
136  double sv_WW(double lambda, double mass, double v)
137  {
138  double s = 4*mass*mass/(1-v*v/4);
139  double x = pow(mW,2)/s;
140  double GeV2tocm3s1 = gev2cm2*s2cm;
141  return pow(lambda,2)*s/8/M_PI*sqrt(1-4*x)*Dh2(s)*(1-4*x+12*pow(x,2))
142  *GeV2tocm3s1;
143  }
144 
145  // Annihilation into Z bosons.
146  double sv_ZZ(double lambda, double mass, double v)
147  {
148  double s = 4*mass*mass/(1-v*v/4);
149  double x = pow(mZ0,2)/s;
150  double GeV2tocm3s1 = gev2cm2*s2cm;
151  return pow(lambda,2)*s/16/M_PI*sqrt(1-4*x)*Dh2(s)*(1-4*x+12*pow(x,2))
152  * GeV2tocm3s1;
153  }
154 
155  // Annihilation into fermions
156  double sv_ff(
157  double lambda, double mass, double v, double mf, bool is_quark)
158  {
159  double s = 4*mass*mass/(1-v*v/4);
160  double vf = sqrt(1-4*pow(mf,2)/s);
161  double Xf = 1;
162  if ( is_quark ) Xf = 3 *
163  (1+(3/2*log(pow(mf,2)/s)+9/4)*4*alpha_s/3/M_PI);
164  double GeV2tocm3s1 = gev2cm2*s2cm;
165  return pow(lambda,2)*
166  pow(mf,2)/4/M_PI*Xf*pow(vf,3) * Dh2(s) * GeV2tocm3s1;
167  }
168 
170  double sv_hh(double lambda, double mass, double v)
171  {
172 
173  double s = 4*mass*mass/(1-v*v/4); // v is relative velocity
174  double vh = sqrt(1-4*mh*mh/s); // vh and vs are lab velocities
175  // Hardcoded lower velocity avoids nan results
176  double vs = std::max(v/2, 1e-6);
177  double tp = pow(mass,2)+pow(mh,2)-0.5*s*(1-vs*vh);
178  double tm = pow(mass,2)+pow(mh,2)-0.5*s*(1+vs*vh);
179 
180  double aR = 1+3*mh*mh*(s-mh*mh)*Dh2(s);
181  double aI = 3*mh*mh*sqrt(s)*Gamma_mh*Dh2(s);
182 
183  return pow(lambda,2)/16/M_PI/pow(s,2)/vs *
184  (
185  (pow(aR,2)+pow(aI,2))*s*vh*vs
186  +4*lambda*pow(v0,2)*(aR-lambda*pow(v0,2)/(s-2*pow(mh,2)))
187  *log(std::abs(pow(mass,2)-tp)/std::abs(pow(mass,2)-tm))
188  +(2*pow(lambda,2)*pow(v0,4)*s*vh*vs)
189  /(pow(mass,2)-tm)/(pow(mass,2)-tp));
190  }
191 
192  private:
193  double Gamma_mh, mh, v0, alpha_s, mb, mc, mtau, mt, mZ0, mW, mS, vSigma_semi;
194  };
195 
196  void DarkMatter_ID_ScalarSingletDM(std::string & result) { result = "S"; }
197  void DarkMatterConj_ID_ScalarSingletDM(std::string & result) { result = "S"; }
198 
201  {
202  const SubSpectrum& he = spec.get_HE();
203  double mass = spec.get(Par::Pole_Mass,"S");
204  double lambda = he.get(Par::dimensionless,"lambda_hS");
205  double mh = spec.get(Par::Pole_Mass,"h0_1");
206 
207  // Expressions taken from Cline et al. (2013, PRD 88:055025, arXiv:1306.4710)
208  double fp = 2./9. + 7./9.*(*Param["fpu"] + *Param["fpd"] + *Param["fps"]);
209  double fn = 2./9. + 7./9.*(*Param["fnu"] + *Param["fnd"] + *Param["fns"]);
210 
211  result.gps = lambda*fp*m_proton/pow(mh,2)/mass/2;
212  result.gns = lambda*fn*m_neutron/pow(mh,2)/mass/2;
213  result.gpa = 0; // Only SI cross-section
214  result.gna = 0;
215 
216  logger() << LogTags::debug << "Singlet DM DD couplings:" << std::endl;
217  logger() << " gps = " << result.gps << std::endl;
218  logger() << " gns = " << result.gns << std::endl;
219  logger() << " gpa = " << result.gpa << std::endl;
220  logger() << " gna = " << result.gna << EOM;
221  }
222 
225  {
228  get_ScalarSingletDM_DD_couplings(spec, result, Param);
229  }
230 
233  {
236  get_ScalarSingletDM_DD_couplings(spec, result, Param);
237  }
238 
239 
242  {
244  using std::vector;
245  using std::string;
246 
247  // Initialize empty catalog and main annihilation process
248  TH_ProcessCatalog catalog;
249  TH_Process process_ann("S", "S");
250 
251  // Explicitly state that Z2 Scalar DM is self-conjugate
252  process_ann.isSelfConj = true;
253 
255  // Import particle masses and couplings
257 
258  // Convenience macros
259  #define getSMmass(Name, spinX2) \
260  catalog.particleProperties.insert(std::pair<string, TH_ParticleProperty> \
261  (Name , TH_ParticleProperty(SM.get(Par::Pole_Mass,Name), spinX2)));
262  #define addParticle(Name, Mass, spinX2) \
263  catalog.particleProperties.insert(std::pair<string, TH_ParticleProperty> \
264  (Name , TH_ParticleProperty(Mass, spinX2)));
265 
266  // Import Spectrum objects
268  const SubSpectrum& he = spec.get_HE();
269  const SubSpectrum& SM = spec.get_LE();
270  const SMInputs& SMI = spec.get_SMInputs();
271 
272  // Import couplings
273  double lambda = he.get(Par::dimensionless,"lambda_hS");
274  double v = he.get(Par::mass1,"vev");
275 
276  // Get SM pole masses
277  getSMmass("e-_1", 1)
278  getSMmass("e+_1", 1)
279  getSMmass("e-_2", 1)
280  getSMmass("e+_2", 1)
281  getSMmass("e-_3", 1)
282  getSMmass("e+_3", 1)
283  getSMmass("Z0", 2)
284  getSMmass("W+", 2)
285  getSMmass("W-", 2)
286  getSMmass("g", 2)
287  getSMmass("gamma", 2)
288  getSMmass("u_3", 1)
289  getSMmass("ubar_3", 1)
290  getSMmass("d_3", 1)
291  getSMmass("dbar_3", 1)
292 
293  // Pole masses not available for the light quarks.
294  addParticle("u_1" , SMI.mU, 1) // mu(2 GeV)^MS-bar, not pole mass
295  addParticle("ubar_1", SMI.mU, 1) // mu(2 GeV)^MS-bar, not pole mass
296  addParticle("d_1" , SMI.mD, 1) // md(2 GeV)^MS-bar, not pole mass
297  addParticle("dbar_1", SMI.mD, 1) // md(2 GeV)^MS-bar, not pole mass
298  addParticle("u_2" , SMI.mCmC,1) // mc(mc)^MS-bar, not pole mass
299  addParticle("ubar_2", SMI.mCmC,1) // mc(mc)^MS-bar, not pole mass
300  addParticle("d_2" , SMI.mS, 1) // ms(2 GeV)^MS-bar, not pole mass
301  addParticle("dbar_2", SMI.mS, 1) // ms(2 GeV)^MS-bar, not pole mass
302  double alpha_s = SMI.alphaS; // alpha_s(mZ)^MSbar
303 
304  // Masses for neutrino flavour eigenstates. Set to zero.
305  // (presently not required)
306  addParticle("nu_e", 0.0, 1)
307  addParticle("nubar_e", 0.0, 1)
308  addParticle("nu_mu", 0.0, 1)
309  addParticle("nubar_mu", 0.0, 1)
310  addParticle("nu_tau", 0.0, 1)
311  addParticle("nubar_tau",0.0, 1)
312 
313  // Higgs-sector masses
314  double mS = spec.get(Par::Pole_Mass,"S");
315  double mH = spec.get(Par::Pole_Mass,"h0_1");
316  addParticle("S", mS, 0) // Scalar Singlet DM
317  addParticle("h0_1", mH, 0) // SM-like Higgs
318  addParticle("pi0", meson_masses.pi0, 0)
319  addParticle("pi+", meson_masses.pi_plus, 0)
320  addParticle("pi-", meson_masses.pi_minus, 0)
321  addParticle("eta", meson_masses.eta, 0)
322  addParticle("rho0", meson_masses.rho0, 1)
323  addParticle("rho+", meson_masses.rho_plus, 1)
324  addParticle("rho-", meson_masses.rho_minus, 1)
325  addParticle("omega", meson_masses.omega, 1)
326 
327  // Get rid of convenience macros
328  #undef getSMmass
329  #undef addParticle
330 
331 
333  // Import Decay information
335 
336  // Import decay table from DecayBit
337  const DecayTable* tbl = &(*Dep::decay_rates);
338 
339  // Save Higgs width for later
340  double gammaH = tbl->at("h0_1").width_in_GeV;
341 
342  // Set of imported decays
343  std::set<string> importedDecays;
344 
345  // Minimum branching ratio to include
346  double minBranching = 0;
347 
348  // Import relevant decays (only Higgs and subsequent decays)
350  // Notes: Virtual Higgs decays into offshell W+W- final states are not
351  // imported. All other channels are correspondingly rescaled. Decay
352  // into SS final states is accounted for, leading to zero photons.
353  ImportDecays("h0_1", catalog, importedDecays, tbl, minBranching,
354  daFunk::vec<std::string>("Z0", "W+", "W-", "e+_2", "e-_2", "e+_3", "e-_3"));
355 
356  // Instantiate new ScalarSingletDM object
357  auto singletDM = boost::make_shared<ScalarSingletDM>(&catalog, gammaH, v, alpha_s, 0.0);
358 
359  // Populate annihilation channel list and add thresholds to threshold
360  // list.
361  // (remark: the lowest threshold is here = 2*mS, whereas in DS-internal
362  // conventions, this lowest threshold is not listed)
363  process_ann.resonances_thresholds.threshold_energy.push_back(2*mS);
364  auto channel =
365  daFunk::vec<string>("bb", "WW", "cc", "tautau", "ZZ", "tt", "hh");
366  auto p1 =
367  daFunk::vec<string>("d_3", "W+", "u_2", "e+_3", "Z0", "u_3", "h0_1");
368  auto p2 =
369  daFunk::vec<string>("dbar_3","W-", "ubar_2","e-_3", "Z0", "ubar_3","h0_1");
370  {
371  for ( unsigned int i = 0; i < channel.size(); i++ )
372  {
373  double mtot_final =
374  catalog.getParticleProperty(p1[i]).mass +
375  catalog.getParticleProperty(p2[i]).mass;
376  // Include final states that are open for T~m/20
377  if ( mS*2 > mtot_final*0.5 )
378  {
379  daFunk::Funk kinematicFunction = daFunk::funcM(singletDM,
380  &ScalarSingletDM::sv, channel[i], lambda, mS, daFunk::var("v"));
381  TH_Channel new_channel(
382  daFunk::vec<string>(p1[i], p2[i]), kinematicFunction
383  );
384  process_ann.channelList.push_back(new_channel);
385  }
386  if ( mS*2 > mtot_final )
387  {
389  push_back(mtot_final);
390  }
391  }
392  }
393 
394  // Populate resonance list
395  if ( mH >= mS*2 ) process_ann.resonances_thresholds.resonances.
396  push_back(TH_Resonance(mH, gammaH));
397 
398  catalog.processList.push_back(process_ann);
399 
400  // Validate
401  catalog.validate();
402 
403 
404  #ifdef DARKBIT_DEBUG
405  // get DarkBit computed vSigma total
406  // so we can compare with that from MO
407  ScalarSingletDM test = *singletDM;
408  int nc = 7;
409  double total = 0;
410  for (int ii=0; ii < nc ; ii++)
411  {
412  total = total + test.sv(channel[ii], lambda, mS, 0.0);
413  }
414  cout << " --- Testing process catalouge --- " << endl;
415  cout << "Total sigma V from process catalouge = " << total << endl;
416  cout << " ---------- " << endl;
417  #endif
418 
419 
420 
421  result = catalog;
422  } // function TH_ProcessCatalog_ScalarSingletDM_Z2
423 
424 
425 
428  {
430  using std::vector;
431  using std::string;
432 
433  // Initialize empty catalog and main annihilation process
434  TH_ProcessCatalog catalog;
435  TH_Process process_ann("S", "S");
436 
437  // Explicitly state that Z3 Scalar DM is not self-conjugate
438  process_ann.isSelfConj = false;
439 
440  // get semi-annihilation cross-section from MicrOmegas
441 
442  // set requested spectra to NULL since we don't need them
443  double * SpNe=NULL,*SpNm=NULL,*SpNl=NULL;
444  double * SpA=NULL,*SpE=NULL,*SpP=NULL;
445  int err;
446 
447  double vSigma_total = BEreq::calcSpectrum(byVal(3),byVal(SpA),byVal(SpE),byVal(SpP),byVal(SpNe),byVal(SpNm),byVal(SpNl) ,byVal(&err));
448 
449  if (err != 0 )
450  {
451  DarkBit_error().raise(LOCAL_INFO, "MicrOmegas spectrum calculation returned error code = " + std::to_string(err));
452  }
453 
454  // get BR for each channel as filled by calcSpectrum
455  MicrOmegas::aChannel* vSigmaCh;
456  vSigmaCh = *BEreq::vSigmaCh;
457 
458  int n_channels = sizeof(vSigmaCh);
459  double BR_semi = 0; // semi-annihilation BR
460  #ifdef DARKBIT_DEBUG
461  cout << "--- Semi-annihilation processes and BRs --- " << endl;
462  #endif
463  // find semi-annihilation channels
464  int i = 0;
465  while ((vSigmaCh[i].weight!=0) && (i < n_channels))
466  {
467  // get final states
468  const char* p1 = vSigmaCh[i].prtcl[2];
469  const char* p2 = vSigmaCh[i].prtcl[3];
470  // semi-annihilation final states are h + ~ss or h + ~SS
471 
472  if ( (strcmp(p1,"h")==0) && ( (strcmp(p2,"~ss")==0) || (strcmp(p2,"~SS")==0) ) )
473  {
474  BR_semi = BR_semi + vSigmaCh[i].weight;
475  #ifdef DARKBIT_DEBUG
476  cout << "process: " << vSigmaCh[i].prtcl[0] << " + ";
477  cout << vSigmaCh[i].prtcl[1] << " -> " << p1 << " + " << p2;
478  cout << ", BR = " << vSigmaCh[i].weight << endl;
479  #endif
480  }
481  i++;
482  }
483 
484  // Get the semi-annihilation cross-section, accounting for the fact that MO already scales
485  // vSigma_total down by a factor of 2 to account for the fact that Z3 scalar singlet DM is not self-conjugate.
486  double vSigma_semi = BR_semi * 2.0 * vSigma_total;
487 
488  #ifdef DARKBIT_DEBUG
489  cout << "--- --- " << endl;
490  cout << "Total sigma v from MicrOmegas = " << vSigma_total << " cm^3/s" << endl;
491  cout << "semi-annihilation BR = " << BR_semi << endl;
492  cout << "semi-annihilation sigma v from MicrOmegas = " << 0.5*vSigma_semi << " cm^3/s" << endl;
493  cout << "Total sigma v from MicrOmegas excluding semi-annihilations = " << vSigma_total - 0.5*vSigma_semi << endl;
494  cout << "--------- " << endl;
495  #endif
496 
497 
499  // Import particle masses and couplings
501 
502  // Convenience macros
503  #define getSMmass(Name, spinX2) \
504  catalog.particleProperties.insert(std::pair<string, TH_ParticleProperty> \
505  (Name , TH_ParticleProperty(SM.get(Par::Pole_Mass,Name), spinX2)));
506  #define addParticle(Name, Mass, spinX2) \
507  catalog.particleProperties.insert(std::pair<string, TH_ParticleProperty> \
508  (Name , TH_ParticleProperty(Mass, spinX2)));
509 
510  // Import Spectrum objects
512  const SubSpectrum& he = spec.get_HE();
513  const SubSpectrum& SM = spec.get_LE();
514  const SMInputs& SMI = spec.get_SMInputs();
515 
516  // Import couplings
517  double lambda = he.get(Par::dimensionless,"lambda_hS");
518  double v = he.get(Par::mass1,"vev");
519 
520  // Get SM pole masses
521  getSMmass("e-_1", 1)
522  getSMmass("e+_1", 1)
523  getSMmass("e-_2", 1)
524  getSMmass("e+_2", 1)
525  getSMmass("e-_3", 1)
526  getSMmass("e+_3", 1)
527  getSMmass("Z0", 2)
528  getSMmass("W+", 2)
529  getSMmass("W-", 2)
530  getSMmass("g", 2)
531  getSMmass("gamma", 2)
532  getSMmass("u_3", 1)
533  getSMmass("ubar_3", 1)
534  getSMmass("d_3", 1)
535  getSMmass("dbar_3", 1)
536 
537  // Pole masses not available for the light quarks.
538  addParticle("u_1" , SMI.mU, 1) // mu(2 GeV)^MS-bar, not pole mass
539  addParticle("ubar_1", SMI.mU, 1) // mu(2 GeV)^MS-bar, not pole mass
540  addParticle("d_1" , SMI.mD, 1) // md(2 GeV)^MS-bar, not pole mass
541  addParticle("dbar_1", SMI.mD, 1) // md(2 GeV)^MS-bar, not pole mass
542  addParticle("u_2" , SMI.mCmC,1) // mc(mc)^MS-bar, not pole mass
543  addParticle("ubar_2", SMI.mCmC,1) // mc(mc)^MS-bar, not pole mass
544  addParticle("d_2" , SMI.mS, 1) // ms(2 GeV)^MS-bar, not pole mass
545  addParticle("dbar_2", SMI.mS, 1) // ms(2 GeV)^MS-bar, not pole mass
546  double alpha_s = SMI.alphaS; // alpha_s(mZ)^MSbar
547 
548  // Masses for neutrino flavour eigenstates. Set to zero.
549  // (presently not required)
550  addParticle("nu_e", 0.0, 1)
551  addParticle("nubar_e", 0.0, 1)
552  addParticle("nu_mu", 0.0, 1)
553  addParticle("nubar_mu", 0.0, 1)
554  addParticle("nu_tau", 0.0, 1)
555  addParticle("nubar_tau",0.0, 1)
556 
557  // Higgs-sector masses
558  double mS = spec.get(Par::Pole_Mass,"S");
559  double mH = spec.get(Par::Pole_Mass,"h0_1");
560  addParticle("S", mS, 0) // Scalar Singlet DM
561  addParticle("h0_1", mH, 0) // SM-like Higgs
562  addParticle("pi0", meson_masses.pi0, 0)
563  addParticle("pi+", meson_masses.pi_plus, 0)
564  addParticle("pi-", meson_masses.pi_minus, 0)
565  addParticle("eta", meson_masses.eta, 0)
566  addParticle("rho0", meson_masses.rho0, 1)
567  addParticle("rho+", meson_masses.rho_plus, 1)
568  addParticle("rho-", meson_masses.rho_minus, 1)
569  addParticle("omega", meson_masses.omega, 1)
570 
571  // Get rid of convenience macros
572  #undef getSMmass
573  #undef addParticle
574 
575 
577  // Import Decay information
579 
580  // Import decay table from DecayBit
581  const DecayTable* tbl = &(*Dep::decay_rates);
582 
583  // Save Higgs width for later
584  double gammaH = tbl->at("h0_1").width_in_GeV;
585 
586  // Set of imported decays
587  std::set<string> importedDecays;
588 
589  // Minimum branching ratio to include
590  double minBranching = 0;
591 
592  // Import relevant decays (only Higgs and subsequent decays)
594  // Notes: Virtual Higgs decays into offshell W+W- final states are not
595  // imported. All other channels are correspondingly rescaled. Decay
596  // into SS final states is accounted for, leading to zero photons.
597  ImportDecays("h0_1", catalog, importedDecays, tbl, minBranching,
598  daFunk::vec<std::string>("Z0", "W+", "W-", "e+_2", "e-_2", "e+_3", "e-_3"));
599 
600  // Instantiate new ScalarSingletDM object
601  auto singletDM = boost::make_shared<ScalarSingletDM>(&catalog, gammaH, v, alpha_s, vSigma_semi);
602 
603  // Populate annihilation channel list and add thresholds to threshold
604  // list.
605  // (remark: the lowest threshold is here = 2*mS, whereas in DS-internal
606  // conventions, this lowest threshold is not listed)
607  process_ann.resonances_thresholds.threshold_energy.push_back(2*mS);
608  auto channel =
609  daFunk::vec<string>("bb", "WW", "cc", "tautau", "ZZ", "tt", "hh", "Sh");
610  auto p1 =
611  daFunk::vec<string>("d_3", "W+", "u_2", "e+_3", "Z0", "u_3", "h0_1", "S");
612  auto p2 =
613  daFunk::vec<string>("dbar_3","W-", "ubar_2","e-_3", "Z0", "ubar_3", "h0_1", "h0_1");
614  {
615  for ( unsigned int i = 0; i < channel.size(); i++ )
616  {
617  double mtot_final =
618  catalog.getParticleProperty(p1[i]).mass +
619  catalog.getParticleProperty(p2[i]).mass;
620  // Include final states that are open for T~m/20
621  if ( mS*2 > mtot_final*0.5 )
622  {
623  daFunk::Funk kinematicFunction = daFunk::funcM(singletDM,
624  &ScalarSingletDM::sv, channel[i], lambda, mS, daFunk::var("v"));
625  TH_Channel new_channel(
626  daFunk::vec<string>(p1[i], p2[i]), kinematicFunction
627  );
628  process_ann.channelList.push_back(new_channel);
629  }
630  if ( mS*2 > mtot_final )
631  {
633  push_back(mtot_final);
634  }
635  }
636  }
637 
638  // Populate resonance list
639  if ( mH >= mS*2 ) process_ann.resonances_thresholds.resonances.
640  push_back(TH_Resonance(mH, gammaH));
641 
642  catalog.processList.push_back(process_ann);
643 
644  // Validate
645  catalog.validate();
646 
647  #ifdef DARKBIT_DEBUG
648  // get DarkBit computed vSigma total
649  // so we can compare with that from MO
650  ScalarSingletDM test = *singletDM;
651  int nc = 7;
652  double total = 0;
653  for (int ii=0; ii < nc ; ii++)
654  {
655  total = total + test.sv(channel[ii], lambda, mS, 0.0);
656  }
657  cout << " --- Testing process catalouge --- " << endl;
658  cout << "Total sigma V from process catalouge excluding semi-annihilations = " << total << endl;
659  total = total + test.sv("Sh", lambda, mS, 0.0);
660  cout << "Total including semi-annihilations = " << total << endl;
661  cout << " ---------- " << endl;
662  #endif
663 
664  result = catalog;
665  } // function TH_ProcessCatalog_ScalarSingletDM_Z3
666 
667 
668 
669  }
670 }
std::vector< TH_Channel > channelList
List of channels.
error & DarkBit_error()
double get(const Par::Tags partype, const std::string &mass) const
Definition: spectrum.cpp:249
Simple function for returning SM Higgs partial and total widths as a function of virtuality, as read from data files from CERN Yellow Paper arXiv:1101.0593.
std::chrono::steady_clock::time_point tp
void DD_couplings_ScalarSingletDM_Z2(DM_nucleon_couplings &result)
Direct detection couplings for Z2 scalar singlet DM.
const double m_proton
std::vector< TH_Resonance > resonances
Entry & at(std::pair< int, int >)
Get entry in decay table for a give particle, throwing an error if particle is absent.
void ImportDecays(std::string pID, TH_ProcessCatalog &catalog, std::set< std::string > &importedDecays, const DecayTable *tbl, double minBranching, std::vector< std::string > excludeDecays=std::vector< std::string >())
Funk funcM(O *obj, double(O::*f)(funcargs...), Args... args)
Definition: daFunk.hpp:861
const double s2cm
const double m_neutron
Simple reader for ASCII tables.
#define addParticle(Name, Mass, spinX2)
#define LOCAL_INFO
Definition: local_info.hpp:34
const double mt
Definition: topness.h:39
START_MODEL v0
void TH_ProcessCatalog_ScalarSingletDM_Z2(DarkBit::TH_ProcessCatalog &result)
Set up process catalog for Z2 scalar singlet DM.
Funk var(std::string arg)
Definition: daFunk.hpp:921
const double mW
Definition: topness.h:40
double virtual_SMHiggs_widths(str, double)
Higgs branching ratios and total width Gamma [GeV], as function of mass [GeV] (90 - 300 GeV) ...
void DD_couplings_ScalarSingletDM_Z3(DM_nucleon_couplings &result)
Direct detection couplings for Z3 scalar singlet DM.
Piped_invalid_point piped_invalid_point
Global instance of piped invalid point class.
Definition: exceptions.cpp:544
bool isSelfConj
Does the process contain self-conjugate DM? (accounting for correct factors of 1/2 in annihilation sp...
Spectrum Spectrum Spectrum Spectrum Spectrum Spectrum Spectrum ScalarSingletDM_Z3_spectrum
A single resonance of a given width at a given energy (both in GeV)
void DarkMatterConj_ID_ScalarSingletDM(std::string &result)
virtual double get(const Par::Tags, const str &, const SpecOverrideOptions=use_overrides, const SafeBool check_antiparticle=SafeBool(true)) const =0
void DarkMatter_ID_ScalarSingletDM(std::string &result)
TH_resonances_thresholds resonances_thresholds
List of resonances and thresholds.
double width_in_GeV
Total particle width (in GeV)
void TH_ProcessCatalog_ScalarSingletDM_Z3(DarkBit::TH_ProcessCatalog &result)
Set up process catalog for Z3 scalar singlet DM.
A container holding all annihilation and decay initial states relevant for DarkBit.
const Logging::endofmessage EOM
Explicit const instance of the end of message struct in Gambit namespace.
Definition: logger.hpp:100
Header file that includes all GAMBIT headers required for a module source file.
EXPORT_SYMBOLS Logging::LogMaster & logger()
Function to retrieve a reference to the Gambit global log object.
Definition: logger.cpp:95
SubSpectrum & get_LE()
Standard getters Return references to internal data members.
Definition: spectrum.cpp:224
All data on a single annihilation or decay channel, e.g.
const double gev2cm2
double lambda(double x, double y, double z)
Definition: MSSM_H.hpp:38
Virtual base class for interacting with spectrum generator output.
Definition: subspectrum.hpp:87
#define getSMmass(Name, spinX2)
Rollcall header for module DarkBit.
GAMBIT native decay table class.
Definition: decay_table.hpp:35
double pow(const double &a)
Outputs a^i.
Spectrum Spectrum Spectrum Spectrum Spectrum Spectrum mh
void request(std::string message)
Request an exception.
Definition: exceptions.cpp:471
A container for a single process.
T byVal(T t)
Redirection function to turn an lvalue into an rvalue, so that it is correctly passed by value when d...
shared_ptr< FunkBase > Funk
Definition: daFunk.hpp:113
void get_ScalarSingletDM_DD_couplings(const Spectrum &spec, DM_nucleon_couplings &result, Models::safe_param_map< safe_ptr< const double > > &Param)
Common code for different scalar singlet direct detection coupling routines.
TODO: see if we can use this one:
Definition: Analysis.hpp:33
SubSpectrum & get_HE()
Definition: spectrum.cpp:225
"Standard Model" (low-energy) plus high-energy model container class
Definition: spectrum.hpp:110
SMInputs & get_SMInputs()
Definition: spectrum.cpp:226
Utility functions for DarkBit.
Container class for Standard Model input information (defined as in SLHA2)
Definition: sminputs.hpp:29