A model class for the Standard Model. More...
#include <StandardModel.h>
A model class for the Standard Model.
This is a Model class containing parameters and functions associated with the Standard Model. This class is inherited from the QCD class, which defines parameters related to QCD.
The constructor StandardModel() initializes some of the model flags to their default values. After creating an instance of the current class, it is required to call the initialization method InitializeModel(), which allocates memory to the pointers defined in the current class. These pointers are then used in computing EW precision and flavour observables, respectively. In the Monte Carlo run, the constructor as well as the initialization method are called in InputParser::ReadParameters().
The initializations and updates of the model parameters and flags are explained below.
The model parameters of StandardModel are summarized below:
Label | LaTeX symbol | Description |
---|---|---|
Mz | \(M_Z\) | The mass of the \(Z\) boson in GeV. |
Mw_inp | \(M_W\) | The mass of the \(W\) boson in GeV. Only used if the flag MWinput is TRUE. |
AlsMz | \(\alpha_s(M_Z)\) | The strong coupling constant at the Z-boson mass. |
GF | \(G_\mu\) | The Fermi constant in \({\rm GeV}^{-2}\), measured through muon decays. |
ale | \(\alpha\) | The fine-structure constant. |
dAle5Mz | \(\Delta\alpha_{\mathrm{had}}^{(5)}(M_Z^2)\) | The five-flavour hadronic contribution to the electromagnetic coupling. |
mHl | \(m_h\) | The Higgs mass in GeV. |
delMw | \(\delta\,M_W\) | The theoretical uncertainty in \(M_W\) in GeV, which is applicable only when EWSMApproximateFormulae::Mw() is employed for \(M_W\). See also the model flag Mw. |
delSin2th_l | \(\delta\sin^2\theta_{\rm eff}^{\rm lept}\) | The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{\rm lept}\), which is applicable only when EWSMApproximateFormulae::sin2thetaEff_l() is employed for \(\sin^2\theta_{\rm eff}^{\rm lept}\). See also the model flag KappaZ. |
delSin2th_q | \(\delta\sin^2\theta_{\rm eff}^{q\not = b,t}\) | The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{q\not = b,t}\), which is applicable only when EWSMApproximateFormulae::sin2thetaEff_q() is employed for \(\sin^2\theta_{\rm eff}^{q\not = b,t}\). See also the model flag KappaZ. |
delSin2th_b | \(\delta\sin^2\theta_{\rm eff}^{b}\) | The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{b}\), which is applicable only when EWSMApproximateFormulae::sin2thetaEff_b() is employed for \(\sin^2\theta_{\rm eff}^{b}\). See also the model flag KappaZ. |
delGammaZ | \(\delta\,\Gamma_Z\) | The theoretical uncertainty in \(\Gamma_Z\) in GeV, which is applicable only when EWSMApproximateFormulae::X_full_2_loop() is employed for \(\Gamma_Z\). See also the model flag NoApproximateGammaZ. |
delsigma0H | \(\delta\,\sigma_{Hadron}^0\) | The theoretical uncertainty in \(\sigma_{Hadron}^0\), which is applicable only when EWSMApproximateFormulae::X_full_2_loop() is employed for \(\sigma_{Hadron}^0\). |
delR0l | \(\delta\,R_l^0\) | The theoretical uncertainty in \(R_l^0\), which is applicable only when EWSMApproximateFormulae::X_full_2_loop() is employed for \(R_l^0\). |
delR0c | \(\delta\,R_c^0\) | The theoretical uncertainty in \(R_c^0\), which is applicable only when EWSMApproximateFormulae::X_full_2_loop() is employed for \(R_c^0\). |
delR0b | \(\delta\,R_b^0\) | The theoretical uncertainty in \(R_b^0\), which is applicable only when EWSMApproximateFormulae::X_full_2_loop() is employed for \(R_b^0\). |
mneutrino_1 | \(m_{\nu_1}\) | The mass of the first-generation neutrino in GeV. |
mneutrino_2 | \(m_{\nu_2}\) | The mass of the second-generation neutrino in GeV. |
mneutrino_3 | \(m_{\nu_3}\) | The mass of the third-generation neutrino in GeV. |
melectron | \(m_e\) | The electron mass in GeV. |
mmu | \(m_\mu\) | The muon mass in GeV. |
mtau | \(m_\tau\) | The tau mass in GeV. |
lambda | \(\lambda\) | The CKM parameter \(\lambda\) in the Wolfenstein parameterization. |
A | \(A\) | The CKM parameter \(A\) in the Wolfenstein parameterization. |
rhob | \(\bar{\rho}\) | The CKM parameter \(\bar{\rho}\) in the Wolfenstein parameterization. |
etab | \(\bar{\eta}\) | The CKM parameter \(\bar{\eta}\) in the Wolfenstein parameterization. |
muw | \(\mu_W\) | A matching scale around the weak scale in GeV. |
The set of the model parameters are initialized and updated with the methods Init() and Update(), respectively, where the former calls the latter actually. In Update(), the methods PreUpdate() and PostUpdate() are called to run all the procedures that are need to be executed before and after the model parameters are updated. The CKM and PMNS matrices and the Yukawa matrices are recomputed in PostUpdate() with the updated parameters. Inside the Update() method, the individual model parameter is assigned with the protected member function setParameter().
The parameters delMw, delSin2th_l, delSin2th_q, delSin2th_b, delGammaZ, delsigma0H, delR0l, delR0c, delR0b represent theoretical uncertainties in the \(W\)-boson mass, the leptonic and quark effective weak mixing angles at the \(Z\)-boson mass scale, the total decay width of the \(Z\) boson, the hadronic cross section at the peak, and the ratios \(R_l^0\), \(R_c^0\) and \(R_b^0\), respectively, originating from missing higher-order corrections. The contributions from these parameters are incorporated into their two-loop approximate formulae: EWSMApproximateFormulae::Mw(), EWSMApproximateFormulae::sin2thetaEff_l(), EWSMApproximateFormulae::sin2thetaEff_q(), EWSMApproximateFormulae::sin2thetaEff_b(), EWSMApproximateFormulae::X_full_2_loop("GammaZ"), EWSMApproximateFormulae::X_full_2_loop("sigmaHadron"), EWSMApproximateFormulae::X_full_2_loop("R0_lepton"), EWSMApproximateFormulae::X_full_2_loop("R0_charm") and EWSMApproximateFormulae::X_full_2_loop("R0_bottom"). Therefore, the parameters are applicable only when the corresponding approximate formulae are employed. See also the model flags below.
The flags of StandardModel are summarized below, where the values of the boolean flags (TRUE or FALSE) are case insensitive, while those of the other flags are case sensitive. The default values of the flags are indicated in bold:
Label | Value | Description |
---|---|---|
Wolfenstein | TRUE / FALSE | This flag controls the way the CKM matrix is parameterized. If set to TRUE, the CKM matrix is computed starting from the Wolfenstein parameters. If set to FALSE, the CKM matrix is computed starting from \(\vert V_{us} \vert\), \(\vert V_{cb} \vert\), \(\vert V_{ub} \vert\) and \(\gamma\). The default value is TRUE. |
UseVud | FALSE / TRUE | This flag controls the way the CKM matrix is parameterized. If set to FALSE, with Wolfenstein FALSE, the CKM matrix is computed starting from \(\vert V_{us} \vert\), \(\vert V_{cb} \vert\), \(\vert V_{ub} \vert\) and \(\gamma\). If set to TRUE, with Wolfenstein FALSE, the CKM matrix is computed starting from \(\vert V_{ud} \vert\), \(\vert V_{cb} \vert\), \(\vert V_{ub} \vert\) and \(\gamma\). If Wolfenstein is set to TRUE, this flag has no effect. The default value is FALSE. |
FixMuwMut | FALSE / TRUE | This flag controls the way the weak matching scale and the top quark decoupling scale are varied. If set to FALSE, the \(\mu_W\) parameter is introduced to float the matching scale independently of the top decoupling scale \(\mu_t\). If set to TRUE, the \(\mu_t\) parameter is fixed to \(\mu_W / M_W * \m_t\) Notice that in this case the \(\mu_t\) parameter defined in QCD becomes irrelevant, therefore it is advisable to fix it to a constant in the configuration file The default value is FALSE. |
CacheInStandardModel | TRUE / FALSE | This flag controls the use of the cashing method implemented in EWSM class. The default value is TRUE. |
CacheInEWSMcache | TRUE / FALSE | This flag controls the use of the cashing method implemented in EWSMcache class. The default value is TRUE. |
WithoutNonUniversalVC | TRUE / FALSE | This flag controls if flavour non-universal vertex corrections are not added to the epsilon parameterization for the EW precision observables. The default value is FALSE; the non-universal corrections are taken into account. |
NoApproximateGammaZ | TRUE / FALSE | This flag is set to true if the two-loop approximate formulae of the partial and total decay widths of the \(Z\) boson defined with the function EWSMApproximateFormulae::X_full_2_loop() are NOT employed. The default value is FALSE. |
Mw | NORESUM / OMSI / INTERMEDIATE / OMSII / APPROXIMATEFORMULA | This flag controls the formula used in computing the \(W\)-boson mass. The default flag is APPROXIMATEFORMULA. See EWSM::Mw_SM(), EWSM::resumMw() and EWSMApproximateFormulae::Mw() for detail. |
RhoZ | NORESUM / OMSI / INTERMEDIATE / OMSII | This flag controls the formula used in computing the \(Zf\bar{f}\) couplings \(\rho_Z^f\). The default flag is NORESUM. See EWSM::rhoZ_l_SM(), EWSM::rhoZ_q_SM() and EWSM::resumRhoZ() for detail. |
KappaZ | NORESUM / OMSI / INTERMEDIATE / OMSII / APPROXIMATEFORMULA | This flag controls the formula used in computing the \(Zf\bar{f}\) couplings \(\kappa_Z^f\). The default flag is APPROXIMATEFORMULA. See EWSM::kappaZ_l_SM(), EWSM::kappaZ_q_SM() and EWSM::resumKappaZ() for detail. |
MWinput | TRUE / FALSE | This auxiliary flag is used for setting the W mass as a SM input, instead of the electromagnetic constant parameter dAle5Mz. The default value is FALSE. |
SMAux | TRUE / FALSE | This auxiliary flag is used for testing new options. The default value is FALSE. |
These flags can be set via the method setFlag() or setFlagStr(), where the former is applicable for the boolean flags, while the latter is for the other flags. The method CheckFlags() is responsible for checking whether the flags are sane. The public member functions IsFlagWithoutNonUniversalVC(), IsFlagNoApproximateGammaZ() getFlagMw(), getFlagRhoZ() and getFlagKappaZ() are used to retrieve the values of each flag.
The first two flags CacheInStandardModel and CacheInEWSMcache for the cashing methods in EWSM and EWSMcache classes are relevant to the computations of the electroweak precision observables. Those caches are effective when the \(W\)-boson mass, the decay widths of the \(Z\) boson and the \(Zf\bar{f}\) effective couplings \(\kappa_Z^f\) are calculated without using their two-loop approximate formulae.
The on-mass-shell renormalization scheme [Sirlin:1980nh], [Marciano:1980pb], [Bardin:1980fe], [Bardin:1981sv] is adopted for UV divergences, and the weak mixing angle is defined in terms of the physical masses of the gauge bosons:
\[ s_W^2 \equiv \sin^2\theta_W = 1 - \frac{M_W^2}{M_Z^2}\,, \]
and \(c_W^2=1-s_W^2\).
The Fermi constant \(G_\mu\) in \(\mu\) decay is taken as an input quantity instead of the \(W\)-boson mass, since the latter has not been measured very precisely compared to the former. The relation between \(G_\mu\) and \(M_W\) is written as
\[ G_\mu = \frac{\pi\,\alpha}{\sqrt{2} s_W^2 M_W^2} (1+\Delta r)\,, \]
where \(\Delta r\) represents radiative corrections. From this relation, the \(W\)-boson mass is calculated as
\[ M_W^2 = \frac{M_Z^2}{2} \left( 1+\sqrt{1-\frac{4\pi\alpha}{\sqrt{2}G_\mu M_Z^2}\,(1+\Delta r)}\ \right). \]
The interaction between the \(Z\) boson and the neutral current can be written in terms of the effective \(Zf\bar{f}\) couplings \(g_{V}^f\) and \(g_{A}^f\), of \(g_{R}^f\) and \(g_{L}^f\), or of \(\rho_Z^f\) and \(\kappa_Z^f\):
\begin{eqnarray} \mathcal{L} &=& \frac{e}{2 s_W c_W}\, Z_\mu \sum_f \bar{f} \left( g_{V}^f\gamma_\mu - g_{A}^f \gamma_\mu\gamma_5 \right)\, f\,, \\ &=& \frac{e}{2s_W c_W}\, Z_\mu \sum_f \bar{f} \left[ g_{R}^f \gamma_\mu (1 + \gamma_5) + g_{L}^f \gamma_\mu (1 - \gamma_5) \right]\, f\,, \\ &=& \frac{e}{2 s_W c_W}\sqrt{\rho_Z^f}\, Z_\mu \sum_f \bar{f} \left[( I_3^f - 2Q_f\kappa_Z^f s_W^2)\gamma^\mu - I_3^f\gamma^\mu\gamma_5\right]\,f\,, \end{eqnarray}
where \(\rho_Z^f\) and \(\kappa_Z^f\) are related to \(g_{V}^f\) and \(g_{A}^f\) as the relations:
\begin{eqnarray} g_V^f &=& \sqrt{\rho_Z^f} I_3^f (1 - 4|Q_f|\kappa_Z^fs_W^2) = \sqrt{\rho_Z^f} (I_3^f - 2Q_f\kappa_Z^fs_W^2)\,, \qquad g_A^f &=& \sqrt{\rho_Z^f} I_3^f\,, \end{eqnarray}
and
\begin{eqnarray} \rho_Z^f &=& \left( \frac{g_A^f}{I_3^f} \right)^2, \qquad \kappa_Z^f &=& \frac{1}{4|Q_f|s_W^2} \left( 1 - \frac{g_V^{f}}{g_A^{f}}\right). \end{eqnarray}
The current class handles the following quantities:
Moreover, the functions Mzbar(), MwbarFromMw(), MwFromMwbar() and DeltaRbar_SM() can be used for the quantities in the complex-pole/fixed-width scheme.
The formulae used for the \(W\)-boson mass \(M_W\) and the effective couplings \(\rho_Z^f\) and \(\kappa_Z^f\) are controlled with the model flags Mw, RhoZ and KappaZ of StandardModel. For each flag, the available schemes are as follows:
The scheme APPROXIMATEFORMULA provides the most accurate SM predictions for \(M_W\) and \(\kappa_Z^f\), while the approximate two-loop formula is not available for \(\rho_Z^f\).
See resumMw(), resumRhoZ() and resumKappaZ() for details on the other schemes.
This class contains caching methods for the following functions: DeltaAlphaLepton(), DeltaAlpha(), Mw_SM(), GammaW_SM(), rhoZ_l_SM(), rhoZ_q_SM(), kappaZ_l_SM() and kappaZ_q_SM(), to improve the performance of the Monte Carlo run. The caching methods are implemented with the function checkSMparams().
The use of the caching methods can be controlled with the model flag CacheInStandardModel of StandardModel.
Definition at line 509 of file StandardModel.h.
Public Types | |
enum | LEP2RCs { Weak = 0 , WeakBox , ISR , QEDFSR , QCDFSR , NUMofLEP2RCs } |
enum | orders_EW { EW1 = 0 , EW1QCD1 , EW1QCD2 , EW2 , EW2QCD1 , EW3 , orders_EW_size } |
An enumerated type representing perturbative orders of radiative corrections to EW precision observables. More... | |
![]() | |
enum | lepton { NEUTRINO_1 , ELECTRON , NEUTRINO_2 , MU , NEUTRINO_3 , TAU , NOLEPTON } |
An enum type for leptons. More... | |
enum | meson { P_0 , P_P , K_0 , K_P , D_0 , D_P , D_S , B_D , B_P , B_S , B_C , PHI , K_star , K_star_P , K_S , D_star_P , RHO , RHO_P , OMEGA , MESON_END } |
An enum type for mesons. More... | |
enum | quark { UP , DOWN , CHARM , STRANGE , TOP , BOTTOM } |
An enum type for quarks. More... | |
Public Member Functions | |
virtual const double | A_f (const Particle f) const |
The left-right asymmetry in \(e^+e^-\to Z\to \ell \bar{\ell}\) at the \(Z\)-pole, \(\mathcal{A}_\ell\). More... | |
virtual const double | AFB (const Particle f) const |
gslpp::complex | AH_f (const double tau) const |
Fermionic loop function entering in the calculation of the effective \(Hgg\) and \(H\gamma\gamma\) couplings. More... | |
gslpp::complex | AH_W (const double tau) const |
W loop function entering in the calculation of the effective \(H\gamma\gamma\) coupling. More... | |
gslpp::complex | AHZga_f (const double tau, const double lambda) const |
Fermionic loop function entering in the calculation of the effective \(HZ\gamma\) coupling. More... | |
gslpp::complex | AHZga_W (const double tau, const double lambda) const |
W loop function entering in the calculation of the effective \(HZ\gamma\) coupling. More... | |
const double | Ale (double mu, orders order, bool Nf_thr=true) const |
The running electromagnetic coupling \(\alpha_e(\mu)\) in the \(\overline{MS}\) scheme. More... | |
const double | ale_OS (const double mu, orders order=FULLNLO) const |
The running electromagnetic coupling \(\alpha(\mu)\) in the on-shell scheme. More... | |
virtual const double | alphaMz () const |
The electromagnetic coupling at the \(Z\)-mass scale, \(\alpha(M_Z^2)=\alpha/(1-\Delta\alpha(M_Z^2))\). More... | |
virtual const double | alrmoller (const double q2, const double y) const |
The computation of the parity violating asymmetry in Moller scattering. More... | |
const double | Als (const double mu, const int Nf_in, const orders order=FULLNLO) const |
Computes the running strong coupling \(\alpha_s(\mu)\) with \(N_f\) active flavours in the \(\overline{\mathrm{MS}}\) scheme. In the cases of LO, NLO and FULLNLO, the coupling is computed with AlsWithInit(). On the other hand, in the cases of NNLO and FULLNNLO, the coupling is computed with AlsWithLambda(). More... | |
const double | Als (const double mu, const orders order, const bool Nf_thr, const bool qed_flag) const |
The running QCD coupling \(\alpha(\mu)\) in the \(\overline{MS}\) scheme including QED corrections. More... | |
const double | Als (const double mu, const orders order=FULLNLO, const bool Nf_thr=true) const |
const double | Alstilde5 (const double mu) const |
The value of \(\frac{\alpha_s^{\mathrm{FULLNLO}}}{4\pi}\) at any scale \(\mu\) with the number of flavours \(n_f = 4\) and full EW corrections. More... | |
virtual const double | amuon () const |
The computation of the anomalous magnetic moment of the muon \(a_\mu=(g_\mu-2)/2\). More... | |
const double | Beta_e (int nm, unsigned int nf) const |
QED beta function coefficients - eq. (36) hep-ph/0512066. More... | |
const double | Beta_s (int nm, unsigned int nf) const |
QCD beta function coefficients including QED corrections - eq. (36) hep-ph/0512066. More... | |
virtual const double | BrHtobb () const |
The Br \((H\to b \bar{b})\) in the Standard Model. More... | |
virtual const double | BrHtocc () const |
The Br \((H\to c \bar{c})\) in the Standard Model. More... | |
virtual const double | BrHtogaga () const |
The Br \((H\to \gamma \gamma)\) in the Standard Model. More... | |
virtual const double | BrHtogg () const |
The Br \(\(H\to gg)\) in the Standard Model. More... | |
virtual const double | BrHtomumu () const |
The Br \((H\to \mu^+ \mu^-)\) in the Standard Model. More... | |
virtual const double | BrHtoss () const |
The Br \((H\to s \bar{s})\) in the Standard Model. More... | |
virtual const double | BrHtotautau () const |
The Br \((H\to \tau^+ \tau^-)\) in the Standard Model. More... | |
virtual const double | BrHtoWWstar () const |
The Br \((H\to W W^*)\) in the Standard Model. More... | |
virtual const double | BrHtoZga () const |
The Br \((H\to Z \gamma)\) in the Standard Model. More... | |
virtual const double | BrHtoZZstar () const |
The Br \((H\to Z Z^*)\) in the Standard Model. More... | |
virtual const double | BrW (const Particle fi, const Particle fj) const |
The branching ratio of the \(W\) boson decaying into a SM fermion pair, \(Br(W\to f_i f_j)\). More... | |
const double | c02 () const |
The square of the cosine of the weak mixing angle \(c_0^2\) defined without weak radiative corrections. More... | |
virtual bool | CheckFlags () const |
A method to check the sanity of the set of model flags. More... | |
virtual bool | CheckParameters (const std::map< std::string, double > &DPars) |
A method to check if all the mandatory parameters for StandardModel have been provided in model initialization. More... | |
bool | checkSMparamsForEWPO () |
A method to check whether the parameters relevant to the EWPO are updated. More... | |
const double | computeBrHto4f () const |
The Br \((H\to 4f)\) in the Standard Model. More... | |
const double | computeBrHto4l2 () const |
The Br \((H\to 4l)\) \(l=e,\mu\) in the Standard Model. More... | |
const double | computeBrHto4l3 () const |
The Br \((H\to 4l)\) \(l=e,\mu,\tau\) in the Standard Model. More... | |
const double | computeBrHto4q () const |
The Br \((H\to 4q)\) in the Standard Model. More... | |
const double | computeBrHto4v () const |
The Br \((H\to 4\nu)\) in the Standard Model. More... | |
const double | computeBrHtobb () const |
The Br \((H\to bb)\) in the Standard Model. More... | |
const double | computeBrHtocc () const |
The Br \((H\to cc)\) in the Standard Model. More... | |
const double | computeBrHtoevmuv () const |
The Br \((H\to e \nu \mu \nu)\) in the Standard Model. More... | |
const double | computeBrHtogaga () const |
The Br \((H\to\gamma\gamma)\) in the Standard Model. More... | |
const double | computeBrHtogg () const |
The Br \((H\to gg)\) in the Standard Model. More... | |
const double | computeBrHtollvv2 () const |
The Br \((H\to l^+ l^- \nu \nu)\) \(l=e,\mu\) in the Standard Model. More... | |
const double | computeBrHtollvv3 () const |
The Br \((H\to l^+ l^- \nu \nu)\) \(l=e,\mu,\tau\) in the Standard Model. More... | |
const double | computeBrHtomumu () const |
The Br \((H\to \mu\mu)\) in the Standard Model. More... | |
const double | computeBrHtoss () const |
The Br \((H\to ss)\) in the Standard Model. More... | |
const double | computeBrHtotautau () const |
The Br \((H\to \tau\tau)\) in the Standard Model. More... | |
const double | computeBrHtoWW () const |
The Br \((H\to WW)\) in the Standard Model. More... | |
const double | computeBrHtoZga () const |
The Br \((H\to Z\gamma)\) in the Standard Model. More... | |
const double | computeBrHtoZZ () const |
The Br \((H\to ZZ)\) in the Standard Model. More... | |
void | ComputeDeltaR_rem (const double Mw_i, double DeltaR_rem[orders_EW_size]) const |
A method to collect \(\Delta r_{\mathrm{rem}}\) computed via subclasses. More... | |
void | ComputeDeltaRho (const double Mw_i, double DeltaRho[orders_EW_size]) const |
A method to collect \(\Delta\rho\) computed via subclasses. More... | |
const double | computeGammaHgaga_tt () const |
The top loop contribution to \(H\to\gamma\gamma\) in the Standard Model. More... | |
const double | computeGammaHgaga_tW () const |
The mixed \(t-W\) loop contribution to \(H\to\gamma\gamma\) in the Standard Model. More... | |
const double | computeGammaHgaga_WW () const |
The \(W\) loop contribution to \(H\to\gamma\gamma\) in the Standard Model. More... | |
const double | computeGammaHgg_bb () const |
The bottom loop contribution to \(H\to gg\) in the Standard Model. More... | |
const double | computeGammaHgg_tb () const |
The top-bottom interference contribution to \(H\to gg\) in the Standard Model. More... | |
const double | computeGammaHgg_tt () const |
The top loop contribution to \(H\to gg\) in the Standard Model. More... | |
const double | computeGammaHTotal () const |
The Higgs total width in the Standard Model. More... | |
const double | computeGammaHZga_tt () const |
The top loop contribution to \(H\to Z\gamma\) in the Standard Model. More... | |
const double | computeGammaHZga_tW () const |
The mixed \(t-W\) loop contribution to \(H\to Z\gamma\) in the Standard Model. More... | |
const double | computeGammaHZga_WW () const |
The \(W\) loop contribution to \(H\to Z\gamma\) in the Standard Model. Currently it returns the value of tab 41 in ref. [Heinemeyer:2013tqa]. More... | |
const double | computeSigmabbH (const double sqrt_s) const |
The bbH production cross section in the Standard Model. More... | |
const double | computeSigmaggH (const double sqrt_s) const |
The ggH cross section in the Standard Model. More... | |
const double | computeSigmaggH_bb (const double sqrt_s) const |
The square of the bottom-quark contribution to the ggH cross section in the Standard Model. More... | |
const double | computeSigmaggH_tb (const double sqrt_s) const |
The top-bottom interference contribution to the ggH cross section in the Standard Model. More... | |
const double | computeSigmaggH_tt (const double sqrt_s) const |
The square of the top-quark contribution to the ggH cross section in the Standard Model. More... | |
const double | computeSigmatHq (const double sqrt_s) const |
The tHq production cross section in the Standard Model. More... | |
const double | computeSigmattH (const double sqrt_s) const |
The ttH production cross section in the Standard Model. More... | |
const double | computeSigmaVBF (const double sqrt_s) const |
The VBF cross section in the Standard Model. More... | |
const double | computeSigmaWF (const double sqrt_s) const |
The W fusion contribution \(\sigma_{WF}\) to higgs-production cross section in the Standard Model. More... | |
const double | computeSigmaWH (const double sqrt_s) const |
The WH production cross section in the Standard Model. More... | |
const double | computeSigmaZF (const double sqrt_s) const |
The Z fusion contribution \(\sigma_{ZF}\) to higgs-production cross section in the Standard Model. More... | |
const double | computeSigmaZH (const double sqrt_s) const |
The ZH production cross section in the Standard Model. More... | |
const double | computeSigmaZWF (const double sqrt_s) const |
The Z W interference fusion contribution \(\sigma_{ZWF}\) to higgs-production cross section in the Standard Model. More... | |
virtual const double | cW2 () const |
virtual const double | cW2 (const double Mw_i) const |
The square of the cosine of the weak mixing angle in the on-shell scheme, denoted as \(c_W^2\). More... | |
virtual const double | Dalpha5hMz () const |
The 5-quark contribution to the running of the em constant to the \(Z\) pole. \(\Delta\alpha_{had}^{(5)}(M_Z)\). More... | |
const double | DeltaAlpha () const |
The total corrections to the electromagnetic coupling \(\alpha\) at the \(Z\)-mass scale, denoted as \(\Delta\alpha(M_Z^2)\). More... | |
const double | DeltaAlphaL5q () const |
The sum of the leptonic and the five-flavour hadronic corrections to the electromagnetic coupling \(\alpha\) at the \(Z\)-mass scale, denoted as \(\Delta\alpha^{\ell+5q}(M_Z^2)\). More... | |
const double | DeltaAlphaLepton (const double s) const |
Leptonic contribution to the electromagnetic coupling \(\alpha\), denoted as \(\Delta\alpha_{\mathrm{lept}}(s)\). More... | |
const double | DeltaAlphaTop (const double s) const |
Top-quark contribution to the electromagnetic coupling \(\alpha\), denoted as \(\Delta\alpha_{\mathrm{top}}(s)\). More... | |
virtual const gslpp::complex | deltaKappaZ_f (const Particle f) const |
Flavour non-universal vertex corrections to \(\kappa_Z^l\), denoted by \(\Delta\kappa_Z^l\). More... | |
virtual const double | DeltaR () const |
The SM prediction for \(\Delta r\) derived from that for the \(W\) boson mass. More... | |
virtual const double | DeltaRbar () const |
The SM prediction for \(\Delta \overline{r}\) derived from that for the \(W\)-boson mass. More... | |
virtual const gslpp::complex | deltaRhoZ_f (const Particle f) const |
Flavour non-universal vertex corrections to \(\rho_Z^l\), denoted by \(\Delta\rho_Z^l\). More... | |
virtual const double | eeffAFBbottom (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffAFBcharm (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffAFBe (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffAFBetsub (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffAFBmu (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffAFBstrange (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffAFBtau (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffRbottom (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffRcharm (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffRelectron (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffRelectrontsub (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffRmuon (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffRstrange (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffRtau (const double pol_e, const double pol_p, const double s) const |
const double | eeffsigma (const Particle f, const double pol_e, const double pol_p, const double s, const double cosmin, const double cosmax) const |
virtual const double | eeffsigmaBottom (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffsigmaCharm (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffsigmaE (const double pol_e, const double pol_p, const double s) const |
const double | eeffsigmaEbin (const double pol_e, const double pol_p, const double s, const double cosmin, const double cosmax) const |
virtual const double | eeffsigmaEtsub (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffsigmaHadron (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffsigmaMu (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffsigmaStrange (const double pol_e, const double pol_p, const double s) const |
virtual const double | eeffsigmaTau (const double pol_e, const double pol_p, const double s) const |
virtual const double | epsilon1 () const |
The SM contribution to the epsilon parameter \(\varepsilon_1\). More... | |
virtual const double | epsilon2 () const |
The SM contribution to the epsilon parameter \(\varepsilon_2\). More... | |
virtual const double | epsilon3 () const |
The SM contribution to the epsilon parameter \(\varepsilon_3\). More... | |
virtual const double | epsilonb () const |
The SM contribution to the epsilon parameter \(\varepsilon_b\). More... | |
gslpp::complex | f_triangle (const double tau) const |
Loop function entering in the calculation of the effective \(Hgg\) and \(H\gamma\gamma\) couplings. More... | |
gslpp::complex | g_triangle (const double tau) const |
Loop function entering in the calculation of the effective \(HZ\gamma\) coupling. More... | |
virtual const gslpp::complex | gA_f (const Particle f) const |
The effective leptonic neutral-current axial-vector coupling \(g_A^l\) in the SM. More... | |
virtual const double | Gamma_had () const |
The hadronic decay width of the \(Z\) boson, \(\Gamma_{h}\). More... | |
virtual const double | Gamma_inv () const |
The invisible partial decay width of the \(Z\) boson, \(\Gamma_{\mathrm{inv}}\). More... | |
virtual const double | Gamma_muon () const |
The computation of the muon decay. More... | |
virtual const double | Gamma_tau_l_nunu (const Particle l) const |
The computation of the leptonic tau decays. More... | |
virtual const double | Gamma_Z () const |
The total decay width of the \(Z\) boson, \(\Gamma_Z\). More... | |
virtual const double | GammaHtobb () const |
The \(\Gamma(H\to b \bar{b})\) in the Standard Model. More... | |
virtual const double | GammaHtocc () const |
The \(\Gamma(H\to c \bar{c})\) in the Standard Model. More... | |
virtual const double | GammaHtogaga () const |
The \(\Gamma(H\to \gamma \gamma)\) in the Standard Model. More... | |
virtual const double | GammaHtogg () const |
The \(\Gamma(H\to gg)\) in the Standard Model. More... | |
virtual const double | GammaHtomumu () const |
The \(\Gamma(H\to \mu^+ \mu^-)\) in the Standard Model. More... | |
virtual const double | GammaHtoss () const |
The \(\Gamma(H\to s \bar{s})\) in the Standard Model. More... | |
virtual const double | GammaHTot () const |
The total Higgs width \(\Gamma(H)\) in the Standard Model. More... | |
virtual const double | GammaHtotautau () const |
The \(\Gamma(H\to \tau^+ \tau^-)\) in the Standard Model. More... | |
virtual const double | GammaHtoWWstar () const |
The \(\Gamma(H\to W W^*)\) in the Standard Model. More... | |
virtual const double | GammaHtoZga () const |
The \(\Gamma(H\to Z \gamma)\) in the Standard Model. More... | |
virtual const double | GammaHtoZZstar () const |
The \(\Gamma(H\to Z Z^*)\) in the Standard Model. More... | |
virtual const double | GammaW () const |
The total width of the \(W\) boson, \(\Gamma_W\). More... | |
virtual const double | GammaW (const Particle fi, const Particle fj) const |
A partial decay width of the \(W\) boson decay into a SM fermion pair. More... | |
virtual const double | GammaZ (const Particle f) const |
The \(Z\to \ell\bar{\ell}\) partial decay width, \(\Gamma_\ell\). More... | |
virtual const double | gAnue () const |
The effective (muon) neutrino-electron axial-vector coupling: gAnue. More... | |
const double | getAle () const |
A get method to retrieve the fine-structure constant \(\alpha\). More... | |
const double | getAlsMz () const |
A get method to access the value of \(\alpha_s(M_Z)\). More... | |
virtual const double | getCBd () const |
The ratio of the absolute value of the $B_d$ mixing amplitude over the Standard Model value. More... | |
virtual const double | getCBs () const |
The ratio of the absolute value of the $B_s$ mixing amplitude over the Standard Model value. More... | |
virtual const double | getCCC1 () const |
A virtual implementation for the RealWeakEFTCC class. More... | |
virtual const double | getCCC2 () const |
A virtual implementation for the RealWeakEFTCC class. More... | |
virtual const double | getCCC3 () const |
A virtual implementation for the RealWeakEFTCC class. More... | |
virtual const double | getCCC4 () const |
A virtual implementation for the RealWeakEFTCC class. More... | |
virtual const double | getCCC5 () const |
A virtual implementation for the RealWeakEFTCC class. More... | |
virtual const double | getCDMK () const |
The ratio of the real part of the $K$ mixing amplitude over the Standard Model value. More... | |
virtual const double | getCepsK () const |
The ratio of the imaginary part of the $K$ mixing amplitude over the Standard Model value. More... | |
const CKM & | getCKM () const |
A get method to retrieve the member object of type CKM. More... | |
const double | getDAle5Mz () const |
A get method to retrieve the five-flavour hadronic contribution to the electromagnetic coupling, \(\Delta\alpha_{\mathrm{had}}^{(5)}(M_Z^2)\). More... | |
const double | getDelGammaZ () const |
A get method to retrieve the theoretical uncertainty in \(\Gamma_Z\), denoted as \(\delta\,\Gamma_Z\). More... | |
const double | getDelMw () const |
A get method to retrieve the theoretical uncertainty in \(M_W\), denoted as \(\delta\,M_W\). More... | |
const double | getDelR0b () const |
A get method to retrieve the theoretical uncertainty in \(R_b^0\), denoted as \(\delta\,R_b^0\). More... | |
const double | getDelR0c () const |
A get method to retrieve the theoretical uncertainty in \(R_c^0\), denoted as \(\delta\,R_c^0\). More... | |
const double | getDelR0l () const |
A get method to retrieve the theoretical uncertainty in \(R_l^0\), denoted as \(\delta\,R_l^0\). More... | |
const double | getDelSigma0H () const |
A get method to retrieve the theoretical uncertainty in \(\sigma_{Hadron}^0\), denoted as \(\delta\,\sigma_{Hadron}^0\). More... | |
const double | getDelSin2th_b () const |
A get method to retrieve the theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{b}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{b}\). More... | |
const double | getDelSin2th_l () const |
A get method to retrieve the theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{\rm lept}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{\rm lept}\). More... | |
const double | getDelSin2th_q () const |
A get method to retrieve the theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{q\not = b,t}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{q\not = b,t}\). More... | |
const std::string | getFlagKappaZ () const |
A method to retrieve the model flag KappaZ. More... | |
const std::string | getFlagMw () const |
A method to retrieve the model flag Mw. More... | |
const std::string | getFlagRhoZ () const |
A method to retrieve the model flag RhoZ. More... | |
const Flavour & | getFlavour () const |
const double | getGF () const |
A get method to retrieve the Fermi constant \(G_\mu\). More... | |
const int | getIterationNo () const |
const Particle & | getLeptons (const QCD::lepton p) const |
A get method to retrieve the member object of a lepton. More... | |
virtual StandardModelMatching & | getMatching () const |
A get method to access the member reference of type StandardModelMatching. More... | |
virtual const double | getMHl () const |
A get method to retrieve the Higgs mass \(m_h\). More... | |
virtual const double | getmq (const QCD::quark q, const double mu) const |
The MSbar running quark mass computed at NLO. More... | |
const double | getMuw () const |
A get method to retrieve the matching scale \(\mu_W\) around the weak scale. More... | |
const double | getMw () const |
A get method to access the input value of the mass of the \(W\) boson \(M_W\). More... | |
EWSMApproximateFormulae * | getMyApproximateFormulae () const |
A get method to retrieve the member pointer of type EWSMApproximateFormulae. More... | |
EWSMcache * | getMyEWSMcache () const |
A get method to retrieve the member pointer of type EWSMcache. More... | |
LeptonFlavour * | getMyLeptonFlavour () const |
EWSMOneLoopEW * | getMyOneLoopEW () const |
A get method to retrieve the member pointer of type EWSMOneLoopEW,. More... | |
EWSMThreeLoopEW * | getMyThreeLoopEW () const |
EWSMThreeLoopEW2QCD * | getMyThreeLoopEW2QCD () const |
EWSMThreeLoopQCD * | getMyThreeLoopQCD () const |
EWSMTwoFermionsLEP2 * | getMyTwoFermionsLEP2 () const |
A get method to retrieve the member pointer of type EWSMTwoFermionsLEP2. More... | |
EWSMTwoLoopEW * | getMyTwoLoopEW () const |
EWSMTwoLoopQCD * | getMyTwoLoopQCD () const |
const double | getMz () const |
A get method to access the mass of the \(Z\) boson \(M_Z\). More... | |
virtual const double | getPhiBd () const |
Half the relative phase of the $B_d$ mixing amplitude w.r.t. the Standard Model one. More... | |
virtual const double | getPhiBs () const |
Half the relative phase of the $B_s$ mixing amplitude w.r.t. the Standard Model one. More... | |
virtual const StandardModel & | getTrueSM () const |
const gslpp::matrix< gslpp::complex > | getUPMNS () const |
A get method to retrieve the object of the PMNS matrix. More... | |
const gslpp::matrix< gslpp::complex > | getVCKM () const |
A get method to retrieve the CKM matrix. More... | |
const gslpp::matrix< gslpp::complex > & | getYd () const |
A get method to retrieve the Yukawa matrix of the down-type quarks, \(Y_d\). More... | |
const gslpp::matrix< gslpp::complex > & | getYe () const |
A get method to retrieve the Yukawa matrix of the charged leptons, \(Y_e\). More... | |
const gslpp::matrix< gslpp::complex > & | getYn () const |
A get method to retrieve the Yukawa matrix of the neutrinos, \(Y_\nu\). More... | |
const gslpp::matrix< gslpp::complex > & | getYu () const |
A get method to retrieve the Yukawa matrix of the up-type quarks, \(Y_u\). More... | |
virtual const double | gLnuN2 () const |
The effective neutrino nucleon LH coupling: gLnuN2. More... | |
virtual const double | gRnuN2 () const |
The effective neutrino nucleon RH coupling: gRnuN2. More... | |
virtual const gslpp::complex | gV_f (const Particle f) const |
The effective leptonic neutral-current vector coupling \(g_V^l\) in the SM. More... | |
virtual const double | gVnue () const |
The effective (muon) neutrino-electron vector coupling: gVnue. More... | |
gslpp::complex | I_triangle_1 (const double tau, const double lambda) const |
Loop function entering in the calculation of the effective \(HZ\gamma\) coupling. More... | |
gslpp::complex | I_triangle_2 (const double tau, const double lambda) const |
Loop function entering in the calculation of the effective \(HZ\gamma\) coupling. More... | |
virtual bool | Init (const std::map< std::string, double > &DPars) |
A method to initialize the model parameters. More... | |
virtual bool | InitializeModel () |
A method to initialize the model. More... | |
const double | intMLL2eeeeus2 (const double s, const double t0, const double t1) const |
const double | intMLR2eeeets2 (const double s, const double t0, const double t1) const |
const double | intMLRtilde2eeeest2 (const double s, const double t0, const double t1) const |
const double | intMRR2eeeeus2 (const double s, const double t0, const double t1) const |
const bool | IsFlagNoApproximateGammaZ () const |
A method to retrieve the model flag NoApproximateGammaZ. More... | |
const bool | IsFlagWithoutNonUniversalVC () const |
A method to retrieve the model flag WithoutNonUniversalVC. More... | |
const bool | isSMSuccess () const |
A get method to retrieve the success status of the Standard Model update and matching. More... | |
virtual const gslpp::complex | kappaZ_f (const Particle f) const |
The effective leptonic neutral-current coupling \(\kappa_Z^l\) in the SM. More... | |
virtual const double | LEP2AFBbottom (const double s) const |
virtual const double | LEP2AFBcharm (const double s) const |
virtual const double | LEP2AFBe (const double s) const |
virtual const double | LEP2AFBmu (const double s) const |
virtual const double | LEP2AFBtau (const double s) const |
virtual const double | LEP2dsigmadcosBinE (const double s, const double cos, const double cosmin, const double cosmax) const |
virtual const double | LEP2dsigmadcosBinMu (const double s, const double cos, const double cosmin, const double cosmax) const |
virtual const double | LEP2dsigmadcosBinTau (const double s, const double cos, const double cosmin, const double cosmax) const |
virtual const double | LEP2dsigmadcosE (const double s, const double cos) const |
virtual const double | LEP2dsigmadcosMu (const double s, const double cos) const |
virtual const double | LEP2dsigmadcosTau (const double s, const double cos) const |
virtual const double | LEP2Rbottom (const double s) const |
virtual const double | LEP2Rcharm (const double s) const |
virtual const double | LEP2sigmaBottom (const double s) const |
virtual const double | LEP2sigmaCharm (const double s) const |
virtual const double | LEP2sigmaE (const double s) const |
virtual const double | LEP2sigmaHadron (const double s) const |
virtual const double | LEP2sigmaMu (const double s) const |
virtual const double | LEP2sigmaTau (const double s) const |
const double | MLL2eeff (const Particle f, const double s, const double t) const |
const double | MLR2eeff (const Particle f, const double s) const |
const double | MRL2eeff (const Particle f, const double s) const |
const double | MRR2eeff (const Particle f, const double s, const double t) const |
virtual const double | Mw () const |
The SM prediction for the \(W\)-boson mass in the on-shell scheme, \(M_{W,\mathrm{SM}}\). More... | |
const double | Mw_tree () const |
The tree-level mass of the \(W\) boson, \(M_W^{\mathrm{tree}}\). More... | |
const double | MwbarFromMw (const double Mw) const |
A method to convert the \(W\)-boson mass in the experimental/running-width scheme to that in the complex-pole/fixed-width scheme. More... | |
const double | MwFromMwbar (const double Mwbar) const |
A method to convert the \(W\)-boson mass in the complex-pole/fixed-width scheme to that in the experimental/running-width scheme. More... | |
double | Mzbar () const |
The \(Z\)-boson mass \(\overline{M}_Z\) in the complex-pole/fixed-width scheme. More... | |
virtual const double | N_nu () const |
The number of neutrinos obtained indirectly from the measurements at the Z pole, \(N_{\nu}\). More... | |
virtual bool | PostUpdate () |
The post-update method for StandardModel. More... | |
virtual bool | PreUpdate () |
The pre-update method for StandardModel. More... | |
virtual const double | Qwemoller (const double q2, const double y) const |
The computation of the electron's weak charge. More... | |
virtual const double | Qwn () const |
The computation of the neutron weak charge: Qwn. More... | |
virtual const double | Qwp () const |
The computation of the proton weak charge: Qwp. More... | |
virtual const double | R0_f (const Particle f) const |
The ratio \(R_\ell^0=\Gamma(Z\to {\rm hadrons})/\Gamma(Z\to \ell^+ \ell^-)\). More... | |
virtual const double | R_inv () const |
The ratio of the invisible and leptonic (electron) decay widths of the \(Z\) boson, \(R_{inv}\). More... | |
virtual const double | rho_GammaW (const Particle fi, const Particle fj) const |
EW radiative corrections to the width of \(W \to f_i \bar{f}_j\), denoted as \(\rho^W_{ij}\). More... | |
virtual const gslpp::complex | rhoZ_f (const Particle f) const |
The effective leptonic neutral-current coupling \(\rho_Z^l\) in the SM. More... | |
virtual const double | Ruc () const |
virtual const double | RWc () const |
The ratio \(R_{W,c)=\Gamma(W\to c + X)/\Gamma(W\to had)\). More... | |
virtual const double | RWlilj (const Particle li, const Particle lj) const |
The lepton universality ratio \(R_{W,l_i/l_j)=\Gamma(W\to l_i \nu_i)/\Gamma(W\to l_j \nu_j)\). More... | |
virtual const double | RZlilj (const Particle li, const Particle lj) const |
The lepton universality ratio \(R_{Z,l_i/l_j)=\Gamma(Z\to l_i^+ l_i^-)/\Gamma(Z\to l_j^+ l_j^-)\). More... | |
const double | s02 () const |
The square of the sine of the weak mixing angle \(s_0^2\) defined without weak radiative corrections. More... | |
void | setCKM (const CKM &CKMMatrix) |
A set method to change the CKM matrix. More... | |
virtual bool | setFlag (const std::string name, const bool value) |
A method to set a flag of StandardModel. More... | |
void | setFlagCacheInStandardModel (bool FlagCacheInStandardModel) |
A set method to change the model flag CacheInStandardModel of StandardModel. More... | |
void | setFlagNoApproximateGammaZ (bool FlagNoApproximateGammaZ) |
bool | setFlagSigmaForAFB (const bool flagSigmaForAFB_i) |
bool | setFlagSigmaForR (const bool flagSigmaForR_i) |
virtual bool | setFlagStr (const std::string name, const std::string value) |
A method to set a flag of StandardModel. More... | |
void | setRequireCKM (bool requireCKM) |
A set method to change the value of requireCKM. More... | |
void | setSMSuccess (bool success) const |
A set method to change the success status of the Standard Model update and matching. More... | |
void | setYd (const gslpp::matrix< gslpp::complex > &Yd) |
A set method to set the Yukawa matrix of the down-type quarks, \(Y_d\). More... | |
void | setYe (const gslpp::matrix< gslpp::complex > &Ye) |
A set method to set the Yukawa matrix of the charged leptons, \(Y_e\). More... | |
void | setYu (const gslpp::matrix< gslpp::complex > &Yu) |
A set method to set the Yukawa matrix of the up-type quarks, \(Y_u\). More... | |
virtual const double | sigma0_had () const |
The hadronic cross section for \(e^+e^- \to Z \to \mathrm{hadrons}\) at the \(Z\)-pole, \(\sigma_h^0\). More... | |
virtual const double | SigmaeeHee (const double sqrt_s, const double Pe, const double Pp) const |
The \(\sigma(e^+ e^- \to e^+ e^- H)\) in the Standard Model. More... | |
virtual const double | SigmaeeHvv (const double sqrt_s, const double Pe, const double Pp) const |
The \(\sigma(e^+ e^- \to \nu \bar{\nu} H)\) in the Standard Model. More... | |
virtual const double | SigmaeeZH (const double sqrt_s, const double Pe, const double Pp) const |
The \(\sigma(e^+ e^- \to Z H)\) in the Standard Model. More... | |
virtual const double | sin2thetaEff (const Particle f) const |
The effective weak mixing angle \(\sin^2\theta_{\rm eff}^{\,\ell}\) for \(Z\ell\bar{\ell}\) at the the \(Z\)-mass scale. More... | |
StandardModel () | |
The default constructor. More... | |
const double | sW2 () const |
virtual const double | sW2 (const double Mw_i) const |
The square of the sine of the weak mixing angle in the on-shell scheme, denoted as \(s_W^2\). More... | |
const double | sW2_MSbar_Approx () const |
The (approximated formula for the) square of the sine of the weak mixing angle in the MSbar scheme, denoted as \(\hat{s}_{W}^2\). See: PDG 22, R.L. Workman et al. (Particle Data Group), Prog. Theor. Exp. Phys. 2022, 083C01 (2022) More... | |
const double | sW2_ND () const |
The square of the sine of the weak mixing angle in the MSbar-ND scheme (w/o decoupling $\alpha\ln(m_t/M_Z)$ terms), denoted as \(\hat{s}_{ND}^2\). See: PDG 22, R.L. Workman et al. (Particle Data Group), Prog. Theor. Exp. Phys. 2022, 083C01 (2022) (eq. 10.13a/10.13b) More... | |
virtual const double | TauLFU_gmuge () const |
The computation of the LFU ratio \(g_\mu/ g_e \). More... | |
virtual const double | TauLFU_gtauge () const |
The computation of the LFU ratio \(g_\tau/ g_e \). More... | |
virtual const double | TauLFU_gtaugmu () const |
The computation of the LFU ratio \(g_\tau/ g_\mu \). More... | |
virtual const double | TauLFU_gtaugmuK () const |
The computation of the LFU ratio \(\left(g_\tau/ g_\mu\right)_K \). More... | |
virtual const double | TauLFU_gtaugmuPi () const |
The computation of the LFU ratio \(\left(g_\tau/ g_\mu\right)_\pi \). More... | |
virtual const double | ThetaLnuN () const |
The effective neutrino nucleon LH parameter: ThetaLnuN. More... | |
virtual const double | ThetaRnuN () const |
The effective neutrino nucleon RH parameter: ThetaRnuN. More... | |
const double | tovers2 (const double cosmin, const double cosmax) const |
const double | uovers2 (const double cosmin, const double cosmax) const |
virtual bool | Update (const std::map< std::string, double > &DPars) |
The update method for StandardModel. More... | |
const double | v () const |
The Higgs vacuum expectation value. More... | |
virtual | ~StandardModel () |
The default destructor. More... | |
![]() | |
const double | AboveTh (const double mu) const |
The active flavour threshold above the scale \(\mu\) as defined in QCD::Thresholds(). More... | |
void | addParameters (std::vector< std::string > params_i) |
A method to add parameters that are specific to only one set of observables. More... | |
const double | Als (const double mu, const int Nf_in, const orders order=FULLNLO) const |
Computes the running strong coupling \(\alpha_s(\mu)\) with \(N_f\) active flavours in the \(\overline{\mathrm{MS}}\) scheme. In the cases of LO, NLO and FULLNLO, the coupling is computed with AlsWithInit(). On the other hand, in the cases of NNLO and FULLNNLO, the coupling is computed with AlsWithLambda(). More... | |
const double | Als (const double mu, const orders order=FULLNLO, const bool Nf_thr=true) const |
const double | Als4 (const double mu) const |
The value of \(\alpha_s^{\mathrm{FULLNLO}}\) at any scale \(\mu\) with the number of flavours \(n_f = 4\). More... | |
const double | AlsByOrder (const double mu, const int Nf_in, const orders order=FULLNLO) const |
const double | AlsByOrder (const double mu, const orders order=FULLNLO, bool Nf_thr=true) const |
const double | AlsOLD (const double mu, const orders order=FULLNLO) const |
Computes the running strong coupling \(\alpha_s(\mu)\) in the \(\overline{\mathrm{MS}}\) scheme. In the cases of LO, NLO and FULLNNLO, the coupling is computed with AlsWithInit(). On the other hand, in the cases of NNLO and FULLNNLO, the coupling is computed with AlsWithLambda(). More... | |
const double | AlsWithInit (const double mu, const double alsi, const double mu_i, const int nf, const orders order) const |
Computes the running strong coupling \(\alpha_s(\mu)\) from \(\alpha_s(\mu_i)\) in the \(\overline{\mathrm{MS}}\) scheme, where it is forbidden to across a flavour threshold in the RG running from \(\mu_i\) to \(\mu\). More... | |
const double | AlsWithLambda (const double mu, const orders order) const |
Computes the running strong coupling \(\alpha_s(\mu)\) in the \(\overline{\mathrm{MS}}\) scheme with the use of \(\Lambda_{\rm QCD}\). More... | |
const double | BelowTh (const double mu) const |
The active flavour threshold below the scale \(\mu\) as defined in QCD::Thresholds(). More... | |
const double | Beta0 (const double nf) const |
The \(\beta_0(n_f)\) coefficient for a certain number of flavours \(n_f\). More... | |
const double | Beta1 (const double nf) const |
The \(\beta_1(n_f)\) coefficient for a certain number of flavours \(n_f\). More... | |
const double | Beta2 (const double nf) const |
The \(\beta_2(n_f)\) coefficient for a certain number of flavours \(n_f\). More... | |
const double | Beta3 (const double nf) const |
The \(\beta_3(n_f)\) coefficient for a certain number of flavours \(n_f\). More... | |
void | CacheShift (double cache[][5], int n) const |
A member used to manage the caching for this class. More... | |
void | CacheShift (int cache[][5], int n) const |
const orders | FullOrder (orders order) const |
Return the FULLORDER enum corresponding to order. More... | |
const double | Gamma0 (const double nf) const |
The \(\gamma_0\) coefficient used to compute the running of a mass. More... | |
const double | Gamma1 (const double nf) const |
The \(\gamma_1\) coefficient used to compute the running of a mass. More... | |
const double | Gamma2 (const double nf) const |
The \(\gamma_2\) coefficient used to compute the running of a mass. More... | |
const double | getAlsM () const |
A get method to access the value of \(\alpha_s(M_{\alpha_s})\). More... | |
const BParameter & | getBBd () const |
For getting the bag parameters corresponding to the operator basis \(O_1 -O_5\) in \(\Delta b = 2\) process in the \(B_d\) meson system. More... | |
const BParameter & | getBBd_subleading () const |
For getting the subleading bag parameters \(R_2 - R_3\) in \(\Delta b = 2\) process in the \(B_d\) meson system. More... | |
const BParameter & | getBBs () const |
For getting the bag parameters corresponding to the operator basis \(O_1 -O_5\) in \(\Delta b = 2\) process in the \(B_s\) meson system. More... | |
const BParameter & | getBBs_subleading () const |
For getting the subleading bag parameters \(R_2 - R_3\) in \(\Delta b = 2\) process in the \(B_s\) meson system. More... | |
const BParameter & | getBD () const |
For getting the bag parameters corresponding to the operator basis \(O_1 -O_5\) in \(\Delta c = 2\) process in the \(D^0\) meson system. More... | |
const BParameter & | getBK () const |
For getting the bag parameters corresponding to the operator basis \(O_1 -O_5\) in \(\Delta s = 2\) process in the \(K^0\) meson system. More... | |
const BParameter & | getBKd1 () const |
const BParameter & | getBKd3 () const |
const double | getCF () const |
A get method to access the Casimir factor of QCD. More... | |
const double | getMAls () const |
A get method to access the mass scale \(M_{\alpha_s}\) at which the strong coupling constant measurement is provided. More... | |
const Meson & | getMesons (const QCD::meson m) const |
A get method to access a meson as an object of the type Meson. More... | |
const double | getMtpole () const |
A get method to access the pole mass of the top quark. More... | |
const double | getMub () const |
A get method to access the threshold between five- and four-flavour theory in GeV. More... | |
const double | getMuc () const |
A get method to access the threshold between four- and three-flavour theory in GeV. More... | |
const double | getMut () const |
A get method to access the threshold between six- and five-flavour theory in GeV. More... | |
const double | getNc () const |
A get method to access the number of colours \(N_c\). More... | |
const double | getOptionalParameter (std::string name) const |
A method to get parameters that are specific to only one set of observables. More... | |
const Particle & | getQuarks (const QCD::quark q) const |
A get method to access a quark as an object of the type Particle. More... | |
std::vector< std::string > | getUnknownParameters () |
A method to get the vector of the parameters that have been specified in the configuration file but not being used. More... | |
void | initializeBParameter (std::string name_i) const |
A method to initialize B Parameter and the corresponding meson. More... | |
void | initializeMeson (QCD::meson meson_i) const |
A method to initialize a meson. More... | |
bool | isQCDsuccess () const |
A getter for the QCDsuccess flag. More... | |
const double | logLambda (const double nf, orders order) const |
Computes \(\ln\Lambda_\mathrm{QCD}\) with nf flavours in GeV. More... | |
const double | Mbar2Mp (const double mbar, const quark q, const orders order=FULLNNLO) const |
Converts the \(\overline{\mathrm{MS}}\) mass \(m(m)\) to the pole mass. More... | |
const double | Mofmu2Mbar (const double m, const double mu, const quark q) const |
Converts a quark running mass at an arbitrary scale to the corresponding \(\overline{\mathrm{MS}}\) mass \(m(m)\). More... | |
const double | Mp2Mbar (const double mp, const quark q, orders order=FULLNNLO) const |
Converts a quark pole mass to the corresponding \(\overline{\mathrm{MS}}\) mass \(m(m)\). More... | |
const double | Mrun (const double mu, const double m, const quark q, const orders order=FULLNNLO) const |
Computes a running quark mass \(m(\mu)\) from \(m(m)\). More... | |
const double | Mrun (const double mu_f, const double mu_i, const double m, const quark q, const orders order=FULLNNLO) const |
Runs a quark mass from \(\mu_i\) to \(\mu_f\). More... | |
const double | Mrun4 (const double mu_f, const double mu_i, const double m) const |
The running of a mass with the number of flavours \(n_f = 4\). More... | |
const double | MS2DRqmass (const double MSbar) const |
Converts a quark mass from the \(\overline{\mathrm{MS}}\) scheme to the \(\overline{\mathrm{DR}}\) scheme. More... | |
const double | MS2DRqmass (const double MSscale, const double MSbar) const |
Converts a quark mass from the \(\overline{\mathrm{MS}}\) scheme to the \(\overline{\mathrm{DR}}\) scheme. More... | |
const double | Nf (const double mu) const |
The number of active flavour at scale \(\mu\). More... | |
const double | NfThresholdCorrections (double mu, double M, double als, int nf, orders order) const |
Threshold corrections in matching \(\alpha_s(n_f+1)\) with \(\alpha_s(n_f)\) from eq. (34) of hep-ph/0512060. More... | |
const std::string | orderToString (const orders order) const |
Converts an object of the enum type "orders" to the corresponding string. More... | |
QCD () | |
Constructor. More... | |
void | setComputemt (bool computemt) |
A set method to change the value of computemt. More... | |
void | setMtpole (double mtpole_in) |
A method to set the pole mass of the top quark. More... | |
void | setNc (double Nc) |
A set method to change the number of colours \(N_c\). More... | |
void | setOptionalParameter (std::string name, double value) |
A method to set the parameter value for the parameters that are specific to only one set of observables. More... | |
void | setQuarkMass (const quark q, const double mass) |
A set method to change the mass of a quark. More... | |
const double | Thresholds (const int i) const |
For accessing the active flavour threshold scales. More... | |
![]() | |
void | addMissingModelParameter (const std::string &missingParameterName) |
std::vector< std::string > | getmissingModelParameters () |
unsigned int | getMissingModelParametersCount () |
std::string | getModelName () const |
A method to fetch the name of the model. More... | |
const double & | getModelParam (std::string name) const |
bool | isModelFWC_DF2 () const |
bool | isModelGeneralTHDM () const |
bool | isModelGeorgiMachacek () const |
bool | IsModelInitialized () const |
A method to check if the model is initialized. More... | |
bool | isModelLinearized () const |
bool | isModelNPquadratic () const |
bool | isModelParam (std::string name) const |
bool | isModelSUSY () const |
bool | isModelTHDM () const |
bool | isModelTHDMW () const |
bool | IsUpdateError () const |
A method to check if there was any error in the model update process. More... | |
Model () | |
The default constructor. More... | |
void | raiseMissingModelParameterCount () |
void | setModelFWC_DF2 () |
void | setModelGeneralTHDM () |
void | setModelGeorgiMachacek () |
void | setModelInitialized (bool ModelInitialized) |
A set method to fix the failure or success of the initialization of the model. More... | |
void | setModelLinearized (bool linearized=true) |
void | setModelName (const std::string name) |
A method to set the name of the model. More... | |
void | setModelNPquadratic (bool NPquadratic=true) |
void | setModelSUSY () |
void | setModelTHDM () |
void | setModelTHDMW () |
void | setSliced (bool Sliced) |
void | setUpdateError (bool UpdateError) |
A set method to fix the update status as success or failure. More... | |
virtual | ~Model () |
The default destructor. More... | |
Static Public Attributes | |
static const double | GeVminus2_to_nb = 389379.338 |
static const double | Mw_error = 0.00001 |
The target accuracy of the iterative calculation of the \(W\)-boson mass in units of GeV. More... | |
static const int | NSMvars = 26 |
The number of the model parameters in StandardModel. More... | |
static const int | NumSMParamsForEWPO = 33 |
The number of the SM parameters that are relevant to the EW precision observables. More... | |
static std::string | SMvars [NSMvars] |
A string array containing the labels of the model parameters in StandardModel. More... | |
![]() | |
static const int | NQCDvars = 11 |
The number of model parameters in QCD. More... | |
static std::string | QCDvars [NQCDvars] |
An array containing the labels under which all QCD parameters are stored in a vector of ModelParameter via InputParser::ReadParameters(). More... | |
Protected Member Functions | |
const double | AFB_NoISR_l (const QCD::lepton l_flavor, const double s) const |
const double | AFB_NoISR_q (const QCD::quark q_flavor, const double s) const |
bool | checkEWPOscheme (const std::string scheme) const |
A method to check if a given scheme name in string form is valid. More... | |
virtual void | computeCKM () |
The method to compute the CKM matrix. More... | |
virtual void | computeYukawas () |
The method to compute the Yukawas matrix. More... | |
double | Delta_EWQCD (const QCD::quark q) const |
The non-factorizable EW-QCD corrections to the partial widths for \(Z\to q\bar{q}\), denoted as \(\Delta_{\mathrm{EW/QCD}}\). More... | |
const double | getIntegrand_AFBnumeratorWithISR_bottom133 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom167 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom172 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom183 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom189 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom192 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom196 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom200 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom202 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom205 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_bottom207 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm133 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm167 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm172 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm183 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm189 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm192 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm196 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm200 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm202 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm205 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_charm207 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu130 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu136 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu161 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu172 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu183 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu189 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu192 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu196 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu200 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu202 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu205 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_mu207 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau130 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau136 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau161 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau172 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau183 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau189 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau192 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau196 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau200 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau202 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau205 (double x) const |
const double | getIntegrand_AFBnumeratorWithISR_tau207 (double x) const |
const double | getIntegrand_dsigmaBox_bottom130 (double x) const |
const double | getIntegrand_dsigmaBox_bottom133 (double x) const |
const double | getIntegrand_dsigmaBox_bottom136 (double x) const |
const double | getIntegrand_dsigmaBox_bottom161 (double x) const |
const double | getIntegrand_dsigmaBox_bottom167 (double x) const |
const double | getIntegrand_dsigmaBox_bottom172 (double x) const |
const double | getIntegrand_dsigmaBox_bottom183 (double x) const |
const double | getIntegrand_dsigmaBox_bottom189 (double x) const |
const double | getIntegrand_dsigmaBox_bottom192 (double x) const |
const double | getIntegrand_dsigmaBox_bottom196 (double x) const |
const double | getIntegrand_dsigmaBox_bottom200 (double x) const |
const double | getIntegrand_dsigmaBox_bottom202 (double x) const |
const double | getIntegrand_dsigmaBox_bottom205 (double x) const |
const double | getIntegrand_dsigmaBox_bottom207 (double x) const |
const double | getIntegrand_dsigmaBox_charm130 (double x) const |
const double | getIntegrand_dsigmaBox_charm133 (double x) const |
const double | getIntegrand_dsigmaBox_charm136 (double x) const |
const double | getIntegrand_dsigmaBox_charm161 (double x) const |
const double | getIntegrand_dsigmaBox_charm167 (double x) const |
const double | getIntegrand_dsigmaBox_charm172 (double x) const |
const double | getIntegrand_dsigmaBox_charm183 (double x) const |
const double | getIntegrand_dsigmaBox_charm189 (double x) const |
const double | getIntegrand_dsigmaBox_charm192 (double x) const |
const double | getIntegrand_dsigmaBox_charm196 (double x) const |
const double | getIntegrand_dsigmaBox_charm200 (double x) const |
const double | getIntegrand_dsigmaBox_charm202 (double x) const |
const double | getIntegrand_dsigmaBox_charm205 (double x) const |
const double | getIntegrand_dsigmaBox_charm207 (double x) const |
const double | getIntegrand_dsigmaBox_down130 (double x) const |
const double | getIntegrand_dsigmaBox_down133 (double x) const |
const double | getIntegrand_dsigmaBox_down136 (double x) const |
const double | getIntegrand_dsigmaBox_down161 (double x) const |
const double | getIntegrand_dsigmaBox_down167 (double x) const |
const double | getIntegrand_dsigmaBox_down172 (double x) const |
const double | getIntegrand_dsigmaBox_down183 (double x) const |
const double | getIntegrand_dsigmaBox_down189 (double x) const |
const double | getIntegrand_dsigmaBox_down192 (double x) const |
const double | getIntegrand_dsigmaBox_down196 (double x) const |
const double | getIntegrand_dsigmaBox_down200 (double x) const |
const double | getIntegrand_dsigmaBox_down202 (double x) const |
const double | getIntegrand_dsigmaBox_down205 (double x) const |
const double | getIntegrand_dsigmaBox_down207 (double x) const |
const double | getIntegrand_dsigmaBox_mu130 (double x) const |
const double | getIntegrand_dsigmaBox_mu133 (double x) const |
const double | getIntegrand_dsigmaBox_mu136 (double x) const |
const double | getIntegrand_dsigmaBox_mu161 (double x) const |
const double | getIntegrand_dsigmaBox_mu167 (double x) const |
const double | getIntegrand_dsigmaBox_mu172 (double x) const |
const double | getIntegrand_dsigmaBox_mu183 (double x) const |
const double | getIntegrand_dsigmaBox_mu189 (double x) const |
const double | getIntegrand_dsigmaBox_mu192 (double x) const |
const double | getIntegrand_dsigmaBox_mu196 (double x) const |
const double | getIntegrand_dsigmaBox_mu200 (double x) const |
const double | getIntegrand_dsigmaBox_mu202 (double x) const |
const double | getIntegrand_dsigmaBox_mu205 (double x) const |
const double | getIntegrand_dsigmaBox_mu207 (double x) const |
const double | getIntegrand_dsigmaBox_strange130 (double x) const |
const double | getIntegrand_dsigmaBox_strange133 (double x) const |
const double | getIntegrand_dsigmaBox_strange136 (double x) const |
const double | getIntegrand_dsigmaBox_strange161 (double x) const |
const double | getIntegrand_dsigmaBox_strange167 (double x) const |
const double | getIntegrand_dsigmaBox_strange172 (double x) const |
const double | getIntegrand_dsigmaBox_strange183 (double x) const |
const double | getIntegrand_dsigmaBox_strange189 (double x) const |
const double | getIntegrand_dsigmaBox_strange192 (double x) const |
const double | getIntegrand_dsigmaBox_strange196 (double x) const |
const double | getIntegrand_dsigmaBox_strange200 (double x) const |
const double | getIntegrand_dsigmaBox_strange202 (double x) const |
const double | getIntegrand_dsigmaBox_strange205 (double x) const |
const double | getIntegrand_dsigmaBox_strange207 (double x) const |
const double | getIntegrand_dsigmaBox_tau130 (double x) const |
const double | getIntegrand_dsigmaBox_tau133 (double x) const |
const double | getIntegrand_dsigmaBox_tau136 (double x) const |
const double | getIntegrand_dsigmaBox_tau161 (double x) const |
const double | getIntegrand_dsigmaBox_tau167 (double x) const |
const double | getIntegrand_dsigmaBox_tau172 (double x) const |
const double | getIntegrand_dsigmaBox_tau183 (double x) const |
const double | getIntegrand_dsigmaBox_tau189 (double x) const |
const double | getIntegrand_dsigmaBox_tau192 (double x) const |
const double | getIntegrand_dsigmaBox_tau196 (double x) const |
const double | getIntegrand_dsigmaBox_tau200 (double x) const |
const double | getIntegrand_dsigmaBox_tau202 (double x) const |
const double | getIntegrand_dsigmaBox_tau205 (double x) const |
const double | getIntegrand_dsigmaBox_tau207 (double x) const |
const double | getIntegrand_dsigmaBox_up130 (double x) const |
const double | getIntegrand_dsigmaBox_up133 (double x) const |
const double | getIntegrand_dsigmaBox_up136 (double x) const |
const double | getIntegrand_dsigmaBox_up161 (double x) const |
const double | getIntegrand_dsigmaBox_up167 (double x) const |
const double | getIntegrand_dsigmaBox_up172 (double x) const |
const double | getIntegrand_dsigmaBox_up183 (double x) const |
const double | getIntegrand_dsigmaBox_up189 (double x) const |
const double | getIntegrand_dsigmaBox_up192 (double x) const |
const double | getIntegrand_dsigmaBox_up196 (double x) const |
const double | getIntegrand_dsigmaBox_up200 (double x) const |
const double | getIntegrand_dsigmaBox_up202 (double x) const |
const double | getIntegrand_dsigmaBox_up205 (double x) const |
const double | getIntegrand_dsigmaBox_up207 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom130 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom133 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom136 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom161 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom167 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom172 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom183 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom189 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom192 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom196 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom200 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom202 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom205 (double x) const |
const double | getIntegrand_sigmaWithISR_bottom207 (double x) const |
const double | getIntegrand_sigmaWithISR_charm130 (double x) const |
const double | getIntegrand_sigmaWithISR_charm133 (double x) const |
const double | getIntegrand_sigmaWithISR_charm136 (double x) const |
const double | getIntegrand_sigmaWithISR_charm161 (double x) const |
const double | getIntegrand_sigmaWithISR_charm167 (double x) const |
const double | getIntegrand_sigmaWithISR_charm172 (double x) const |
const double | getIntegrand_sigmaWithISR_charm183 (double x) const |
const double | getIntegrand_sigmaWithISR_charm189 (double x) const |
const double | getIntegrand_sigmaWithISR_charm192 (double x) const |
const double | getIntegrand_sigmaWithISR_charm196 (double x) const |
const double | getIntegrand_sigmaWithISR_charm200 (double x) const |
const double | getIntegrand_sigmaWithISR_charm202 (double x) const |
const double | getIntegrand_sigmaWithISR_charm205 (double x) const |
const double | getIntegrand_sigmaWithISR_charm207 (double x) const |
const double | getIntegrand_sigmaWithISR_down130 (double x) const |
const double | getIntegrand_sigmaWithISR_down133 (double x) const |
const double | getIntegrand_sigmaWithISR_down136 (double x) const |
const double | getIntegrand_sigmaWithISR_down161 (double x) const |
const double | getIntegrand_sigmaWithISR_down167 (double x) const |
const double | getIntegrand_sigmaWithISR_down172 (double x) const |
const double | getIntegrand_sigmaWithISR_down183 (double x) const |
const double | getIntegrand_sigmaWithISR_down189 (double x) const |
const double | getIntegrand_sigmaWithISR_down192 (double x) const |
const double | getIntegrand_sigmaWithISR_down196 (double x) const |
const double | getIntegrand_sigmaWithISR_down200 (double x) const |
const double | getIntegrand_sigmaWithISR_down202 (double x) const |
const double | getIntegrand_sigmaWithISR_down205 (double x) const |
const double | getIntegrand_sigmaWithISR_down207 (double x) const |
const double | getIntegrand_sigmaWithISR_mu130 (double x) const |
const double | getIntegrand_sigmaWithISR_mu136 (double x) const |
const double | getIntegrand_sigmaWithISR_mu161 (double x) const |
const double | getIntegrand_sigmaWithISR_mu172 (double x) const |
const double | getIntegrand_sigmaWithISR_mu183 (double x) const |
const double | getIntegrand_sigmaWithISR_mu189 (double x) const |
const double | getIntegrand_sigmaWithISR_mu192 (double x) const |
const double | getIntegrand_sigmaWithISR_mu196 (double x) const |
const double | getIntegrand_sigmaWithISR_mu200 (double x) const |
const double | getIntegrand_sigmaWithISR_mu202 (double x) const |
const double | getIntegrand_sigmaWithISR_mu205 (double x) const |
const double | getIntegrand_sigmaWithISR_mu207 (double x) const |
const double | getIntegrand_sigmaWithISR_strange130 (double x) const |
const double | getIntegrand_sigmaWithISR_strange133 (double x) const |
const double | getIntegrand_sigmaWithISR_strange136 (double x) const |
const double | getIntegrand_sigmaWithISR_strange161 (double x) const |
const double | getIntegrand_sigmaWithISR_strange167 (double x) const |
const double | getIntegrand_sigmaWithISR_strange172 (double x) const |
const double | getIntegrand_sigmaWithISR_strange183 (double x) const |
const double | getIntegrand_sigmaWithISR_strange189 (double x) const |
const double | getIntegrand_sigmaWithISR_strange192 (double x) const |
const double | getIntegrand_sigmaWithISR_strange196 (double x) const |
const double | getIntegrand_sigmaWithISR_strange200 (double x) const |
const double | getIntegrand_sigmaWithISR_strange202 (double x) const |
const double | getIntegrand_sigmaWithISR_strange205 (double x) const |
const double | getIntegrand_sigmaWithISR_strange207 (double x) const |
const double | getIntegrand_sigmaWithISR_tau130 (double x) const |
const double | getIntegrand_sigmaWithISR_tau136 (double x) const |
const double | getIntegrand_sigmaWithISR_tau161 (double x) const |
const double | getIntegrand_sigmaWithISR_tau172 (double x) const |
const double | getIntegrand_sigmaWithISR_tau183 (double x) const |
const double | getIntegrand_sigmaWithISR_tau189 (double x) const |
const double | getIntegrand_sigmaWithISR_tau192 (double x) const |
const double | getIntegrand_sigmaWithISR_tau196 (double x) const |
const double | getIntegrand_sigmaWithISR_tau200 (double x) const |
const double | getIntegrand_sigmaWithISR_tau202 (double x) const |
const double | getIntegrand_sigmaWithISR_tau205 (double x) const |
const double | getIntegrand_sigmaWithISR_tau207 (double x) const |
const double | getIntegrand_sigmaWithISR_up130 (double x) const |
const double | getIntegrand_sigmaWithISR_up133 (double x) const |
const double | getIntegrand_sigmaWithISR_up136 (double x) const |
const double | getIntegrand_sigmaWithISR_up161 (double x) const |
const double | getIntegrand_sigmaWithISR_up167 (double x) const |
const double | getIntegrand_sigmaWithISR_up172 (double x) const |
const double | getIntegrand_sigmaWithISR_up183 (double x) const |
const double | getIntegrand_sigmaWithISR_up189 (double x) const |
const double | getIntegrand_sigmaWithISR_up192 (double x) const |
const double | getIntegrand_sigmaWithISR_up196 (double x) const |
const double | getIntegrand_sigmaWithISR_up200 (double x) const |
const double | getIntegrand_sigmaWithISR_up202 (double x) const |
const double | getIntegrand_sigmaWithISR_up205 (double x) const |
const double | getIntegrand_sigmaWithISR_up207 (double x) const |
const double | Integrand_AFBnumeratorWithISR_l (double x, const QCD::lepton l_flavor, const double s) const |
const double | Integrand_AFBnumeratorWithISR_q (double x, const QCD::quark q_flavor, const double s) const |
const double | Integrand_dsigmaBox_l (double cosTheta, const QCD::lepton l_flavor, const double s) const |
const double | Integrand_dsigmaBox_q (double cosTheta, const QCD::quark q_flavor, const double s) const |
const double | Integrand_sigmaWithISR_l (double x, const QCD::lepton l_flavor, const double s) const |
const double | Integrand_sigmaWithISR_q (double x, const QCD::quark q_flavor, const double s) const |
double | m_q (const QCD::quark q, const double mu, const orders order=FULLNLO) const |
double | RAq (const QCD::quark q) const |
The radiator factor associated with the final-state QED and QCD corrections to the the axial-vector-current interactions, \(R_A^q(M_Z^2)\). More... | |
double | resumKappaZ (const double DeltaRho[orders_EW_size], const double deltaKappa_rem[orders_EW_size], const double DeltaRbar_rem, const bool bool_Zbb) const |
A method to compute the real part of the effetvive coupling \(\kappa_Z^f\) from \(\Delta\rho\), \(\delta\rho_{\rm rem}^{f}\) and \(\Delta r_{\mathrm{rem}}\). More... | |
double | resumMw (const double Mw_i, const double DeltaRho[orders_EW_size], const double DeltaR_rem[orders_EW_size]) const |
A method to compute the \(W\)-boson mass from \(\Delta\rho\) and \(\Delta r_{\mathrm{rem}}\). More... | |
double | resumRhoZ (const double DeltaRho[orders_EW_size], const double deltaRho_rem[orders_EW_size], const double DeltaRbar_rem, const bool bool_Zbb) const |
A method to compute the real part of the effective coupling \(\rho_Z^f\) from \(\Delta\rho\), \(\delta\rho_{\rm rem}^{f}\) and \(\Delta r_{\mathrm{rem}}\). More... | |
double | RVh () const |
The singlet vector corrections to the hadronic \(Z\)-boson width, denoted as \(R_V^h\). More... | |
double | RVq (const QCD::quark q) const |
The radiator factor associated with the final-state QED and QCD corrections to the the vector-current interactions, \(R_V^q(M_Z^2)\). More... | |
double | SchemeToDouble (const std::string scheme) const |
A method to convert a given scheme name in string form into a floating-point number with double precision. More... | |
virtual void | setParameter (const std::string name, const double &value) |
A method to set the value of a parameter of StandardModel. More... | |
const double | sigma_NoISR_l (const QCD::lepton l_flavor, const double s) const |
const double | sigma_NoISR_q (const QCD::quark q_flavor, const double s) const |
double | taub () const |
Top-mass corrections to the \(Zb\bar{b}\) vertex, denoted by \(\tau_b\). More... | |
![]() | |
const double | MassOfNf (int nf) const |
The Mbar mass of the heaviest quark in the theory with Nf active flavour. More... | |
Protected Attributes | |
double | A |
The CKM parameter \(A\) in the Wolfenstein parameterization. More... | |
double | ale |
The fine-structure constant \(\alpha\). More... | |
double | alpha21 |
double | alpha31 |
double | AlsMz |
The strong coupling constant at the Z-boson mass, \(\alpha_s(M_Z)\). More... | |
bool | bSigmaForAFB |
bool | bSigmaForR |
double | dAl5hMz |
The five-flavour hadronic contribution to the electromagnetic coupling, \(\Delta\alpha_{\mathrm{had}}^{(5)}(M_Z^2)\). (Non-input parameter) More... | |
double | dAle5Mz |
The five-flavour hadronic contribution to the electromagnetic coupling, \(\Delta\alpha_{\mathrm{had}}^{(5)}(M_Z^2)\), used as input for FlagMWinput = FALSE. More... | |
double | delGammaZ |
The theoretical uncertainty in \(\Gamma_Z\), denoted as \(\delta\,\Gamma_Z\), in GeV. More... | |
double | delMw |
The theoretical uncertainty in \(M_W\), denoted as \(\delta\,M_W\), in GeV. More... | |
double | delR0b |
The theoretical uncertainty in \(R_b^0\), denoted as \(\delta\,R_b^0\). More... | |
double | delR0c |
The theoretical uncertainty in \(R_c^0\), denoted as \(\delta\,R_c^0\). More... | |
double | delR0l |
The theoretical uncertainty in \(R_l^0\), denoted as \(\delta\,R_l^0\). More... | |
double | delsigma0H |
The theoretical uncertainty in \(\sigma_{Hadron}^0\), denoted as \(\delta\,\sigma_{Hadron}^0\) in nb. More... | |
double | delSin2th_b |
The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{b}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{b}\). More... | |
double | delSin2th_l |
The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{\rm lept}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{\rm lept}\). More... | |
double | delSin2th_q |
The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{q\not = b,t}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{q\not = b,t}\). More... | |
double | delta |
double | etab |
The CKM parameter \(\bar{\eta}\) in the Wolfenstein parameterization. More... | |
bool | flag_order [orders_EW_size] |
An array of internal flags controlling the inclusions of higher-order corrections. More... | |
bool | FlagFixMuwMut |
A boolean for the model flag FixMuwMut. More... | |
bool | flagLEP2 [NUMofLEP2RCs] |
double | gamma |
\(\gamma \) used as an input for FlagWolfenstein = FALSE More... | |
double | GF |
The Fermi constant \(G_\mu\) in \({\rm GeV}^{-2}\). More... | |
double | lambda |
The CKM parameter \(\lambda\) in the Wolfenstein parameterization. More... | |
Particle | leptons [6] |
An array of Particle objects for the leptons. More... | |
double | mHl |
The Higgs mass \(m_h\) in GeV. More... | |
double | muw |
A matching scale \(\mu_W\) around the weak scale in GeV. More... | |
double | Mw_inp |
The mass of the \(W\) boson in GeV used as input for FlagMWinput = TRUE. More... | |
CKM | myCKM |
An object of type CKM. More... | |
PMNS | myPMNS |
double | Mz |
The mass of the \(Z\) boson in GeV. More... | |
bool | requireCKM |
An internal flag to control whether the CKM matrix has to be recomputed. More... | |
bool | requireYe |
An internal flag to control whether the charged-lepton Yukawa matrix has to be recomputed. More... | |
bool | requireYn |
An internal flag to control whether the neutrino Yukawa matrix has to be recomputed. More... | |
double | rhob |
The CKM parameter \(\bar{\rho}\) in the Wolfenstein parameterization. More... | |
double | s12 |
double | s13 |
double | s23 |
Flavour | SMFlavour |
An object of type Flavour. More... | |
Matching< StandardModelMatching, StandardModel > | SMM |
An object of type Matching. More... | |
double | Vcb |
\(\vert V_{cb} \vert \) used as an input for FlagWolfenstein = FALSE More... | |
double | Vub |
\(\vert V_{ub} \vert \) used as an input for FlagWolfenstein = FALSE More... | |
double | Vud |
\(\vert V_{ud} \vert \) used as an input for FlagWolfenstein = FALSE and FlagUseVud = TRUE More... | |
double | Vus |
\(\vert V_{us} \vert \) used as an input for FlagWolfenstein = FALSE More... | |
gslpp::matrix< gslpp::complex > | Yd |
The Yukawa matrix of the down-type quarks. More... | |
gslpp::matrix< gslpp::complex > | Ye |
The Yukawa matrix of the charged leptons. More... | |
gslpp::matrix< gslpp::complex > | Yn |
The Yukawa matrix of the neutrinos. More... | |
gslpp::matrix< gslpp::complex > | Yu |
The Yukawa matrix of the up-type quarks. More... | |
![]() | |
double | AlsM |
The strong coupling constant at the mass scale MAls, \(\alpha_s(M_{\alpha_s})\). More... | |
double | CA |
double | CF |
bool | computemt |
Switch for computing the \(\overline{\mathrm{MS}}\) mass of the top quark. More... | |
double | dAdA_NA |
double | dFdA_NA |
double | dFdF_NA |
bool | FlagMpole2MbarNumeric |
A flag to determine whether the pole mass to \(\over \mathrm{MS}\) mass conversion is done numerically. More... | |
bool | FlagMtPole |
A flag to determine whether the pole mass of the top quark is used as input. More... | |
double | MAls |
The mass scale in GeV at which the strong coupling measurement is provided. More... | |
double | mtpole |
The pole mass of the top quark. More... | |
double | mub |
The threshold between five- and four-flavour theory in GeV. More... | |
double | muc |
The threshold between four- and three-flavour theory in GeV. More... | |
double | mut |
The threshold between six- and five-flavour theory in GeV. More... | |
double | NA |
double | Nc |
The number of colours. More... | |
bool | QCDsuccess =true |
Particle | quarks [6] |
The vector of all SM quarks. More... | |
bool | requireYd |
Switch for generating the Yukawa couplings to the down-type quarks. More... | |
bool | requireYu |
Switch for generating the Yukawa couplings to the up-type quarks. More... | |
double | TF |
![]() | |
bool | isSliced = false |
A boolean set to true if the current istance is a slice of an extended object. More... | |
std::map< std::string, std::reference_wrapper< const double > > | ModelParamMap |
bool | UpdateError = false |
A boolean set to false if update is successful. More... | |
Private Member Functions | |
const double | AleWithInit (double mu, double alsi, double mu_i, orders order) const |
const double | AlsE (double mu, orders order, bool Nf_thr) const |
const double | AlsEByOrder (double mu, orders order, bool Nf_thr) const |
const double | AlsEWithInit (double mu, double alsi, double mu_i, const int nf_i, orders order) const |
Private Attributes | |
double | ale_cache [10][CacheSize] |
Cache for \(\alpha_e\). More... | |
double | als_cache [11][CacheSize] |
Cache for \(\alpha_s\). More... | |
double | average |
double | DeltaAlpha_cache |
A cache of the value of \(\Delta\alpha(M_Z^2)\). More... | |
double | DeltaAlphaLepton_cache |
A cache of the value of \(\Delta\alpha_{\mathrm{lept}}(M_Z^2)\). More... | |
double | error |
gsl_function | f_GSL |
bool | FlagCacheInStandardModel |
A flag for caching (true by default). More... | |
std::string | FlagKappaZ |
A string for the model flag KappaZ. More... | |
std::string | FlagMw |
A string for the model flag Mw. More... | |
bool | FlagMWinput |
A boolean for the model flag MWinput. More... | |
bool | FlagNoApproximateGammaZ |
A boolean for the model flag NoApproximateGammaZ. More... | |
std::string | FlagRhoZ |
A string for the model flag RhoZ. More... | |
bool | FlagSMAux |
A boolean for the model flag SMAux. More... | |
bool | FlagUseVud |
A boolean for the model flag UseVud. More... | |
bool | FlagWithoutNonUniversalVC |
A boolean for the model flag WithoutNonUniversalVC. More... | |
bool | FlagWolfenstein |
A boolean for the model flag Wolfenstein. More... | |
double | GammaW_cache |
A cache of the value of \(\Gamma_W\). More... | |
int | iterationNo |
gslpp::complex | kappaZ_f_cache [12] |
A cache of the value of \(\kappa_Z^l\). More... | |
double | Mw_cache |
A cache of the value of \(M_W\). More... | |
EWSMApproximateFormulae * | myApproximateFormulae |
A pointer to an object of type EWSMApproximateFormulae. More... | |
EWSMcache * | myEWSMcache |
A pointer to an object of type EWSMcache. More... | |
LeptonFlavour * | myLeptonFlavour |
A pointer to an object of the type LeptonFlavour. More... | |
EWSMOneLoopEW * | myOneLoopEW |
A pointer to an object of type EWSMOneLoopEW. More... | |
EWSMThreeLoopEW * | myThreeLoopEW |
A pointer to an object of type EWSMThreeLoopEW. More... | |
EWSMThreeLoopEW2QCD * | myThreeLoopEW2QCD |
A pointer to an object of type EWSMThreeLoopEW2QCD. More... | |
EWSMThreeLoopQCD * | myThreeLoopQCD |
A pointer to an object of type EWSMThreeLoopQCD. More... | |
EWSMTwoFermionsLEP2 * | myTwoFermionsLEP2 |
A pointer to an object of type EWSMTwoFermionsLEP2. More... | |
EWSMTwoLoopEW * | myTwoLoopEW |
A pointer to an object of type EWSMTwoLoopEW. More... | |
EWSMTwoLoopQCD * | myTwoLoopQCD |
A pointer to an object of type EWSMTwoLoopQCD. More... | |
orders | realorder |
gslpp::complex | rhoZ_f_cache [12] |
A cache of the value of \(\rho_Z^l\). More... | |
double | SMparamsForEWPO_cache [NumSMParamsForEWPO] |
double | SMresult_cache |
bool | SMSuccess |
A boolean for the success of the Standard Model update and matching. More... | |
bool | useDeltaAlpha_cache |
bool | useDeltaAlphaLepton_cache |
bool | useGammaW_cache |
bool | useKappaZ_f_cache [12] |
bool | useMw_cache |
bool | useRhoZ_f_cache [12] |
gsl_integration_workspace * | w_GSL1 |
Static Private Attributes | |
static const int | CacheSize = 5 |
Defines the depth of the cache. More... | |
Enumerator | |
---|---|
Weak | |
WeakBox | |
ISR | |
QEDFSR | |
QCDFSR | |
NUMofLEP2RCs |
Definition at line 514 of file StandardModel.h.
An enumerated type representing perturbative orders of radiative corrections to EW precision observables.
Definition at line 527 of file StandardModel.h.
StandardModel::StandardModel | ( | ) |
The default constructor.
Definition at line 41 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The default destructor.
Definition at line 152 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The left-right asymmetry in \(e^+e^-\to Z\to \ell \bar{\ell}\) at the \(Z\)-pole, \(\mathcal{A}_\ell\).
The asymmetry \(\mathcal{A}_\ell\) is given by
\[ \mathcal{A}_\ell = \frac{2\, {\rm Re}\left(g_{V}^\ell/g_{A}^\ell\right)} {1+\left[{\rm Re}\left(g_{V}^\ell/g_{A}^\ell\right)\right]^2}\,, \]
where the ratio of the effective couplings \(g_{V}^\ell/g_{A}^\ell\) is computed via the two-loop approximate formula of \(\sin^2\theta_{\rm eff}^{\,\ell}\), EWSMApproximateFormulae::sin2thetaEff_l(), when checkNPZff_linearized() returns true and the model flag KappaZ of StandardModel is set to APPROXIMATEFORMULA.
[in] | f | a lepton or quark |
Reimplemented in NPbase, NPSMEFTd6General, NPZbbbar, and NPEpsilons.
Definition at line 1339 of file StandardModel/src/StandardModel.cpp.
|
virtual |
[in] | f | a lepton or quark |
Reimplemented in NPbase, NPSMEFTd6General, NPZbbbar, and NPEpsilons.
Definition at line 1346 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8028 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8036 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::AH_f | ( | const double | tau | ) | const |
Fermionic loop function entering in the calculation of the effective \(Hgg\) and \(H\gamma\gamma\) couplings.
\(A^H_f(\tau)=2\tau [1+(1-\tau)f(\tau)]\)
[in] |
_form#4708, with \(M\) the mass of the fermion in the loop.
Definition at line 3296 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::AH_W | ( | const double | tau | ) | const |
W loop function entering in the calculation of the effective \(H\gamma\gamma\) coupling.
\(A^H_W(\tau)=-[2+3\tau + 3\tau*(2-\tau) f(\tau)]\)
[in] |
_form#4708, with \(M\) the mass of the fermion in the loop.
Definition at line 3300 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::AHZga_f | ( | const double | tau, |
const double | lambda | ||
) | const |
Fermionic loop function entering in the calculation of the effective \(HZ\gamma\) coupling.
[in] |
_form#4708, \(\lambda=4 M^2/m_Z^2\), with \(M\) the mass of the fermion in the loop.
Definition at line 3304 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::AHZga_W | ( | const double | tau, |
const double | lambda | ||
) | const |
W loop function entering in the calculation of the effective \(HZ\gamma\) coupling.
[in] |
_form#4708, \(\lambda=4 M^2/m_Z^2\), with \(M\) the mass of the fermion in the loop.
Definition at line 3308 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::Ale | ( | double | mu, |
orders | order, | ||
bool | Nf_thr = true |
||
) | const |
The running electromagnetic coupling \(\alpha_e(\mu)\) in the \(\overline{MS}\) scheme.
See [Huber:2005ig]
[in] | mu | renormalization scale \(\mu\) in GeV |
[in] | order | order in the \(\alpha_e\) expansion as defined in the order enum in OrderScheme |
[in] | Nf_thr | flag to activate flavour thresholds. Default: true |
Definition at line 777 of file StandardModel/src/StandardModel.cpp.
The running electromagnetic coupling \(\alpha(\mu)\) in the on-shell scheme.
See [Baikov:2012rr].
[in] | mu | renormalization scale \(\mu\) in GeV. |
[in] | order | LO/FULLNLO |
Definition at line 605 of file StandardModel/src/StandardModel.cpp.
|
private |
Definition at line 850 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The electromagnetic coupling at the \(Z\)-mass scale, \(\alpha(M_Z^2)=\alpha/(1-\Delta\alpha(M_Z^2))\).
The radiative corrections are included with Dyson resummation:
\[ \alpha(M_Z^2) = \frac{\alpha}{1 - \Delta\alpha(M_Z^2)}. \]
Reimplemented in NPbase, NPSMEFTd6, and NPSMEFTd6General.
Definition at line 938 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the parity violating asymmetry in Moller scattering.
[in] | q2 | the \(Q^2\) of the process |
[in] | y |
Reimplemented in NPbase.
Definition at line 2763 of file StandardModel/src/StandardModel.cpp.
Computes the running strong coupling \(\alpha_s(\mu)\) with \(N_f\) active flavours in the \(\overline{\mathrm{MS}}\) scheme. In the cases of LO, NLO and FULLNLO, the coupling is computed with AlsWithInit(). On the other hand, in the cases of NNLO and FULLNNLO, the coupling is computed with AlsWithLambda().
[in] | mu | the scale \(\mu\) in GeV |
[in] | Nf_in | number of active flavours |
[in] | order | order in the \(\alpha_s\) expansion as defined in OrderScheme |
Definition at line 839 of file QCD.cpp.
|
inline |
The running QCD coupling \(\alpha(\mu)\) in the \(\overline{MS}\) scheme including QED corrections.
See [Huber:2005ig]
[in] | mu | renormalization scale \(\mu\) in GeV. |
[in] | order | order in the \(\alpha_s\) expansion as defined in OrderScheme |
[in] | Nf_thr | true: \(n_f\) = Nf(mu), false: \(n_f\) = Nf(AlsM) |
[in] | qed_flag | include \(\alpha_e\) corrections to the requested order in \(\alpha_s\). The \(\alpha_s\alpha_e\) term is included if NNNLO is requested. Default: false |
Definition at line 1088 of file StandardModel.h.
const double QCD::Als | ( | const double | mu, |
const orders | order = FULLNLO , |
||
const bool | Nf_thr = true |
||
) | const |
Definition at line 826 of file QCD.cpp.
|
private |
Definition at line 674 of file StandardModel/src/StandardModel.cpp.
|
private |
Definition at line 686 of file StandardModel/src/StandardModel.cpp.
|
private |
Definition at line 749 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::Alstilde5 | ( | const double | mu | ) | const |
The value of \(\frac{\alpha_s^{\mathrm{FULLNLO}}}{4\pi}\) at any scale \(\mu\) with the number of flavours \(n_f = 4\) and full EW corrections.
[in] | mu | the scale at which \(\alpha_s\) has to be computed |
Definition at line 945 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the anomalous magnetic moment of the muon \(a_\mu=(g_\mu-2)/2\).
Reimplemented in NPbase.
Definition at line 2435 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::Beta_e | ( | int | nm, |
unsigned int | nf | ||
) | const |
QED beta function coefficients - eq. (36) hep-ph/0512066.
nm | powers of alpha_s and alpha_e as an integer |
nf | number of active flavor |
Definition at line 654 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::Beta_s | ( | int | nm, |
unsigned int | nf | ||
) | const |
QCD beta function coefficients including QED corrections - eq. (36) hep-ph/0512066.
nm | powers of alpha_s and alpha_e as an integer |
nf | number of active flavor |
Definition at line 626 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to b \bar{b})\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3691 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to c \bar{c})\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3681 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to \gamma \gamma)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3666 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \(\(H\to gg)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3646 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to \mu^+ \mu^-)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3671 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to s \bar{s})\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3686 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to \tau^+ \tau^-)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3676 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to W W^*)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3656 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to Z \gamma)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3661 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The Br \((H\to Z Z^*)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3651 of file StandardModel/src/StandardModel.cpp.
The branching ratio of the \(W\) boson decaying into a SM fermion pair, \(Br(W\to f_i f_j)\).
Reimplemented in NPbase, NPSMEFTd6, and NPSMEFTd6General.
Definition at line 1283 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::c02 | ( | ) | const |
The square of the cosine of the weak mixing angle \(c_0^2\) defined without weak radiative corrections.
The quantity \(c_0^2\) is given by
\[ c_0^2 = 1 - s_0^2\,, \]
where \(s_0^2\) is defined in s02().
See [Altarelli:1990zd] and [Altarelli:1991fk].
Definition at line 1014 of file StandardModel/src/StandardModel.cpp.
|
inlineprotected |
A method to check if a given scheme name in string form is valid.
[in] | scheme | scheme name for \(M_W\), \(\rho_Z^f\) or \(\kappa_Z^f\) |
Definition at line 3518 of file StandardModel.h.
|
virtual |
A method to check the sanity of the set of model flags.
Reimplemented from QCD.
Definition at line 547 of file StandardModel/src/StandardModel.cpp.
|
virtual |
A method to check if all the mandatory parameters for StandardModel have been provided in model initialization.
[in] | DPars | a map of the parameters that are being updated in the Monte Carlo run (including parameters that are varied and those that are held constant) |
Reimplemented from QCD.
Reimplemented in CMFV, FlavourWilsonCoefficient, FlavourWilsonCoefficient_DF2, LoopMediators, NPDF2, RealWeakEFTCC, RealWeakEFTLFV, GeneralSUSY, GeorgiMachacek, LeftRightSymmetricModel, MFV, HiggsChiral, HiggsKigen, NPEpsilons, NPEpsilons_pureNP, NPHiggs, NPSMEFTd6, NPSTU, NPSTUVWXY, NPSTUZbbbarLR, NPZbbbar, NPZbbbarLinearized, SigmaBR, pMSSM, SUSY, SUSYMassInsertion, THDM, and THDMW.
Definition at line 364 of file StandardModel/src/StandardModel.cpp.
bool StandardModel::checkSMparamsForEWPO | ( | ) |
A method to check whether the parameters relevant to the EWPO are updated.
This function is used for the cashing methods implemented in the current class: DeltaAlphaLepton(), DeltaAlpha(), Mw_SM(), rhoZ_l_SM(), rhoZ_q_SM(), kappaZ_l_SM(), kappaZ_q_SM() and GammaW_SM(). When the values of the StandardModel parameters are updated in the Monte Carlo run and differ from those stored in the cache SMparamsForEWPO_cache, this function updates the cache, and returns false.
Definition at line 556 of file StandardModel/src/StandardModel.cpp.
|
inline |
The Br \((H\to 4f)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2946 of file StandardModel.h.
|
inline |
The Br \((H\to 4l)\) \(l=e,\mu\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2913 of file StandardModel.h.
|
inline |
The Br \((H\to 4l)\) \(l=e,\mu,\tau\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2924 of file StandardModel.h.
|
inline |
The Br \((H\to 4q)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2935 of file StandardModel.h.
|
inline |
The Br \((H\to 4\nu)\) in the Standard Model.
Definition at line 2869 of file StandardModel.h.
|
inline |
The Br \((H\to bb)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2856 of file StandardModel.h.
|
inline |
The Br \((H\to cc)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2833 of file StandardModel.h.
|
inline |
The Br \((H\to e \nu \mu \nu)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2880 of file StandardModel.h.
|
inline |
The Br \((H\to\gamma\gamma)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2799 of file StandardModel.h.
|
inline |
The Br \((H\to gg)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2752 of file StandardModel.h.
|
inline |
The Br \((H\to l^+ l^- \nu \nu)\) \(l=e,\mu\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2891 of file StandardModel.h.
|
inline |
The Br \((H\to l^+ l^- \nu \nu)\) \(l=e,\mu,\tau\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2902 of file StandardModel.h.
|
inline |
The Br \((H\to \mu\mu)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2810 of file StandardModel.h.
|
inline |
The Br \((H\to ss)\) in the Standard Model.
From Table 7 in http://cdsweb.cern.ch/record/2629412/files/ATLAS-CONF-2018-031.pdf
Definition at line 2845 of file StandardModel.h.
|
inline |
The Br \((H\to \tau\tau)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2821 of file StandardModel.h.
|
inline |
The Br \((H\to WW)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2763 of file StandardModel.h.
|
inline |
The Br \((H\to Z\gamma)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2787 of file StandardModel.h.
|
inline |
The Br \((H\to ZZ)\) in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2775 of file StandardModel.h.
|
protectedvirtual |
The method to compute the CKM matrix.
Definition at line 376 of file StandardModel/src/StandardModel.cpp.
void StandardModel::ComputeDeltaR_rem | ( | const double | Mw_i, |
double | DeltaR_rem[orders_EW_size] | ||
) | const |
A method to collect \(\Delta r_{\mathrm{rem}}\) computed via subclasses.
This function collects \(\Delta r_{\mathrm{rem}}\) computed via EWSMOneLoopEW, EWSMTwoLoopQCD, EWSMTwoLoopEW, EWSMThreeLoopQCD, EWSMThreeLoopEW2QCD and EWSMThreeLoopEW classes.
[in] | Mw_i | the \(W\)-boson mass |
[out] | DeltaR_rem | Array of \(\Delta r_{\mathrm{rem}}\) |
Definition at line 1155 of file StandardModel/src/StandardModel.cpp.
void StandardModel::ComputeDeltaRho | ( | const double | Mw_i, |
double | DeltaRho[orders_EW_size] | ||
) | const |
A method to collect \(\Delta\rho\) computed via subclasses.
This function collects \(\Delta\rho\) computed via EWSMOneLoopEW, EWSMTwoLoopQCD, EWSMTwoLoopEW, EWSMThreeLoopQCD, EWSMThreeLoopEW2QCD and EWSMThreeLoopEW classes.
[in] | Mw_i | the \(W\)-boson mass |
[out] | DeltaRho | Array of \(\Delta\rho\) |
Definition at line 1126 of file StandardModel/src/StandardModel.cpp.
|
inline |
The top loop contribution to \(H\to\gamma\gamma\) in the Standard Model.
Currently it returns the value of tab 40 in ref. [Heinemeyer:2013tqa]
Definition at line 3034 of file StandardModel.h.
|
inline |
The mixed \(t-W\) loop contribution to \(H\to\gamma\gamma\) in the Standard Model.
Currently it returns the value of tab 40 in ref. [Heinemeyer:2013tqa]
Definition at line 3056 of file StandardModel.h.
|
inline |
The \(W\) loop contribution to \(H\to\gamma\gamma\) in the Standard Model.
Currently it returns the value of tab 40 in ref. [Heinemeyer:2013tqa]
Definition at line 3045 of file StandardModel.h.
|
inline |
The bottom loop contribution to \(H\to gg\) in the Standard Model.
Currently it returns the value of tab 39 in ref. [Heinemeyer:2013tqa]
Definition at line 2979 of file StandardModel.h.
|
inline |
The top-bottom interference contribution to \(H\to gg\) in the Standard Model.
Currently it returns the value of tab 39 in ref. [Heinemeyer:2013tqa]
Definition at line 2990 of file StandardModel.h.
|
inline |
The top loop contribution to \(H\to gg\) in the Standard Model.
Currently it returns the value of tab 39 in ref. [Heinemeyer:2013tqa]
Definition at line 2968 of file StandardModel.h.
|
inline |
The Higgs total width in the Standard Model.
Currently it returns the value for Mh=125.1 GeV provided by the LHCXSSWG update in the CERN Report 4 from 2016 https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageBR
Definition at line 2957 of file StandardModel.h.
|
inline |
The top loop contribution to \(H\to Z\gamma\) in the Standard Model.
Currently it returns the value of tab 41 in ref. [Heinemeyer:2013tqa]
Definition at line 3001 of file StandardModel.h.
|
inline |
The mixed \(t-W\) loop contribution to \(H\to Z\gamma\) in the Standard Model.
Currently it returns the value of tab 41 in ref. [Heinemeyer:2013tqa]
Definition at line 3023 of file StandardModel.h.
|
inline |
The \(W\) loop contribution to \(H\to Z\gamma\) in the Standard Model. Currently it returns the value of tab 41 in ref. [Heinemeyer:2013tqa].
Definition at line 3012 of file StandardModel.h.
|
inline |
The bbH production cross section in the Standard Model.
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2735 of file StandardModel.h.
|
inline |
The ggH cross section in the Standard Model.
See Tables B.67 and B.74 in ref. [Heinemeyer:2013tqa] and the updates in https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG2KAPPA for 7 and 8 TeV For the 13, 14 and 27 TeV values we use the updated numbers wrt the CERN Report 4 2016 from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG1HELHCXsecs https://twiki.cern.ch/twiki/pub/LHCPhysics/LHCHXSWG1HELHCXsecs/hlhehiggs.pdf For 13.6 TeV we follow the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1: https://arxiv.org/pdf/2402.09955v1.pdf For the 100 TeV values we use the values from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/HiggsEuropeanStrategy
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2371 of file StandardModel.h.
|
inline |
The square of the bottom-quark contribution to the ggH cross section in the Standard Model.
The values have been obtained from: https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG2KAPPA For 13.6 TeV we follow what is done in some cases in the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1 and use linear interpolation between the values at 13 and 14 TeV
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2433 of file StandardModel.h.
|
inline |
The top-bottom interference contribution to the ggH cross section in the Standard Model.
The values have been obtained from: https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG2KAPPA For 13.6 TeV we follow what is done in some cases in the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1 and use linear interpolation between the values at 13 and 14 TeV
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2463 of file StandardModel.h.
|
inline |
The square of the top-quark contribution to the ggH cross section in the Standard Model.
The values have been obtained from: https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG2KAPPA For 13.6 TeV we follow what is done in some cases in the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1 and use linear interpolation between the values at 13 and 14 TeV
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2403 of file StandardModel.h.
|
inline |
The tHq production cross section in the Standard Model.
For the 13 TeV values we use the official numbers a la CERN Report 4 2016 from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageAt13TeV
Definition at line 2716 of file StandardModel.h.
|
inline |
The ttH production cross section in the Standard Model.
See Tables B.67 and B.74 in ref. [Heinemeyer:2013tqa] . For the 13 TeV values we use the official numbers a la CERN Report 4 2016 from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageAt13TeV https://twiki.cern.ch/twiki/bin/view/LHCPhysics/CERNYellowReportPageAt14TeV For the 14 and 27 TeV values we use the updated numbers wrt the CERN Report 4 2016 from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG1HELHCXsecs https://twiki.cern.ch/twiki/pub/LHCPhysics/LHCHXSWG1HELHCXsecs/hlhehiggs.pdf For 13.6 TeV we follow the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1: https://arxiv.org/pdf/2402.09955v1.pdf For the 100 TeV values we use the values from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/HiggsEuropeanStrategy
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2686 of file StandardModel.h.
|
inline |
The VBF cross section in the Standard Model.
See Tables B.67 and B.74 in ref. [Heinemeyer:2013tqa] . For the 7, 8, 13, 14 and 27 TeV values we use the updated numbers wrt the CERN Report 4 2016 from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG1HELHCXsecs https://twiki.cern.ch/twiki/pub/LHCPhysics/LHCHXSWG1HELHCXsecs/hlhehiggs.pdf For 13.6 TeV we follow the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1: https://arxiv.org/pdf/2402.09955v1.pdf For the 100 TeV values we use the values from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/HiggsEuropeanStrategy
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2496 of file StandardModel.h.
|
inline |
The W fusion contribution \(\sigma_{WF}\) to higgs-production cross section in the Standard Model.
The values have been obtained from: https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG2KAPPA For 13.6 TeV we follow what is done in some cases in the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1 and use linear interpolation between the values at 13 and 14 TeV
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2529 of file StandardModel.h.
|
inline |
The WH production cross section in the Standard Model.
See Tables B.67 and B.74 in ref. [Heinemeyer:2013tqa] . For the 13, 14 and 27 TeV values we use the updated numbers wrt the CERN Report 4 2016 from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG1HELHCXsecs https://twiki.cern.ch/twiki/pub/LHCPhysics/LHCHXSWG1HELHCXsecs/hlhehiggs.pdf For 13.6 TeV we follow the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1: https://arxiv.org/pdf/2402.09955v1.pdf For the 100 TeV values we use the values from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/HiggsEuropeanStrategy
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2609 of file StandardModel.h.
|
inline |
The Z fusion contribution \(\sigma_{ZF}\) to higgs-production cross section in the Standard Model.
The values have been obtained from: https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG2KAPPA For 13.6 TeV we follow what is done in some cases in the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1 and use linear interpolation between the values at 13 and 14 TeV
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2562 of file StandardModel.h.
|
inline |
The ZH production cross section in the Standard Model.
See Tables B.67 and B.74 in ref. [Heinemeyer:2013tqa] . For the 13, 14 and 27 TeV values we use the updated numbers wrt the CERN Report 4 2016 from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/LHCHXSWG1HELHCXsecs https://twiki.cern.ch/twiki/pub/LHCPhysics/LHCHXSWG1HELHCXsecs/hlhehiggs.pdf For 13.6 TeV we follow the LHC Higgs WG note: arXiv: 2402.09955 [hep-ph] V1: https://arxiv.org/pdf/2402.09955v1.pdf For the 100 TeV values we use the values from https://twiki.cern.ch/twiki/bin/view/LHCPhysics/HiggsEuropeanStrategy
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2646 of file StandardModel.h.
|
inline |
The Z W interference fusion contribution \(\sigma_{ZWF}\) to higgs-production cross section in the Standard Model.
Negligible (0.1%) in the Standard model.
[in] | sqrt_s | the center-of-mass energy in TeV |
Definition at line 2591 of file StandardModel.h.
|
protectedvirtual |
The method to compute the Yukawas matrix.
Reimplemented in SUSY.
Definition at line 410 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Definition at line 1081 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The square of the cosine of the weak mixing angle in the on-shell scheme, denoted as \(c_W^2\).
\[ c_W^2=\cos^2{\theta_W}=\frac{M_W^2}{M_Z^2}. \]
Definition at line 1076 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The 5-quark contribution to the running of the em constant to the \(Z\) pole. \(\Delta\alpha_{had}^{(5)}(M_Z)\).
Depending on the flag MWinput this is given by the input parameter dAle5Mz (MWinput=false) or it is computed from Mw (MWinput=true)
Definition at line 1068 of file StandardModel/src/StandardModel.cpp.
|
protected |
The non-factorizable EW-QCD corrections to the partial widths for \(Z\to q\bar{q}\), denoted as \(\Delta_{\mathrm{EW/QCD}}\).
See [Czarnecki:1996ei] and [Harlander:1997zb].
[in] | q | name of a quark (see QCD::quark) |
Definition at line 2133 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::DeltaAlpha | ( | ) | const |
The total corrections to the electromagnetic coupling \(\alpha\) at the \(Z\)-mass scale, denoted as \(\Delta\alpha(M_Z^2)\).
\[ \Delta\alpha(M_Z^2) = \Delta\alpha_{\rm lept}(M_Z^2) + \Delta\alpha_{\rm had}^{(5)}(M_Z^2) + \Delta\alpha_{\rm top}(M_Z^2)\,. \]
Definition at line 926 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::DeltaAlphaL5q | ( | ) | const |
The sum of the leptonic and the five-flavour hadronic corrections to the electromagnetic coupling \(\alpha\) at the \(Z\)-mass scale, denoted as \(\Delta\alpha^{\ell+5q}(M_Z^2)\).
\[ \Delta\alpha^{\ell+5q}(M_Z^2) = \Delta\alpha_{\rm lept}(M_Z^2) + \Delta\alpha_{\rm had}^{(5)}(M_Z^2)\,. \]
Definition at line 901 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::DeltaAlphaLepton | ( | const double | s | ) | const |
Leptonic contribution to the electromagnetic coupling \(\alpha\), denoted as \(\Delta\alpha_{\mathrm{lept}}(s)\).
[in] | s | invariant mass squared |
Definition at line 873 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::DeltaAlphaTop | ( | const double | s | ) | const |
Top-quark contribution to the electromagnetic coupling \(\alpha\), denoted as \(\Delta\alpha_{\mathrm{top}}(s)\).
[in] | s | invariant mass squared |
Definition at line 907 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Flavour non-universal vertex corrections to \(\kappa_Z^l\), denoted by \(\Delta\kappa_Z^l\).
The non-universal contribution \(\Delta\kappa_Z^l\) is given by
\[ \Delta \kappa_Z^l = \kappa_Z^l - \kappa_Z^e = \frac{\alpha}{4\pi s_W^2} \left( \frac{\delta_l^2-\delta_e^2}{4c_W^2}\,\mathcal{F}_Z(M_Z^2) -u_l+u_e\right), \]
where \(u_l\) and \(\delta_l\) are defined as
\[ u_l = \frac{3v_l^2+a_l^2}{4c_W^2}\mathcal{F}_Z(M_Z^2) + \mathcal{F}_W^l(M_Z^2)\,, \qquad \delta_l = v_l - a_l \]
with the tree-level vector and axial-vector couplings \(v_l = I_3^l - 2Q_l s_W^2\) and \(a_l = I_3^l\), and the form factors \(\mathcal{F}_Z\) and \(\mathcal{F}_W^l\).
See [Ciuchini:2013pca] and references therein.
[in] | f | a lepton or quark |
Definition at line 1764 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The SM prediction for \(\Delta r\) derived from that for the \(W\) boson mass.
If the model flag Mw of StandardModel is set to NORESUM or APPROXIMATEFORMULA, the quantity \(\Delta r\) is computed by using the following relation:
\[ s_W^2 M_W^2 = \frac{\pi\,\alpha}{\sqrt{2}G_\mu}(1+\Delta r)\,. \]
Otherwise, the following relation is employed instead:
\[ s_W^2 M_W^2 = \frac{\pi\,\alpha}{\sqrt{2}G_\mu(1-\Delta r)}\,, \]
where the resummation for \(\Delta r\) is considered.
Definition at line 1112 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The SM prediction for \(\Delta \overline{r}\) derived from that for the \(W\)-boson mass.
The quantity \(\Delta \overline{r}\) is computed by using the following relation:
\[ \overline{s}_W^2 \overline{M}_W^2 = \frac{\pi\,\alpha}{\sqrt{2}G_\mu}(1+\Delta \overline{r})\,, \]
where \(\overline{M}_W\) and \(\overline{s}_W\) are the \(W\)-boson mass and the sine of the weak mixing angle in the complex-pole/fixed-width scheme [Bardin:1988xt].
Definition at line 1222 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Flavour non-universal vertex corrections to \(\rho_Z^l\), denoted by \(\Delta\rho_Z^l\).
The non-universal contribution \(\Delta\rho_Z^l\) is given by
\[ \Delta \rho_Z^l = \rho_Z^l - \rho_Z^e = \frac{\alpha}{2\pi s_W^2}\left(u_l - u_e\right), \]
where \(u_l\) is defined as
\[ u_l = \frac{3v_l^2+a_l^2}{4c_W^2}\mathcal{F}_Z(M_Z^2) + \mathcal{F}_W^l(M_Z^2) \]
with the tree-level vector and axial-vector couplings \(v_l = I_3^l - 2Q_l s_W^2\) and \(a_l = I_3^l\) and the form factors, \(\mathcal{F}_Z\) and \(\mathcal{F}_W^l\).
See [Ciuchini:2013pca] and references therein.
[in] | f | a lepton or quark |
Definition at line 1739 of file StandardModel/src/StandardModel.cpp.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3257 of file StandardModel.h.
|
inlinevirtual |
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3227 of file StandardModel.h.
|
inlinevirtual |
|
inlinevirtual |
|
inlinevirtual |
|
inlinevirtual |
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3220 of file StandardModel.h.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3216 of file StandardModel.h.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3196 of file StandardModel.h.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3200 of file StandardModel.h.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3204 of file StandardModel.h.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3212 of file StandardModel.h.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3208 of file StandardModel.h.
const double StandardModel::eeffsigma | ( | const Particle | f, |
const double | pol_e, | ||
const double | pol_p, | ||
const double | s, | ||
const double | cosmin, | ||
const double | cosmax | ||
) | const |
Definition at line 4048 of file StandardModel/src/StandardModel.cpp.
|
inlinevirtual |
|
inlinevirtual |
|
inlinevirtual |
const double StandardModel::eeffsigmaEbin | ( | const double | pol_e, |
const double | pol_p, | ||
const double | s, | ||
const double | cosmin, | ||
const double | cosmax | ||
) | const |
Definition at line 4019 of file StandardModel/src/StandardModel.cpp.
|
inlinevirtual |
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 3172 of file StandardModel.h.
|
inlinevirtual |
|
inlinevirtual |
|
inlinevirtual |
|
virtual |
The SM contribution to the epsilon parameter \(\varepsilon_1\).
The parameters \(\varepsilon_1\) is defined as
\[ \varepsilon_1 = \Delta\rho'\,, \]
where \(\Delta\rho'=2\left(\sqrt{{\rm Re}(\rho_Z^e)}-1\right)\).
See [Altarelli:1990zd] and [Altarelli:1991fk].
Reimplemented in NPEpsilons, NPEpsilons_pureNP, NPSTU, and NPSTUVWXY.
Definition at line 1794 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The SM contribution to the epsilon parameter \(\varepsilon_2\).
The parameters \(\varepsilon_2\) is computed via the formula:
\[ \varepsilon_2 = c_0^2 \Delta\rho' + \frac{s_0^2}{c_0^2 - s_0^2} \Delta r_W - 2 s_0^2 \Delta\kappa'\,, \]
where \(\Delta\rho'\), \(\Delta r_W\) and \(\Delta\kappa'\) are defined as
\begin{align} \Delta\rho'=2\left(\sqrt{{\rm Re}(\rho_Z^e)}-1\right),\qquad \Delta r_W = 1 - \frac{\pi\,\alpha(M_Z^2)}{\sqrt{2}\,G_\mu M_Z^2 s_W^2 c_W^2},\qquad \Delta\kappa' = \frac{\sin^2\theta_{\mathrm{eff}}^e}{s_0^2} - 1\,, \end{align}
and \(s_0^2\) and \(c_0^2\) are given in s02() and c02(), respectively.
See [Altarelli:1990zd] and [Altarelli:1991fk].
Reimplemented in NPEpsilons, NPEpsilons_pureNP, NPSTU, and NPSTUVWXY.
Definition at line 1802 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The SM contribution to the epsilon parameter \(\varepsilon_3\).
The parameters \(\varepsilon_3\) is computed via the formula:
\[ \varepsilon_3 = c_0^2\Delta\rho' + (c_0^2-s_0^2)\Delta\kappa'\,, \]
where \(\Delta\rho'\) and \(\Delta\kappa'\) are defined as
\begin{align} \Delta\rho'=2\left(\sqrt{{\rm Re}(\rho_Z^e)}-1\right),\qquad \Delta\kappa' = \frac{\sin^2\theta_{\mathrm{eff}}^e}{s_0^2} - 1\,, \end{align}
and \(s_0^2\) and \(c_0^2\) are given in s02() and c02(), respectively.
See [Altarelli:1990zd] and [Altarelli:1991fk].
Reimplemented in NPEpsilons, NPEpsilons_pureNP, NPSTU, and NPSTUVWXY.
Definition at line 1814 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The SM contribution to the epsilon parameter \(\varepsilon_b\).
The parameters \(\varepsilon_b\) is computed via the formula:
\[ \epsilon_b = \frac{ {\rm Re}\left[ \kappa_Z^e + \Delta\kappa_Z^b \right]} {{\rm Re}(\kappa_Z^b)} - 1\,, \]
where \(\Delta\kappa_Z^b\), representing flavour non-universal vertex corrections to the \(Zb\bar{b}\) vertex, is neglected when the model flag WithoutNonUniversalVC of StandardModel is set to true.
See [Altarelli:1990zd], [Altarelli:1991fk] and [Altarelli:1993sz] for the \(\varepsilon\) parameterization and [Ciuchini:2013pca] for the flavour non-universal vertex corrections.
Reimplemented in NPEpsilons, NPEpsilons_pureNP, NPSTU, and NPSTUVWXY.
Definition at line 1824 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::f_triangle | ( | const double | tau | ) | const |
Loop function entering in the calculation of the effective \(Hgg\) and \(H\gamma\gamma\) couplings.
[in] |
_form#4708, with \(M\) the mass of the particle in the loop.
Definition at line 3256 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::g_triangle | ( | const double | tau | ) | const |
Loop function entering in the calculation of the effective \(HZ\gamma\) coupling.
[in] |
_form#4708, with \(M\) the mass of the particle in the loop.
Definition at line 3267 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective leptonic neutral-current axial-vector coupling \(g_A^l\) in the SM.
\[ g_A^l = \sqrt{\rho_Z^l}\, I_3^l\,. \]
[in] | f | a lepton or quark |
Reimplemented in NPbase, and NPEpsilons.
Definition at line 1583 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The hadronic decay width of the \(Z\) boson, \(\Gamma_{h}\).
The hadronic width is given by the sum,
\[ \Gamma_h = \Gamma_u + \Gamma_d + \Gamma_c + \Gamma_s + \Gamma_b\,. \]
Furthermore, the singlet vector corrections are added, following the prescription in [Bardin:1997xq] :
\[ \Gamma_h = \sum_q \Gamma_q + 4N_c\Gamma_0 R_V^h\,. \]
Reimplemented in NPbase.
Definition at line 1411 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The invisible partial decay width of the \(Z\) boson, \(\Gamma_{\mathrm{inv}}\).
\[ \Gamma_{\mathrm{inv}} = 3\,\Gamma_\nu\,, \]
where \(\Gamma_{\nu}\) is the partial width for \(Z\to\nu\bar{\nu}\).
Definition at line 1405 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the muon decay.
Follows the formulae of PDG
Definition at line 3088 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the leptonic tau decays.
Follows the formulae of PDG for muon, adapted to tau leptons
Definition at line 3128 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The total decay width of the \(Z\) boson, \(\Gamma_Z\).
When checkNPZff_linearized() returns true and the model flag NoApproximateGammaZ of StandardModel is set to false, this function uses the two-loop approximate formula of \(\Gamma_Z\) via EWSMApproximateFormulae::X_full_2_loop(). Otherwise, the total decay width is calculated with
\[ \Gamma_Z = \Gamma_{e} + \Gamma_{\mu} + \Gamma_{\tau} + \Gamma_{\mathrm{inv}} + \Gamma_h\,. \]
Reimplemented in NPbase, NPEpsilons, NPSMEFTd6General, and NPZbbbar.
Definition at line 1433 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to b \bar{b})\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3604 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to c \bar{c})\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3552 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to \gamma \gamma)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3485 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to gg)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3362 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to \mu^+ \mu^-)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3528 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to s \bar{s})\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3578 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The total Higgs width \(\Gamma(H)\) in the Standard Model.
At the same level of the individual contributions
Definition at line 3630 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to \tau^+ \tau^-)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3540 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to W W^*)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3410 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to Z \gamma)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3426 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\Gamma(H\to Z Z^*)\) in the Standard Model.
Currently, only at tree level. From Higgs Hunter's guide
Definition at line 3394 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The total width of the \(W\) boson, \(\Gamma_W\).
Reimplemented in NPbase, NPEpsilons, NPEpsilons_pureNP, NPSMEFTd6, NPSMEFTd6General, NPSTUVWXY, and NPZbbbar.
Definition at line 1266 of file StandardModel/src/StandardModel.cpp.
A partial decay width of the \(W\) boson decay into a SM fermion pair.
\[ \Gamma^W_{ij} = |U_{ij}|^2\,\frac{G_\mu M_W^3}{6\sqrt{2}\,\pi}\,\rho^W_{ij} \]
where \(U\) denotes the MNS matrix, and \(\rho^W_{ij}\) represents EW radiative corrections.
\[ \Gamma^W_{ij} = 3 |V_{ij}|^2\,\frac{G_\mu M_W^3}{6\sqrt{2}\,\pi}\,\rho^W_{ij} \left( 1 + \frac{\alpha_s(M_W^2)}{\pi} \right). \]
where \(V\) denotes the CKM matrix, and \(\rho^W_{ij}\) represents EW radiative corrections.
[in] | fi | a lepton or quark |
[in] | fj | a lepton or quark |
Reimplemented in NPbase, NPSMEFTd6, and NPSMEFTd6General.
Definition at line 1242 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(Z\to \ell\bar{\ell}\) partial decay width, \(\Gamma_\ell\).
When checkNPZff_linearized() returns true and the model flag NoApproximateGammaZ of StandardModel is set to false, this function uses the two-loop approximate formula of \(\Gamma_\ell\) via EWSMApproximateFormulae::X_full_2_loop(). Otherwise, the partial width is calculated with \(\rho_Z^\ell\) and \(g_{V}^\ell/g_{A}^\ell\) [Bardin:1999ak] :
\[ \Gamma_\ell = \Gamma_0 \big|\rho_Z^f\big| \sqrt{1-\frac{4m_\ell^2}{M_Z^2}} \left[ \left(1+\frac{2m_\ell^2}{M_Z^2}\right) \left(\left|\frac{g_{V}^\ell}{g_{A}^\ell}\right|^2 + 1 \right) - \frac{6m_\ell^2}{M_Z^2} \right] \left( 1 + \frac{3}{4}\frac{\alpha(M_Z^2)}{\pi}\, Q_\ell^2 \right) \]
with \(\Gamma_0=G_\mu M_Z^3/(24\sqrt{2}\pi)\).
[in] | f | a lepton or quark |
Definition at line 1357 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective (muon) neutrino-electron axial-vector coupling: gAnue.
Follows the corresponding semianalytical expression in EWSMApproximateFormulae.
Reimplemented in NPbase.
Definition at line 3068 of file StandardModel/src/StandardModel.cpp.
|
inline |
A get method to retrieve the fine-structure constant \(\alpha\).
Definition at line 789 of file StandardModel.h.
|
inline |
A get method to access the value of \(\alpha_s(M_Z)\).
Definition at line 771 of file StandardModel.h.
|
inlinevirtual |
The ratio of the absolute value of the $B_d$ mixing amplitude over the Standard Model value.
Reimplemented in NPDF2.
Definition at line 3066 of file StandardModel.h.
|
inlinevirtual |
The ratio of the absolute value of the $B_s$ mixing amplitude over the Standard Model value.
Reimplemented in NPDF2.
Definition at line 3075 of file StandardModel.h.
|
inlinevirtual |
A virtual implementation for the RealWeakEFTCC class.
Reimplemented in RealWeakEFTCC.
Definition at line 1173 of file StandardModel.h.
|
inlinevirtual |
A virtual implementation for the RealWeakEFTCC class.
Reimplemented in RealWeakEFTCC.
Definition at line 1178 of file StandardModel.h.
|
inlinevirtual |
A virtual implementation for the RealWeakEFTCC class.
Reimplemented in RealWeakEFTCC.
Definition at line 1183 of file StandardModel.h.
|
inlinevirtual |
A virtual implementation for the RealWeakEFTCC class.
Definition at line 1188 of file StandardModel.h.
|
inlinevirtual |
A virtual implementation for the RealWeakEFTCC class.
Definition at line 1193 of file StandardModel.h.
|
inlinevirtual |
The ratio of the real part of the $K$ mixing amplitude over the Standard Model value.
Reimplemented in NPDF2.
Definition at line 3084 of file StandardModel.h.
|
inlinevirtual |
The ratio of the imaginary part of the $K$ mixing amplitude over the Standard Model value.
Reimplemented in NPDF2.
Definition at line 3093 of file StandardModel.h.
|
inline |
A get method to retrieve the member object of type CKM.
Definition at line 920 of file StandardModel.h.
|
inline |
A get method to retrieve the five-flavour hadronic contribution to the electromagnetic coupling, \(\Delta\alpha_{\mathrm{had}}^{(5)}(M_Z^2)\).
Definition at line 800 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(\Gamma_Z\), denoted as \(\delta\,\Gamma_Z\).
Definition at line 862 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(M_W\), denoted as \(\delta\,M_W\).
Definition at line 819 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(R_b^0\), denoted as \(\delta\,R_b^0\).
Definition at line 902 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(R_c^0\), denoted as \(\delta\,R_c^0\).
Definition at line 892 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(R_l^0\), denoted as \(\delta\,R_l^0\).
Definition at line 882 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(\sigma_{Hadron}^0\), denoted as \(\delta\,\sigma_{Hadron}^0\).
Definition at line 872 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{b}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{b}\).
Definition at line 852 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{\rm lept}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{\rm lept}\).
Definition at line 830 of file StandardModel.h.
|
inline |
A get method to retrieve the theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{q\not = b,t}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{q\not = b,t}\).
Definition at line 841 of file StandardModel.h.
|
inline |
A method to retrieve the model flag KappaZ.
See StandardModelFlags for detail.
Definition at line 714 of file StandardModel.h.
|
inline |
A method to retrieve the model flag Mw.
See StandardModelFlags for detail.
Definition at line 694 of file StandardModel.h.
|
inline |
A method to retrieve the model flag RhoZ.
See StandardModelFlags for detail.
Definition at line 704 of file StandardModel.h.
|
inline |
Definition at line 1033 of file StandardModel.h.
|
inline |
A get method to retrieve the Fermi constant \(G_\mu\).
Definition at line 780 of file StandardModel.h.
|
protected |
Definition at line 9534 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9540 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9546 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9552 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9558 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9564 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9570 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9576 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9582 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9588 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9594 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9465 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9471 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9477 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9483 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9489 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9495 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9501 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9507 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9513 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9519 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9525 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9303 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9309 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9315 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9321 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9327 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9333 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9339 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9345 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9351 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9357 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9363 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9369 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9376 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9382 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9388 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9394 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9400 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9406 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9412 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9418 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9424 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9430 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9436 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9442 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9195 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9201 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9207 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9213 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9219 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9225 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9231 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9237 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9243 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9249 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9255 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9261 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9267 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9273 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9017 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9023 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9029 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9035 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9041 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9047 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9053 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9059 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9065 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9071 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9077 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9083 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9089 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9095 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8929 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8935 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8941 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8947 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8953 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8959 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8965 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8971 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8977 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8983 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8989 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8995 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9001 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9007 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8677 of file StandardModel/src/StandardModel.cpp.
|
protected |
|
protected |
Definition at line 8683 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8689 of file StandardModel/src/StandardModel.cpp.
|
protected |
|
protected |
Definition at line 8695 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8701 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8707 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8713 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8719 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8725 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8731 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8737 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8743 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9105 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9111 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9117 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9123 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9129 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9137 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9143 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9149 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9155 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9161 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9167 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9173 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9179 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9185 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8753 of file StandardModel/src/StandardModel.cpp.
|
protected |
|
protected |
Definition at line 8759 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8765 of file StandardModel/src/StandardModel.cpp.
|
protected |
|
protected |
Definition at line 8771 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8777 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8783 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8789 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8795 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8801 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8807 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8813 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8819 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8842 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8848 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8854 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8860 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8866 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8872 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8878 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8884 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8890 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8896 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8902 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8908 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8914 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8920 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8583 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8589 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8595 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8601 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8607 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8613 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8619 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8625 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8631 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8637 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8643 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8649 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8655 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8661 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8407 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8413 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8419 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8425 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8431 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8437 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8443 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8449 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8455 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8461 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8467 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8473 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8479 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8485 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8318 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8324 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8331 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8337 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8343 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8349 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8355 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8361 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8367 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8373 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8379 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8385 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8391 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8397 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8062 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8068 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8074 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8080 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8086 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8092 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8098 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8104 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8110 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8116 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8122 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8128 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8495 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8501 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8507 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8513 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8519 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8525 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8531 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8537 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8543 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8549 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8555 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8561 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8567 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8573 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8135 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8141 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8147 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8153 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8159 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8165 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8171 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8177 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8183 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8189 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8195 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8201 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8231 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8237 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8243 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8249 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8255 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8261 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8267 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8273 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8279 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8285 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8291 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8297 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8303 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8309 of file StandardModel/src/StandardModel.cpp.
|
inline |
Definition at line 617 of file StandardModel.h.
|
inline |
A get method to retrieve the member object of a lepton.
[in] | p | name of a lepton |
Definition at line 744 of file StandardModel.h.
|
inlinevirtual |
A get method to access the member reference of type StandardModelMatching.
Reimplemented in CMFV, FlavourWilsonCoefficient, FlavourWilsonCoefficient_DF2, LoopMediators, RealWeakEFTLFV, GeorgiMachacek, LeftRightSymmetricModel, NPSMEFTd6, NPSMEFTd6General, SUSY, SUSYMassInsertion, THDM, and THDMW.
Definition at line 965 of file StandardModel.h.
|
inlinevirtual |
A get method to retrieve the Higgs mass \(m_h\).
Reimplemented in SUSY.
Definition at line 809 of file StandardModel.h.
|
inlinevirtual |
The MSbar running quark mass computed at NLO.
q | the quark flavour |
mu | the scale at which the running mass is returned |
Definition at line 3310 of file StandardModel.h.
|
inline |
A get method to retrieve the matching scale \(\mu_W\) around the weak scale.
Definition at line 951 of file StandardModel.h.
|
inline |
A get method to access the input value of the mass of the \(W\) boson \(M_W\).
Definition at line 762 of file StandardModel.h.
|
inline |
A get method to retrieve the member pointer of type EWSMApproximateFormulae.
Definition at line 992 of file StandardModel.h.
|
inline |
A get method to retrieve the member pointer of type EWSMcache.
Definition at line 974 of file StandardModel.h.
|
inline |
Definition at line 1038 of file StandardModel.h.
|
inline |
A get method to retrieve the member pointer of type EWSMOneLoopEW,.
Definition at line 983 of file StandardModel.h.
|
inline |
Definition at line 1008 of file StandardModel.h.
|
inline |
Definition at line 1013 of file StandardModel.h.
|
inline |
Definition at line 1018 of file StandardModel.h.
|
inline |
A get method to retrieve the member pointer of type EWSMTwoFermionsLEP2.
Definition at line 1002 of file StandardModel.h.
|
inline |
Definition at line 1023 of file StandardModel.h.
|
inline |
Definition at line 1028 of file StandardModel.h.
|
inline |
A get method to access the mass of the \(Z\) boson \(M_Z\).
Definition at line 753 of file StandardModel.h.
|
inlinevirtual |
Half the relative phase of the $B_d$ mixing amplitude w.r.t. the Standard Model one.
Reimplemented in NPDF2.
Definition at line 3111 of file StandardModel.h.
|
inlinevirtual |
Half the relative phase of the $B_s$ mixing amplitude w.r.t. the Standard Model one.
Reimplemented in NPDF2.
Definition at line 3102 of file StandardModel.h.
|
inlinevirtual |
Reimplemented in NPbase.
Definition at line 956 of file StandardModel.h.
|
inline |
A get method to retrieve the object of the PMNS matrix.
Definition at line 931 of file StandardModel.h.
|
inline |
A get method to retrieve the CKM matrix.
Definition at line 911 of file StandardModel.h.
|
inline |
A get method to retrieve the Yukawa matrix of the down-type quarks, \(Y_d\).
Definition at line 3358 of file StandardModel.h.
|
inline |
A get method to retrieve the Yukawa matrix of the charged leptons, \(Y_e\).
Definition at line 3378 of file StandardModel.h.
|
inline |
A get method to retrieve the Yukawa matrix of the neutrinos, \(Y_\nu\).
Definition at line 941 of file StandardModel.h.
|
inline |
A get method to retrieve the Yukawa matrix of the up-type quarks, \(Y_u\).
Definition at line 3338 of file StandardModel.h.
|
virtual |
The effective neutrino nucleon LH coupling: gLnuN2.
Follows the corresponding semianalytical expression in EWSMApproximateFormulae.
Reimplemented in NPbase.
Definition at line 3001 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective neutrino nucleon RH coupling: gRnuN2.
Follows the corresponding semianalytical expression in EWSMApproximateFormulae.
Reimplemented in NPbase.
Definition at line 3015 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective leptonic neutral-current vector coupling \(g_V^l\) in the SM.
\[ g_V^l = g_A^l (1 - 4|Q_l|\kappa_Z^l s_W^2)\,. \]
[in] | f | a lepton or quark |
Reimplemented in NPbase, and NPEpsilons.
Definition at line 1577 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective (muon) neutrino-electron vector coupling: gVnue.
Follows the corresponding semianalytical expression in EWSMApproximateFormulae.
Reimplemented in NPbase.
Definition at line 3055 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::I_triangle_1 | ( | const double | tau, |
const double | lambda | ||
) | const |
Loop function entering in the calculation of the effective \(HZ\gamma\) coupling.
[in] |
_form#4708, \(\lambda=4 M^2/m_Z^2\), with \(M\) the mass of the particle in the loop.
Definition at line 3278 of file StandardModel/src/StandardModel.cpp.
gslpp::complex StandardModel::I_triangle_2 | ( | const double | tau, |
const double | lambda | ||
) | const |
Loop function entering in the calculation of the effective \(HZ\gamma\) coupling.
[in] |
_form#4708, \(\lambda=4 M^2/m_Z^2\), with \(M\) the mass of the particle in the loop.
Definition at line 3288 of file StandardModel/src/StandardModel.cpp.
|
virtual |
A method to initialize the model parameters.
[in] | DPars | a map of the parameters that are being updated in the Monte Carlo run (including parameters that are varied and those that are held constant) |
Reimplemented from QCD.
Reimplemented in FlavourWilsonCoefficient, LoopMediators, RealWeakEFTCC, RealWeakEFTLFV, GeneralSUSY, GeorgiMachacek, LeftRightSymmetricModel, MFV, NPSMEFTd6General, pMSSM, SUSY, SUSYMassInsertion, THDM, and THDMW.
Definition at line 196 of file StandardModel/src/StandardModel.cpp.
|
virtual |
A method to initialize the model.
This method, called via InputParser::ReadParameters(), allocates memory to the pointers defined in the current class.
< A pointer to an object of type EWSMcache.
< A pointer to an object of type EWSMOneLoopEW.
< A pointer to an object of type EWSMTwoLoopQCD.
< A pointer to an object of type EWSMThreeLoopQCD.
< A pointer to an object of type EWSMTwoLoopEW.
< A pointer to an object of type EWSMThreeLoopEW2QCD.
< A pointer to an object of type EWSMThreeLoopEW.
< A pointer to an object of type EWSMApproximateFormulae.
< A pointer to an object of type EWSMTwoFermionsLEP2.
Reimplemented in FlavourWilsonCoefficient, FlavourWilsonCoefficient_DF2, LoopMediators, RealWeakEFTCC, RealWeakEFTLFV, GeneralSUSY, GeorgiMachacek, LeftRightSymmetricModel, MFV, pMSSM, SUSY, SUSYMassInsertion, THDM, and THDMW.
Definition at line 174 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9291 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 9450 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8671 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8830 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8047 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8207 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::intMLL2eeeeus2 | ( | const double | s, |
const double | t0, | ||
const double | t1 | ||
) | const |
Definition at line 3967 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::intMLR2eeeets2 | ( | const double | s, |
const double | t0, | ||
const double | t1 | ||
) | const |
Definition at line 3923 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::intMLRtilde2eeeest2 | ( | const double | s, |
const double | t0, | ||
const double | t1 | ||
) | const |
Definition at line 3949 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::intMRR2eeeeus2 | ( | const double | s, |
const double | t0, | ||
const double | t1 | ||
) | const |
Definition at line 3992 of file StandardModel/src/StandardModel.cpp.
|
inline |
A method to retrieve the model flag NoApproximateGammaZ.
See StandardModelFlags for detail.
Definition at line 679 of file StandardModel.h.
|
inline |
A method to retrieve the model flag WithoutNonUniversalVC.
See StandardModelFlags for detail.
Definition at line 666 of file StandardModel.h.
|
inline |
A get method to retrieve the success status of the Standard Model update and matching.
Definition at line 3397 of file StandardModel.h.
|
virtual |
The effective leptonic neutral-current coupling \(\kappa_Z^l\) in the SM.
This function collects the radiative corrections to \(\kappa_Z^l\) computed via EWSMOneLoopEW, EWSMTwoLoopQCD, EWSMTwoLoopEW, EWSMThreeLoopQCD, EWSMThreeLoopEW2QCD and EWSMThreeLoopEW classes. The real part is computed with the function resumKappaZ(), while only the one-loop contribution is kept in the imaginary part.
As a part of the two-loop EW contribution, a correction associated with the product of the imaginary part of \(\Delta\alpha\) and that of \(\Pi_{Z\gamma}\) is included [Bardin:1999ak], [Bardin:1999yd] :
\begin{eqnarray} \Delta \kappa_Z^l = - \frac{1}{s_W^2}\left( \frac{\alpha(M_Z^2)}{4\pi} \right)^2 {\rm Im}\,\overline{\Pi}_{\gamma\gamma}^{\rm fer}(M_Z^2)\,\, {\rm Im}\,\overline{\Pi}_{Z\gamma}^{\rm fer}(M_Z^2) = \frac{35\alpha^2(M_Z^2)}{18 s_W^2}\, \left( 1 - \frac{8}{3}\, {\rm Re}(\kappa_Z^l) s_W^2 \right). \end{eqnarray}
[in] | f | a lepton or quark |
Reimplemented in NPbase, and NPEpsilons.
Definition at line 1653 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 6157 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 6568 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 6978 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 6983 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 7480 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 9646 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 9651 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 9656 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 9604 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 9617 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 9630 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 7977 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 7989 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 4814 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 4603 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase.
Definition at line 4083 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 5025 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 4088 of file StandardModel/src/StandardModel.cpp.
|
virtual |
Reimplemented in NPbase, and NPSTUVWXY.
Definition at line 4345 of file StandardModel/src/StandardModel.cpp.
|
inlineprotected |
Definition at line 3531 of file StandardModel.h.
const double StandardModel::MLL2eeff | ( | const Particle | f, |
const double | s, | ||
const double | t | ||
) | const |
Definition at line 3806 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::MLR2eeff | ( | const Particle | f, |
const double | s | ||
) | const |
Definition at line 3703 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::MRL2eeff | ( | const Particle | f, |
const double | s | ||
) | const |
Definition at line 3754 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::MRR2eeff | ( | const Particle | f, |
const double | s, | ||
const double | t | ||
) | const |
Definition at line 3858 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The SM prediction for the \(W\)-boson mass in the on-shell scheme, \(M_{W,\mathrm{SM}}\).
When the model flag Mw of StandardModel is set to APPROXIMATEFORMULA, the current function uses the two-loop approximate formula in EWSMApproximateFormulae::Mw(), which includes the full two-loop EW contribution of \({\cal O}(\alpha^2)\) as well as the leading \({\cal O}(G_\mu^2\alpha_s m_t^4)\) and \({\cal O}(G_\mu^3m_t^6)\) contributions.
When the model flag Mw is not set to APPROXIMATEFORMULA, the \(W\)-boson mass is computed from \(\Delta r(M_W)\) with an iterative procedure. The target accuracy of the iterative calculation is specified with the constant Mw_error. This function calls resumMw(), in which \(M_W\) is computed with a given \(\Delta r\), equivalently with \(\Delta\rho\) and \(\Delta r_{\mathrm{rem}}\)
Reimplemented in GeorgiMachacek, NPbase, NPEpsilons, NPEpsilons_pureNP, NPSMEFTd6, NPSMEFTd6General, NPZbbbar, SUSY, and THDMW.
Definition at line 1019 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::Mw_tree | ( | ) | const |
The tree-level mass of the \(W\) boson, \(M_W^{\mathrm{tree}}\).
Definition at line 997 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::MwbarFromMw | ( | const double | Mw | ) | const |
A method to convert the \(W\)-boson mass in the experimental/running-width scheme to that in the complex-pole/fixed-width scheme.
The mass parameter \(\overline{M}_W\) in the complex-pole/fixed-width scheme [Bardin:1988xt] is given by
\[ \overline{M}_{W} = M_{W} - \frac{\Gamma_{W}^2}{2M_{W}}\,, \]
where \(M_W\) and \(\Gamma_{W}\) are the mass and width of the \(W\) boson in the experimental/running-width scheme:
\[ \Gamma_W = \frac{3G_\mu M_W^3}{2\sqrt{2}\pi} \left( 1 + \frac{2\alpha_s(M_W^2)}{3\pi} \right)\,. \]
[in] | Mw | the \(W\)-boson mass in the experimental/running-width scheme |
Definition at line 1204 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::MwFromMwbar | ( | const double | Mwbar | ) | const |
A method to convert the \(W\)-boson mass in the complex-pole/fixed-width scheme to that in the experimental/running-width scheme.
The experimental mass \(M_W\) is derived
\[ M_W = \overline{M}_W + \frac{\Gamma_{W}^2}{2\overline{M}_{W}}\,, \]
where \(\overline{M}_W\) is the mass parameter in the complex-pole/fixed-width scheme [Bardin:1988xt], and \(\Gamma_{W}\) is the \(W\)-boson width in the experimental/running-width scheme:
\[ \Gamma_W = \frac{3G_\mu M_W^3}{2\sqrt{2}\pi} \left( 1 + \frac{2\alpha_s(M_W^2)}{3\pi} \right) \approx \frac{3G_\mu \overline{M}_W^3}{2\sqrt{2}\pi} \left( 1 + \frac{2\alpha_s(\overline{M}_W^2)}{3\pi} \right)\,. \]
[in] | Mwbar | the \(W\)-boson mass in the complex-pole/fixed-width scheme |
Definition at line 1213 of file StandardModel/src/StandardModel.cpp.
double StandardModel::Mzbar | ( | ) | const |
The \(Z\)-boson mass \(\overline{M}_Z\) in the complex-pole/fixed-width scheme.
The mass parameter \(\overline{M}_Z\) in the complex-pole/fixed-width scheme [Bardin:1988xt] is given by
\[ \overline{M}_{Z} = M_{Z} - \frac{\Gamma_{Z}^2}{2M_{Z}}\,, \]
where \(M_Z\) and \(\Gamma_{Z}\) are the mass and width of the \(Z\) boson in the experimental/running-width scheme:
\begin{align} \Gamma(Z\to f\bar{f}) = \frac{G_\mu M_Z^3}{24\sqrt{2}\pi} \left[ \left( \frac{v_f}{a_f} \right)^2 + 1 \right] \times \left\{ \begin{array}{ll} 1 & \mathrm{for}\quad f=\ell\,, \\[2mm] \displaystyle N_c \left( 1 + \frac{\alpha_s(M_Z^2)}{\pi} \right) & \mathrm{for}\quad f=q \end{array} \right. \end{align}
with \(v_f/a_f=1-4|Q_f|s_{W,\mathrm{tree}}^2\).
Definition at line 1187 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The number of neutrinos obtained indirectly from the measurements at the Z pole, \(N_{\nu}\).
\(N_{\nu}\) is calculated with
\[ N_{\nu} = \frac{\Gamma_\ell}{\Gamma_{\nu}}\left(\sqrt{\frac{12\pi R_\ell}{M_Z^2 \sigma_\mathrm{had}^0}}-R_\ell - 3\right)\,. \]
Reimplemented in NPbase.
Definition at line 1556 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The post-update method for StandardModel.
This method runs all the procedures that are need to be executed after the model is successfully updated. This includes
Reimplemented from QCD.
Reimplemented in FlavourWilsonCoefficient, FlavourWilsonCoefficient_DF2, LoopMediators, RealWeakEFTCC, RealWeakEFTLFV, GeneralSUSY, GeorgiMachacek, LeftRightSymmetricModel, MFV, HiggsChiral, HiggsKigen, NPd6SILH, NPEpsilons, NPSMEFTd6, NPSMEFTd6General, NPSMEFTd6U2, NPSMEFTd6U2qU1le, NPSMEFTd6U3, NPZbbbar, NPZbbbarLinearized, pMSSM, SUSY, SUSYMassInsertion, THDM, and THDMW.
Definition at line 241 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The pre-update method for StandardModel.
This method initializes the internal flags requireCKM, requireYe and requireYn, and calls QCD::PreUpdate(), before updating the model parameters with the method Update().
Reimplemented from QCD.
Reimplemented in FlavourWilsonCoefficient, LoopMediators, RealWeakEFTCC, RealWeakEFTLFV, GeneralSUSY, GeorgiMachacek, LeftRightSymmetricModel, MFV, NPSMEFTd6General, pMSSM, SUSY, SUSYMassInsertion, THDM, and THDMW.
Definition at line 214 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the electron's weak charge.
[in] | q2 | the \(Q^2\) at which the weak charge is measured |
[in] | y |
Reimplemented in NPbase.
Definition at line 2665 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the neutron weak charge: Qwn.
Follows J.Erler,A.Kurylov,M.J.Ramsey-Musolf hep-ph/0302149.
Reimplemented in NPbase.
Definition at line 2889 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the proton weak charge: Qwp.
Follows J.Erler,A.Kurylov,M.J.Ramsey-Musolf hep-ph/0302149.
Reimplemented in NPbase.
Definition at line 2781 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The ratio \(R_\ell^0=\Gamma(Z\to {\rm hadrons})/\Gamma(Z\to \ell^+ \ell^-)\).
When checkNPZff_linearized() returns true and the model flag NoApproximateGammaZ of StandardModel is set to false, this function uses the two-loop approximate formula of \(R_\ell^0\) via EWSMApproximateFormulae::X_full_2_loop(). Otherwise, \(R_\ell^0\) is calculated with
\[ R_\ell^0 = \frac{\Gamma_h}{\Gamma_\ell}\,. \]
, where \(\ell\) denotes a charged lepton.
[in] | f | a lepton or quark |
Reimplemented in NPbase, NPSMEFTd6General, NPZbbbar, and NPEpsilons.
Definition at line 1479 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The ratio of the invisible and leptonic (electron) decay widths of the \(Z\) boson, \(R_{inv}\).
\(R_{inv}\) is calculated with
\[ R_{inv} = \frac{\Gamma_{inv}}{\Gamma_e}\,. \]
,
Reimplemented in NPbase.
Definition at line 1550 of file StandardModel/src/StandardModel.cpp.
|
protected |
The radiator factor associated with the final-state QED and QCD corrections to the the axial-vector-current interactions, \(R_A^q(M_Z^2)\).
See [Chetyrkin:1994js], [Bardin:1999ak], [Bardin:1999yd], [Baikov:2012er] and references therein.
[in] | q | name of a quark (see QCD::quark) |
Definition at line 2271 of file StandardModel/src/StandardModel.cpp.
|
protected |
A method to compute the real part of the effetvive coupling \(\kappa_Z^f\) from \(\Delta\rho\), \(\delta\rho_{\rm rem}^{f}\) and \(\Delta r_{\mathrm{rem}}\).
This function computes \(\kappa_Z^f\) without or with resummation of \(\Delta\rho\), depending on the model flag KappaZ of StandardModel:
where the OMS-I, INTERMEDIATE and OMS-II schemes are adopted in ZFITTER [Bardin:1999yd] (see also [Degrassi:1996mg], [Degrassi:1996ps], [Degrassi:1999jd], [Bardin:1999ak]), and used for making comparisons to the outputs of ZFITTER. In all the cases, the two-loop EW corrections are calculated in the large- \(m_t\) expansion.
[in] | DeltaRho | Array of \(\Delta\rho\) |
[in] | deltaKappa_rem | Array of \(\delta\kappa_{\rm rem}^{f}\) |
[in] | DeltaRbar_rem | Array of \(\Delta \bar{r}_{\rm rem}\) |
[in] | bool_Zbb | true for \(Zb\bar{b}\) |
Definition at line 2036 of file StandardModel/src/StandardModel.cpp.
|
protected |
A method to compute the \(W\)-boson mass from \(\Delta\rho\) and \(\Delta r_{\mathrm{rem}}\).
This function computes the \(W\)-boson mass without or with resummation of \(\Delta r\), depending on the model flag Mw of StandardModel:
where the OMS-I, INTERMEDIATE and OMS-II schemes are adopted in ZFITTER [Bardin:1999yd] (see also [Degrassi:1996mg], [Degrassi:1996ps], [Degrassi:1999jd], [Bardin:1999ak]), and used for making comparisons to the outputs of ZFITTER. The full two-loop EW contribution is included in the case of "NORESUM", while the large- \(m_t\) expansion for the two-loop contribution is adopted in the other cases.
In the case of "NORESUM", the two-loop EW contribution to \(\Delta r\) is calculated via the function EWSMApproximateFormulae::DeltaR_TwoLoopEW_rem(), given in the complex-pole/fixed-width scheme. The \(W\)-boson mass in the complex-pole/fixed-width scheme, obtained from \(\Delta r\), is converted into the one in the experimental/running-width scheme with the function MwFromMwbar().
[in] | Mw_i | the \(W\)-boson mass |
[in] | DeltaRho | Array of \(\Delta\rho\) |
[in] | DeltaR_rem | Array of \(\Delta r_{\mathrm{rem}}\) |
Definition at line 1870 of file StandardModel/src/StandardModel.cpp.
|
protected |
A method to compute the real part of the effective coupling \(\rho_Z^f\) from \(\Delta\rho\), \(\delta\rho_{\rm rem}^{f}\) and \(\Delta r_{\mathrm{rem}}\).
This function computes \(\rho_Z^f\) without or with resummation of \(\Delta\rho\), depending on the model flag RhoZ of StandardModel:
where the OMS-I, INTERMEDIATE and OMS-II schemes are adopted in ZFITTER [Bardin:1999yd] (see also [Degrassi:1996mg], [Degrassi:1996ps], [Degrassi:1999jd], [Bardin:1999ak]), and used for making comparisons to the outputs of ZFITTER. In all the cases, the two-loop EW corrections are calculated in the large- \(m_t\) expansion.
[in] | DeltaRho | Array of \(\Delta\rho\) |
[in] | deltaRho_rem | Array of \(\delta\rho_{\rm rem}^{f}\) |
[in] | DeltaRbar_rem | Array of \(\Delta \bar{r}_{\rm rem}\) |
[in] | bool_Zbb | true for \(Zb\bar{b}\) |
Definition at line 1957 of file StandardModel/src/StandardModel.cpp.
EW radiative corrections to the width of \(W \to f_i \bar{f}_j\), denoted as \(\rho^W_{ij}\).
[in] | fi | a lepton or quark |
[in] | fj | a lepton or quark |
Definition at line 1234 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective leptonic neutral-current coupling \(\rho_Z^l\) in the SM.
This function collects the radiative corrections to \(\rho_Z^l\) computed via EWSMOneLoopEW, EWSMTwoLoopQCD, EWSMTwoLoopEW, EWSMThreeLoopQCD, EWSMThreeLoopEW2QCD and EWSMThreeLoopEW classes. The real part is computed with the function resumRhoZ(), while only the one-loop contribution is kept in the imaginary part.
[in] | f | a lepton or quark |
Reimplemented in NPbase, and NPEpsilons.
Definition at line 1588 of file StandardModel/src/StandardModel.cpp.
|
virtual |
|
protected |
The singlet vector corrections to the hadronic \(Z\)-boson width, denoted as \(R_V^h\).
In addition to the final-state corrections represented by the radiator factors \(R_V^q(M_Z^2)\) and \(R_A^q(M_Z^2)\), there exist singlet vector corrections to the total hadronic width [Chetyrkin:1994js], [Baikov:2012er], which is much smaller than the other corrections.
The assignment of the singlet vector corrections to the partial widths is ambiguous [Bardin:1997xq]. See Gamma_had() for our prescription.
Definition at line 2408 of file StandardModel/src/StandardModel.cpp.
|
protected |
The radiator factor associated with the final-state QED and QCD corrections to the the vector-current interactions, \(R_V^q(M_Z^2)\).
See [Chetyrkin:1994js], [Bardin:1999ak], [Bardin:1999yd] and references therein.
[in] | q | name of a quark (see QCD::quark) |
Definition at line 2151 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The ratio \(R_{W,c)=\Gamma(W\to c + X)/\Gamma(W\to had)\).
Reimplemented in NPbase, NPSMEFTd6, and NPSMEFTd6General.
Definition at line 1322 of file StandardModel/src/StandardModel.cpp.
The lepton universality ratio \(R_{W,l_i/l_j)=\Gamma(W\to l_i \nu_i)/\Gamma(W\to l_j \nu_j)\).
Reimplemented in NPbase, NPSMEFTd6, and NPSMEFTd6General.
Definition at line 1292 of file StandardModel/src/StandardModel.cpp.
The lepton universality ratio \(R_{Z,l_i/l_j)=\Gamma(Z\to l_i^+ l_i^-)/\Gamma(Z\to l_j^+ l_j^-)\).
Reimplemented in NPbase, NPSMEFTd6, and NPSMEFTd6General.
Definition at line 1447 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::s02 | ( | ) | const |
The square of the sine of the weak mixing angle \(s_0^2\) defined without weak radiative corrections.
The quantity \(s_0^2\) is defined through
\[ s_0^2 c_0^2 = \frac{\pi\,\alpha(M_Z^2)}{\sqrt{2}\,G_\mu M_Z^2} \ \ \rightarrow\ \ s_0^2 = \frac{1}{2} \left(1 - \sqrt{1 - \frac{4\pi \alpha(M_Z^2)}{\sqrt{2}\,G_\mu M_Z^2}}\ \right)\,. \]
See [Altarelli:1990zd] and [Altarelli:1991fk].
Definition at line 1005 of file StandardModel/src/StandardModel.cpp.
|
inlineprotected |
A method to convert a given scheme name in string form into a floating-point number with double precision.
This method is used in EWSM::checkSMparams() for caching the schemes used in computing \(M_W\), \(\rho_Z^f\) and \(\kappa_Z^f\).
[in] | scheme | scheme name that is used in computing \(M_W\), \(\rho_Z^f\) or \(\kappa_Z^f\) |
Definition at line 3497 of file StandardModel.h.
|
inline |
A set method to change the CKM matrix.
[in] | CKMMatrix | a reference to the new CKM matrix |
Definition at line 3328 of file StandardModel.h.
|
virtual |
A method to set a flag of StandardModel.
[in] | name | name of a model flag |
[in] | value | the boolean to be assigned to the flag specified by name |
Reimplemented from QCD.
Reimplemented in FlavourWilsonCoefficient, LoopMediators, RealWeakEFTCC, RealWeakEFTLFV, HiggsChiral, HiggsKigen, NPbase, NPd6SILH, NPEpsilons, NPSMEFTd6, NPSMEFTd6General, THDM, GeorgiMachacek, LeftRightSymmetricModel, NPSMEFT6dtopquark, and SUSY.
Definition at line 443 of file StandardModel/src/StandardModel.cpp.
|
inline |
A set method to change the model flag CacheInStandardModel of StandardModel.
Setting CacheInStandardModel to false, the caching methods defined in the current class are not employed in numerical computations. The flag is set to true in the constructor EWSM() by default.
[in] | FlagCacheInStandardModel | true (false) if the caching methods are turned on (off); |
Definition at line 730 of file StandardModel.h.
|
inline |
Definition at line 684 of file StandardModel.h.
|
inline |
Definition at line 3292 of file StandardModel.h.
|
inline |
Definition at line 3298 of file StandardModel.h.
|
virtual |
A method to set a flag of StandardModel.
[in] | name | name of a model flag |
[in] | value | the string to be assigned to the flag specified by name |
Reimplemented from QCD.
Reimplemented in LeftRightSymmetricModel, NPSMEFTd6General, THDM, and THDMW.
Definition at line 508 of file StandardModel/src/StandardModel.cpp.
|
protectedvirtual |
A method to set the value of a parameter of StandardModel.
[in] | name | name of a model parameter |
[in] | value | the value to be assigned to the parameter specified by name |
Reimplemented from QCD.
Reimplemented in NPDF2, HiggsChiral, HiggsKigen, NPd6SILH, NPEpsilons, NPEpsilons_pureNP, NPHiggs, NPSMEFT6dtopquark, NPSMEFTd6, NPSMEFTd6General, NPSMEFTd6U2, NPSMEFTd6U2qU1le, NPSMEFTd6U3, NPSTU, NPSTUVWXY, NPSTUZbbbarLR, NPZbbbar, NPZbbbarLinearized, SigmaBR, SUSY, THDM, CMFV, FlavourWilsonCoefficient, FlavourWilsonCoefficient_DF2, GeneralSUSY, GeorgiMachacek, LeftRightSymmetricModel, MFV, pMSSM, SUSYMassInsertion, and THDMW.
Definition at line 278 of file StandardModel/src/StandardModel.cpp.
|
inline |
A set method to change the value of requireCKM.
[in] | requireCKM | the new value for requireCKM |
Definition at line 3319 of file StandardModel.h.
|
inline |
A set method to change the success status of the Standard Model update and matching.
[in] | success | the new value for SMSuccess |
Definition at line 3406 of file StandardModel.h.
|
inline |
A set method to set the Yukawa matrix of the down-type quarks, \(Y_d\).
[in] | Yd | the Yukawa matrix to be set |
Definition at line 3368 of file StandardModel.h.
|
inline |
A set method to set the Yukawa matrix of the charged leptons, \(Y_e\).
[in] | Ye | the Yukawa matrix to be set |
Definition at line 3388 of file StandardModel.h.
|
inline |
A set method to set the Yukawa matrix of the up-type quarks, \(Y_u\).
[in] | Yu | the Yukawa matrix to be set |
Definition at line 3348 of file StandardModel.h.
|
virtual |
The hadronic cross section for \(e^+e^- \to Z \to \mathrm{hadrons}\) at the \(Z\)-pole, \(\sigma_h^0\).
When checkNPZff_linearized() returns true and the model flag NoApproximateGammaZ of StandardModel is set to false, this function uses the two-loop approximate formula of \(\sigma_h^0\) via EWSMApproximateFormulae::X_full_2_loop(). Otherwise, the hadronic cross section is calculated with
\[ \sigma_h^0 = \frac{12\pi}{M_Z^2}\frac{\Gamma_e\Gamma_h}{\Gamma_Z^2}\,. \]
Reimplemented in NPbase, NPEpsilons, NPSMEFTd6General, and NPZbbbar.
Definition at line 1465 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8001 of file StandardModel/src/StandardModel.cpp.
|
protected |
Definition at line 8013 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\sigma(e^+ e^- \to e^+ e^- H)\) in the Standard Model.
Currently, only at tree level. From https://arxiv.org/pdf/hep-ph/9605437
Definition at line 3351 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\sigma(e^+ e^- \to \nu \bar{\nu} H)\) in the Standard Model.
Currently, only at tree level. From https://arxiv.org/pdf/hep-ph/9605437
Definition at line 3344 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The \(\sigma(e^+ e^- \to Z H)\) in the Standard Model.
Currently, only at tree level. From https://arxiv.org/pdf/hep-ph/9605437
Definition at line 3322 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective weak mixing angle \(\sin^2\theta_{\rm eff}^{\,\ell}\) for \(Z\ell\bar{\ell}\) at the the \(Z\)-mass scale.
When checkNPZff_linearized() returns true and the model flag KappaZ of StandardModel is set to APPROXIMATEFORMULA, this function uses the two-loop approximate formula of \(\sin^2\theta_{\rm eff}^{\,\ell}\) via EWSMApproximateFormulae::sin2thetaEff(). Otherwise, the effective weak mixing angle is calculated from the coupling \(\kappa_Z^\ell\):
\[ \sin^2\theta_{\rm eff}^{\,\ell} = {\rm Re}(\kappa_Z^\ell)\,s_W^2\,. \]
[in] | f | a lepton or quark |
Reimplemented in NPbase, NPZbbbar, and NPEpsilons.
Definition at line 1351 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::sW2 | ( | ) | const |
Definition at line 1092 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The square of the sine of the weak mixing angle in the on-shell scheme, denoted as \(s_W^2\).
\[ s_W^2=\sin^2{\theta_W}=1-\frac{M_W^2}{M_Z^2}. \]
Definition at line 1087 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::sW2_MSbar_Approx | ( | ) | const |
The (approximated formula for the) square of the sine of the weak mixing angle in the MSbar scheme, denoted as \(\hat{s}_{W}^2\). See: PDG 22, R.L. Workman et al. (Particle Data Group), Prog. Theor. Exp. Phys. 2022, 083C01 (2022)
Definition at line 1097 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::sW2_ND | ( | ) | const |
The square of the sine of the weak mixing angle in the MSbar-ND scheme (w/o decoupling $\alpha\ln(m_t/M_Z)$ terms), denoted as \(\hat{s}_{ND}^2\). See: PDG 22, R.L. Workman et al. (Particle Data Group), Prog. Theor. Exp. Phys. 2022, 083C01 (2022) (eq. 10.13a/10.13b)
Definition at line 1103 of file StandardModel/src/StandardModel.cpp.
|
protected |
Top-mass corrections to the \(Zb\bar{b}\) vertex, denoted by \(\tau_b\).
The large top-quark mass gives important corrections to the EW observables through the gauge-boson self-energies, i.e., \(\Delta\rho\), and through the \(Zb\bar{b}\) vertex. The latter contribution is parameterised by the quantity \(\tau_b\):
\[ \tau_{b} = -2\, X_t^{G_\mu} \left[ 1 - \frac{\pi}{3}\alpha_s(M^2_t) + X_t^{G_\mu} \tau^{(2)} \left( \frac{M_t^2}{m_h^2} \right) \right], \]
where the \(O(G_\mu\alpha_s m_t^2)\) term was calculated in [Fleischer:1992fq], [Buchalla:1992zm], [Degrassi:1993ij], [Chetyrkin:1993jp], and the \(O(G_\mu^2 m_t^4)\) term can be found in [Barbieri:1992nz], [Barbieri:1992dq], [Fleischer:1993ub], [Fleischer:1994cb].
Definition at line 2113 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the LFU ratio \(g_\mu/ g_e \).
Reimplemented in NPbase.
Definition at line 3165 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the LFU ratio \(g_\tau/ g_e \).
Reimplemented in NPbase.
Definition at line 3211 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the LFU ratio \(g_\tau/ g_\mu \).
Reimplemented in NPbase.
Definition at line 3188 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the LFU ratio \(\left(g_\tau/ g_\mu\right)_K \).
Reimplemented in NPbase.
Definition at line 3242 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The computation of the LFU ratio \(\left(g_\tau/ g_\mu\right)_\pi \).
Reimplemented in NPbase.
Definition at line 3235 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective neutrino nucleon LH parameter: ThetaLnuN.
Follows the corresponding semianalytical expression in EWSMApproximateFormulae.
Definition at line 3028 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The effective neutrino nucleon RH parameter: ThetaRnuN.
Follows the corresponding semianalytical expression in EWSMApproximateFormulae.
Definition at line 3042 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::tovers2 | ( | const double | cosmin, |
const double | cosmax | ||
) | const |
Definition at line 3912 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::uovers2 | ( | const double | cosmin, |
const double | cosmax | ||
) | const |
Definition at line 3916 of file StandardModel/src/StandardModel.cpp.
|
virtual |
The update method for StandardModel.
This method updates all the model parameters with given DPars.
[in] | DPars | a map of the parameters that are being updated in the Monte Carlo run (including parameters that are varied and those that are held constant) |
Reimplemented from QCD.
Reimplemented in FlavourWilsonCoefficient, LoopMediators, RealWeakEFTCC, RealWeakEFTLFV, GeneralSUSY, GeorgiMachacek, LeftRightSymmetricModel, MFV, NPbase, pMSSM, SUSY, SUSYMassInsertion, THDM, and THDMW.
Definition at line 225 of file StandardModel/src/StandardModel.cpp.
const double StandardModel::v | ( | ) | const |
The Higgs vacuum expectation value.
\[ v = \left(\frac{1}{\sqrt{2} G_\mu}\right)^{1/2}, \]
where \(G_\mu\) is the Fermi constant, measured through muon decays.
Definition at line 989 of file StandardModel/src/StandardModel.cpp.
|
protected |
The CKM parameter \(A\) in the Wolfenstein parameterization.
Definition at line 3462 of file StandardModel.h.
|
protected |
The fine-structure constant \(\alpha\).
Definition at line 3449 of file StandardModel.h.
|
mutableprivate |
Cache for \(\alpha_e\).
Definition at line 4080 of file StandardModel.h.
|
protected |
Definition at line 3471 of file StandardModel.h.
|
protected |
Definition at line 3471 of file StandardModel.h.
|
mutableprivate |
Cache for \(\alpha_s\).
Definition at line 4079 of file StandardModel.h.
|
protected |
The strong coupling constant at the Z-boson mass, \(\alpha_s(M_Z)\).
Definition at line 3445 of file StandardModel.h.
|
mutableprivate |
GSL integral variable
Definition at line 4065 of file StandardModel.h.
|
mutableprotected |
Definition at line 3729 of file StandardModel.h.
|
mutableprotected |
Definition at line 3730 of file StandardModel.h.
|
staticprivate |
Defines the depth of the cache.
Definition at line 4078 of file StandardModel.h.
|
protected |
The five-flavour hadronic contribution to the electromagnetic coupling, \(\Delta\alpha_{\mathrm{had}}^{(5)}(M_Z^2)\). (Non-input parameter)
Definition at line 3474 of file StandardModel.h.
|
protected |
The five-flavour hadronic contribution to the electromagnetic coupling, \(\Delta\alpha_{\mathrm{had}}^{(5)}(M_Z^2)\), used as input for FlagMWinput = FALSE.
Definition at line 3450 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(\Gamma_Z\), denoted as \(\delta\,\Gamma_Z\), in GeV.
Definition at line 3456 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(M_W\), denoted as \(\delta\,M_W\), in GeV.
Definition at line 3452 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(R_b^0\), denoted as \(\delta\,R_b^0\).
Definition at line 3460 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(R_c^0\), denoted as \(\delta\,R_c^0\).
Definition at line 3459 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(R_l^0\), denoted as \(\delta\,R_l^0\).
Definition at line 3458 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(\sigma_{Hadron}^0\), denoted as \(\delta\,\sigma_{Hadron}^0\) in nb.
Definition at line 3457 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{b}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{b}\).
Definition at line 3455 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{\rm lept}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{\rm lept}\).
Definition at line 3453 of file StandardModel.h.
|
protected |
The theoretical uncertainty in \(\sin^2\theta_{\rm eff}^{q\not = b,t}\), denoted as \(\delta\sin^2\theta_{\rm eff}^{q\not = b,t}\).
Definition at line 3454 of file StandardModel.h.
|
protected |
Definition at line 3471 of file StandardModel.h.
|
mutableprivate |
A cache of the value of \(\Delta\alpha(M_Z^2)\).
Definition at line 4046 of file StandardModel.h.
|
mutableprivate |
A cache of the value of \(\Delta\alpha_{\mathrm{lept}}(M_Z^2)\).
Definition at line 4045 of file StandardModel.h.
|
mutableprivate |
GSL integral variable
Definition at line 4066 of file StandardModel.h.
|
protected |
The CKM parameter \(\bar{\eta}\) in the Wolfenstein parameterization.
Definition at line 3464 of file StandardModel.h.
|
mutableprivate |
GSL integral variable
Definition at line 4067 of file StandardModel.h.
|
protected |
An array of internal flags controlling the inclusions of higher-order corrections.
These flags are prepared for debugging. The flags are initialized in the constructor EWSM().
Definition at line 3485 of file StandardModel.h.
|
private |
A flag for caching (true by default).
Definition at line 4043 of file StandardModel.h.
|
protected |
A boolean for the model flag FixMuwMut.
Definition at line 3719 of file StandardModel.h.
|
private |
A string for the model flag KappaZ.
Definition at line 4031 of file StandardModel.h.
|
protected |
Definition at line 3728 of file StandardModel.h.
|
private |
A string for the model flag Mw.
Definition at line 4029 of file StandardModel.h.
|
private |
A boolean for the model flag MWinput.
Definition at line 4035 of file StandardModel.h.
|
private |
A boolean for the model flag NoApproximateGammaZ.
Definition at line 4028 of file StandardModel.h.
|
private |
A string for the model flag RhoZ.
Definition at line 4030 of file StandardModel.h.
|
private |
A boolean for the model flag SMAux.
Definition at line 4036 of file StandardModel.h.
|
private |
A boolean for the model flag UseVud.
Definition at line 4033 of file StandardModel.h.
|
private |
A boolean for the model flag WithoutNonUniversalVC.
Definition at line 4027 of file StandardModel.h.
|
private |
A boolean for the model flag Wolfenstein.
Definition at line 4032 of file StandardModel.h.
|
protected |
\(\gamma \) used as an input for FlagWolfenstein = FALSE
Definition at line 3469 of file StandardModel.h.
|
mutableprivate |
A cache of the value of \(\Gamma_W\).
Definition at line 4048 of file StandardModel.h.
|
static |
Definition at line 546 of file StandardModel.h.
|
protected |
The Fermi constant \(G_\mu\) in \({\rm GeV}^{-2}\).
Definition at line 3448 of file StandardModel.h.
|
private |
Definition at line 4071 of file StandardModel.h.
|
mutableprivate |
A cache of the value of \(\kappa_Z^l\).
Definition at line 4050 of file StandardModel.h.
|
protected |
The CKM parameter \(\lambda\) in the Wolfenstein parameterization.
Definition at line 3461 of file StandardModel.h.
|
protected |
An array of Particle objects for the leptons.
Definition at line 3432 of file StandardModel.h.
|
protected |
The Higgs mass \(m_h\) in GeV.
Definition at line 3451 of file StandardModel.h.
|
protected |
A matching scale \(\mu_W\) around the weak scale in GeV.
Definition at line 3470 of file StandardModel.h.
|
mutableprivate |
A cache of the value of \(M_W\).
Definition at line 4047 of file StandardModel.h.
|
static |
The target accuracy of the iterative calculation of the \(W\)-boson mass in units of GeV.
Definition at line 552 of file StandardModel.h.
|
protected |
The mass of the \(W\) boson in GeV used as input for FlagMWinput = TRUE.
Definition at line 3447 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMApproximateFormulae.
Definition at line 4021 of file StandardModel.h.
|
protected |
An object of type CKM.
Definition at line 3433 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMcache.
Definition at line 4014 of file StandardModel.h.
|
private |
A pointer to an object of the type LeptonFlavour.
Definition at line 4022 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMOneLoopEW.
Definition at line 4015 of file StandardModel.h.
|
protected |
Definition at line 3434 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMThreeLoopEW.
Definition at line 4020 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMThreeLoopEW2QCD.
Definition at line 4019 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMThreeLoopQCD.
Definition at line 4017 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMTwoFermionsLEP2.
Definition at line 4024 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMTwoLoopEW.
Definition at line 4018 of file StandardModel.h.
|
private |
A pointer to an object of type EWSMTwoLoopQCD.
Definition at line 4016 of file StandardModel.h.
|
protected |
The mass of the \(Z\) boson in GeV.
Definition at line 3446 of file StandardModel.h.
|
static |
The number of the model parameters in StandardModel.
Definition at line 540 of file StandardModel.h.
|
static |
The number of the SM parameters that are relevant to the EW precision observables.
This constant is used for the cashing method.
Definition at line 2100 of file StandardModel.h.
|
mutableprivate |
Definition at line 4081 of file StandardModel.h.
|
protected |
An internal flag to control whether the CKM matrix has to be recomputed.
Definition at line 3714 of file StandardModel.h.
|
protected |
An internal flag to control whether the charged-lepton Yukawa matrix has to be recomputed.
Definition at line 3715 of file StandardModel.h.
|
protected |
An internal flag to control whether the neutrino Yukawa matrix has to be recomputed.
Definition at line 3716 of file StandardModel.h.
|
protected |
The CKM parameter \(\bar{\rho}\) in the Wolfenstein parameterization.
Definition at line 3463 of file StandardModel.h.
|
mutableprivate |
A cache of the value of \(\rho_Z^l\).
Definition at line 4049 of file StandardModel.h.
|
protected |
Definition at line 3471 of file StandardModel.h.
|
protected |
Definition at line 3471 of file StandardModel.h.
|
protected |
Definition at line 3471 of file StandardModel.h.
|
protected |
An object of type Flavour.
Definition at line 3718 of file StandardModel.h.
|
mutableprotected |
An object of type Matching.
Definition at line 3437 of file StandardModel.h.
|
mutableprivate |
Definition at line 4044 of file StandardModel.h.
|
mutableprivate |
Definition at line 4061 of file StandardModel.h.
|
mutableprivate |
A boolean for the success of the Standard Model update and matching.
Definition at line 4038 of file StandardModel.h.
|
static |
A string array containing the labels of the model parameters in StandardModel.
Definition at line 544 of file StandardModel.h.
|
mutableprivate |
Definition at line 4052 of file StandardModel.h.
|
mutableprivate |
Definition at line 4051 of file StandardModel.h.
|
mutableprivate |
Definition at line 4054 of file StandardModel.h.
|
mutableprivate |
Definition at line 4056 of file StandardModel.h.
|
mutableprivate |
Definition at line 4053 of file StandardModel.h.
|
mutableprivate |
Definition at line 4055 of file StandardModel.h.
|
protected |
\(\vert V_{cb} \vert \) used as an input for FlagWolfenstein = FALSE
Definition at line 3467 of file StandardModel.h.
|
protected |
\(\vert V_{ub} \vert \) used as an input for FlagWolfenstein = FALSE
Definition at line 3468 of file StandardModel.h.
|
protected |
\(\vert V_{ud} \vert \) used as an input for FlagWolfenstein = FALSE and FlagUseVud = TRUE
Definition at line 3466 of file StandardModel.h.
|
protected |
\(\vert V_{us} \vert \) used as an input for FlagWolfenstein = FALSE
Definition at line 3465 of file StandardModel.h.
|
private |
GSL integral variable
Definition at line 4068 of file StandardModel.h.
|
protected |
The Yukawa matrix of the down-type quarks.
Definition at line 3439 of file StandardModel.h.
|
protected |
The Yukawa matrix of the charged leptons.
Definition at line 3441 of file StandardModel.h.
|
protected |
The Yukawa matrix of the neutrinos.
Definition at line 3440 of file StandardModel.h.
|
protected |
The Yukawa matrix of the up-type quarks.
Definition at line 3438 of file StandardModel.h.