Herwig 7.3.0
|
The MEPP2Higgs class implements the matrix element for the process pp->Higgs with different Higgs shape prescriptions (see details in hep-ph/9505211) and the NLL corrected Higgs width (see details in the FORTRAN HERWIG manual). More...
#include <MEPP2Higgs.h>
Public Member Functions | |
MEPP2Higgs () | |
The default constructor. | |
virtual CrossSection | dSigHatDR () const |
Return the matrix element for the kinematical configuation previously provided by the last call to setKinematics(). | |
virtual void | setKinematics () |
Set the typed and momenta of the incoming and outgoing partons to be used in subsequent calls to me() and colourGeometries() according to the associated XComb object. | |
Member functions for the generation of hard QCD radiation | |
virtual POWHEGType | hasPOWHEGCorrection () |
Has a POWHEG style correction. | |
virtual bool | hasMECorrection () |
Has an old fashioned ME correction. | |
virtual void | initializeMECorrection (RealEmissionProcessPtr, double &, double &) |
Initialize the ME correction. | |
virtual RealEmissionProcessPtr | applyHardMatrixElementCorrection (RealEmissionProcessPtr) |
Apply the hard matrix element correction to a given hard process or decay. | |
virtual bool | softMatrixElementVeto (PPtr parent, PPtr progenitor, const bool &fs, const Energy &highestpT, const vector< tcPDPtr > &ids, const double &z, const Energy &scale, const Energy &pT) |
Apply the soft matrix element correction. | |
virtual RealEmissionProcessPtr | generateHardest (RealEmissionProcessPtr, ShowerInteraction) |
Apply the POWHEG style correction. | |
Virtual functions required by the MEBase class. | |
virtual unsigned int | orderInAlphaS () const |
Return the order in \(\alpha_S\) in which this matrix element is given. | |
virtual unsigned int | orderInAlphaEW () const |
Return the order in \(\alpha_{EW}\) in which this matrix element is given. | |
virtual double | me2 () const |
The matrix element for the kinematical configuration previously provided by the last call to setKinematics(), suitably scaled by sHat() to give a dimension-less number. | |
virtual bool | generateKinematics (const double *r) |
Generate internal degrees of freedom given nDim() uniform random numbers in the interval \( ]0,1[ \). | |
virtual Energy2 | scale () const |
Return the scale associated with the last set phase space point. | |
virtual int | nDim () const |
The number of internal degrees of freedom used in the matrix element. | |
virtual void | getDiagrams () const |
Add all possible diagrams with the add() function. | |
virtual Selector< DiagramIndex > | diagrams (const DiagramVector &dv) const |
Get diagram selector. | |
virtual Selector< const ColourLines * > | colourGeometries (tcDiagPtr diag) const |
Return a Selector with possible colour geometries for the selected diagram weighted by their relative probabilities. | |
virtual void | constructVertex (tSubProPtr) |
Construct the vertex of spin correlations. | |
Public Member Functions inherited from Herwig::HwMEBase | |
HwMEBase () | |
Default constructor. | |
void | persistentOutput (PersistentOStream &os) const |
Function used to write out object persistently. | |
void | persistentInput (PersistentIStream &is, int version) |
Function used to read in object persistently. | |
Public Member Functions inherited from ThePEG::MEBase | |
virtual unsigned int | orderInAlphaS () const=0 |
virtual unsigned int | orderInAlphaEW () const=0 |
virtual double | me2 () const=0 |
virtual Energy2 | scale () const=0 |
virtual double | alphaS () const |
virtual double | alphaEM () const |
void | setKinematics (tPPair in, const PVector &out) |
virtual void | setKinematics () |
virtual void | constructVertex (tSubProPtr sub) |
virtual void | constructVertex (tSubProPtr sub, const ColourLines *cl) |
virtual int | nDim () const |
virtual bool | generateKinematics (const double *r)=0 |
virtual bool | wantCMS () const |
virtual bool | headCuts () const |
virtual bool | ignoreCuts () const |
virtual bool | apply () const |
virtual CrossSection | dSigHatDR () const=0 |
virtual map< string, double > | generateOptionalWeights () |
virtual bool | haveX1X2 () const |
virtual bool | havePDFWeight1 () const |
virtual bool | havePDFWeight2 () const |
virtual bool | keepRandomNumbers () const |
virtual void | generateSubCollision (SubProcess &) |
virtual void | clearKinematics () |
virtual void | getDiagrams () const=0 |
virtual bool | noMirror () const |
const DiagramVector & | diagrams () const |
virtual Selector< const ColourLines * > | colourGeometries (tcDiagPtr diag) const=0 |
virtual const ColourLines & | selectColourGeometry (tcDiagPtr diag) const |
virtual Selector< DiagramIndex > | diagrams (const DiagramVector &) const |
virtual DiagramIndex | diagram (const DiagramVector &) const |
bool | reweighted () const |
double | reWeight () const |
double | preWeight () const |
void | addReweighter (tReweightPtr rw) |
void | addPreweighter (tReweightPtr rw) |
Ptr< Amplitude >::pointer | amplitude () const |
void | amplitude (Ptr< Amplitude >::pointer amp) |
Energy2 | sHat () const |
double | preweight () const |
virtual void | flushCaches () |
virtual StdXCombPtr | makeXComb (Energy newMaxEnergy, const cPDPair &inc, tEHPtr newEventHandler, tSubHdlPtr newSubProcessHandler, tPExtrPtr newExtractor, tCascHdlPtr newCKKW, const PBPair &newPartonBins, tCutsPtr newCuts, const DiagramVector &newDiagrams, bool mir, const PartonPairVec &allPBins, tStdXCombPtr newHead=tStdXCombPtr(), tMEPtr newME=tMEPtr()) |
virtual StdXCombPtr | makeXComb (tStdXCombPtr newHead, const PBPair &newPartonBins, const DiagramVector &newDiagrams, tMEPtr newME=tMEPtr()) |
virtual void | fillProjectors () |
virtual void | setXComb (tStdXCombPtr) |
const DVector & | meInfo () const |
void | meInfo (const DVector &info) const |
virtual int | maxMultCKKW () const |
virtual int | minMultCKKW () const |
virtual void | maxMultCKKW (int mult) |
virtual void | minMultCKKW (int mult) |
virtual void | setVetoScales (tSubProPtr) const |
virtual unsigned int | orderInAlphaS () const=0 |
virtual unsigned int | orderInAlphaEW () const=0 |
virtual double | me2 () const=0 |
virtual Energy2 | scale () const=0 |
virtual double | alphaS () const |
virtual double | alphaEM () const |
void | setKinematics (tPPair in, const PVector &out) |
virtual void | setKinematics () |
virtual void | constructVertex (tSubProPtr sub) |
virtual void | constructVertex (tSubProPtr sub, const ColourLines *cl) |
virtual int | nDim () const |
virtual bool | generateKinematics (const double *r)=0 |
virtual bool | wantCMS () const |
virtual bool | headCuts () const |
virtual bool | ignoreCuts () const |
virtual bool | apply () const |
virtual CrossSection | dSigHatDR () const=0 |
virtual map< string, double > | generateOptionalWeights () |
virtual bool | haveX1X2 () const |
virtual bool | havePDFWeight1 () const |
virtual bool | havePDFWeight2 () const |
virtual bool | keepRandomNumbers () const |
virtual void | generateSubCollision (SubProcess &) |
virtual void | clearKinematics () |
virtual void | getDiagrams () const=0 |
virtual bool | noMirror () const |
const DiagramVector & | diagrams () const |
virtual Selector< const ColourLines * > | colourGeometries (tcDiagPtr diag) const=0 |
virtual const ColourLines & | selectColourGeometry (tcDiagPtr diag) const |
virtual Selector< DiagramIndex > | diagrams (const DiagramVector &) const |
virtual DiagramIndex | diagram (const DiagramVector &) const |
bool | reweighted () const |
double | reWeight () const |
double | preWeight () const |
void | addReweighter (tReweightPtr rw) |
void | addPreweighter (tReweightPtr rw) |
Ptr< Amplitude >::pointer | amplitude () const |
void | amplitude (Ptr< Amplitude >::pointer amp) |
Energy2 | sHat () const |
double | preweight () const |
virtual void | flushCaches () |
virtual StdXCombPtr | makeXComb (Energy newMaxEnergy, const cPDPair &inc, tEHPtr newEventHandler, tSubHdlPtr newSubProcessHandler, tPExtrPtr newExtractor, tCascHdlPtr newCKKW, const PBPair &newPartonBins, tCutsPtr newCuts, const DiagramVector &newDiagrams, bool mir, const PartonPairVec &allPBins, tStdXCombPtr newHead=tStdXCombPtr(), tMEPtr newME=tMEPtr()) |
virtual StdXCombPtr | makeXComb (tStdXCombPtr newHead, const PBPair &newPartonBins, const DiagramVector &newDiagrams, tMEPtr newME=tMEPtr()) |
virtual void | fillProjectors () |
virtual void | setXComb (tStdXCombPtr) |
const DVector & | meInfo () const |
void | meInfo (const DVector &info) const |
virtual int | maxMultCKKW () const |
virtual int | minMultCKKW () const |
virtual void | maxMultCKKW (int mult) |
virtual void | minMultCKKW (int mult) |
virtual void | setVetoScales (tSubProPtr) const |
void | persistentOutput (PersistentOStream &os) const |
void | persistentInput (PersistentIStream &is, int version) |
Public Member Functions inherited from ThePEG::HandlerBaseT< UseRandom > | |
double | rnd () const |
double | rnd (double xu) const |
double | rnd (double xl, double xu) const |
bool | rndbool () const |
bool | rndbool (double p) const |
bool | rndbool (double p1, double p2) const |
int | rndsign (double p1, double p2, double p3) const |
int | rnd2 (double p0, double p1) const |
int | rnd3 (double p0, double p1, double p2) const |
int | rnd4 (double p0, double p1, double p2, double p3) const |
long | irnd (long xu=2) const |
long | irnd (long xl, long xu) const |
const StandardModelBase & | SM () const |
tSMPtr | standardModel () const |
Public Member Functions inherited from ThePEG::Interfaced | |
virtual bool | defaultInit () |
PPtr | getParticle (PID) const |
PDPtr | getParticleData (PID) const |
bool | used () const |
void | useMe () const |
tEGPtr | generator () const |
void | persistentOutput (PersistentOStream &os) const |
void | persistentInput (PersistentIStream &is, int version) |
PPtr | getParticle (PID) const |
PDPtr | getParticleData (PID) const |
bool | used () const |
void | useMe () const |
tEGPtr | generator () const |
Public Member Functions inherited from ThePEG::InterfacedBase | |
string | fullName () const |
string | name () const |
string | path () const |
string | comment () const |
void | setup (istream &is) |
void | update () |
void | init () |
virtual bool | preInitialize () const |
void | initrun () |
void | finish () |
void | touch () |
void | reset () |
void | clear () |
InitState | state () const |
bool | locked () const |
bool | touched () const |
virtual IBPtr | fullclone () const |
void | persistentOutput (PersistentOStream &os) const |
void | persistentInput (PersistentIStream &is, int version) |
virtual void | debugme () const |
void | update () |
void | init () |
virtual bool | preInitialize () const |
void | initrun () |
void | finish () |
void | touch () |
void | reset () |
void | clear () |
InitState | state () const |
bool | locked () const |
bool | touched () const |
virtual IBPtr | fullclone () const |
Public Member Functions inherited from ThePEG::Base | |
void | debug () const |
virtual void | debugme () const |
Public Member Functions inherited from ThePEG::Pointer::ReferenceCounted | |
CounterType | referenceCount () const |
Public Member Functions inherited from ThePEG::Named | |
Named (const string &newName=string()) | |
Named (const Named &)=default | |
const string & | name () const |
bool | operator== (const Named &other) const |
bool | operator< (const Named &other) const |
Public Member Functions inherited from ThePEG::LastXCombInfo< StandardXComb > | |
const XC & | lastXComb () const |
const XC & | lastXComb () const |
tXCPtr | lastXCombPtr () const |
tXCPtr | lastXCombPtr () const |
const XC & | lastHeadXComb () const |
const XC & | lastHeadXComb () const |
tXCPtr | lastHeadXCombPtr () const |
tXCPtr | lastHeadXCombPtr () const |
const EventHandler & | lastEventHandler () const |
const EventHandler & | lastEventHandler () const |
tPExtrPtr | lastExtractor () const |
tPExtrPtr | lastExtractor () const |
PDFT | pdf (tcPPtr parton) const |
PDFT | pdf (tcPPtr parton) const |
const Cuts & | lastCuts () const |
const Cuts & | lastCuts () const |
tCutsPtr | lastCutsPtr () const |
tCutsPtr | lastCutsPtr () const |
const PPair & | lastParticles () const |
const PPair & | lastParticles () const |
Energy2 | lastS () const |
Energy2 | lastS () const |
const PPair & | lastPartons () const |
const PPair & | lastPartons () const |
Energy2 | lastSHat () const |
Energy2 | lastSHat () const |
double | lastTau () const |
double | lastTau () const |
double | lastY () const |
double | lastY () const |
double | lastP1 () const |
double | lastP1 () const |
double | lastP2 () const |
double | lastP2 () const |
double | lastL1 () const |
double | lastL1 () const |
double | lastL2 () const |
double | lastL2 () const |
double | lastX1 () const |
double | lastX1 () const |
double | lastX2 () const |
double | lastX2 () const |
double | lastE1 () const |
double | lastE1 () const |
double | lastE2 () const |
double | lastE2 () const |
double | lastFL1L2 () const |
double | lastFL1L2 () const |
Energy2 | lastScale () const |
double | lastAlphaS () const |
double | lastAlphaEM () const |
const vector< Lorentz5Momentum > & | meMomenta () const |
double | lastME2 () const |
double | lastPreweight () const |
double | jacobian () const |
CrossSection | lastMECrossSection () const |
double | lastMEPDFWeight () const |
double | lastMECouplings () const |
tSubProPtr | subProcess () const |
const cPDVector & | mePartonData () const |
Protected Member Functions | |
Clone Methods. | |
virtual IBPtr | clone () const |
Make a simple clone of this object. | |
virtual IBPtr | fullclone () const |
Make a clone of this object, possibly modifying the cloned object to make it sane. | |
Protected Member Functions inherited from Herwig::HwMEBase | |
Energy2 | tHat () const |
Return the \(\hat{t}\) of the last set phase space point. | |
Energy2 | uHat () const |
Return the \(\hat{u}\) of the last set phase space point. | |
double | phi () const |
Return the azimuth angle of the last set phase space point. | |
void | tHat (Energy2 e2) |
Set the \(\hat{t}\) of the last set phase space point. | |
void | uHat (Energy2 e2) |
Set the \(\hat{u}\) of the last set phase space point. | |
void | phi (double phi) |
Set the azimuth angle of the last set phase space point. | |
void | massOption (vector< unsigned int > iopt) |
Set the treatment of the outgoing masses. | |
void | rescalingOption (unsigned int iopt) |
Rescaled momenta for the helicity ME. | |
bool | rescaleMomenta (const vector< Lorentz5Momentum > &, const cPDVector &) |
rescale the momenta for the computation of the helicity matrix element | |
const vector< Lorentz5Momentum > & | rescaledMomenta () const |
Access to the rescaled momenta. | |
bool | generateMasses (vector< Energy > &masses, double &mjac, const double *r) |
Generate the masses of the particles. | |
virtual double | getCosTheta (double cthmin, double cthmax, const double r) |
Used internally by generateKinematics, after calculating the limits on cos(theta). | |
Protected Member Functions inherited from ThePEG::MEBase | |
virtual void | doinit () |
virtual void | doinitrun () |
void | add (DiagPtr dp) const |
vector< Lorentz5Momentum > & | meMomenta () |
void | lastME2 (double v) const |
void | lastPreweight (double w) const |
void | lastMECrossSection (CrossSection v) const |
void | lastMEPDFWeight (double v) const |
void | lastMECouplings (double v) const |
void | jacobian (double j) |
void | use (tcMEPtr other) |
void | useDiagrams (tcMEPtr other) const |
Protected Member Functions inherited from ThePEG::Interfaced | |
void | reporeg (IBPtr object, string name) const |
bool | setDefaultReference (PtrT &ptr, string classname, string objectname) |
Interfaced (const string &newName) | |
Interfaced (const Interfaced &i) | |
void | setGenerator (tEGPtr generator) |
Protected Member Functions inherited from ThePEG::InterfacedBase | |
virtual void | readSetup (istream &is) |
virtual void | doupdate () |
virtual void | doinit () |
virtual void | doinitrun () |
virtual void | dofinish () |
virtual IVector | getReferences () |
virtual void | rebind (const TranslationMap &) |
virtual IBPtr | clone () const=0 |
InterfacedBase (string newName) | |
InterfacedBase (const InterfacedBase &i) | |
virtual void | readSetup (istream &is) |
virtual void | doupdate () |
virtual void | doinit () |
virtual void | doinitrun () |
virtual void | dofinish () |
virtual IVector | getReferences () |
virtual void | rebind (const TranslationMap &) |
Protected Member Functions inherited from ThePEG::Pointer::ReferenceCounted | |
ReferenceCounted (const ReferenceCounted &) | |
ReferenceCounted & | operator= (const ReferenceCounted &) |
Protected Member Functions inherited from ThePEG::Named | |
const Named & | operator= (const Named &other) |
const string & | name (const string &newName) |
Standard Interfaced functions. | |
unsigned int | scaleopt_ |
Selects a dynamic (sHat) or fixed factorization scale. | |
Energy | mu_F_ |
The value associated to the fixed factorization scale option. | |
unsigned int | shapeOption_ |
Defines the Higgs resonance shape. | |
unsigned int | processOption_ |
The processes to be included (GG->H and/or qq->H) | |
int | minFlavour_ |
Minimum flavour of incoming quarks. | |
int | maxFlavour_ |
Maximum flavour of incoming quarks. | |
ProductionMatrixElement | me_ |
Matrix element for spin correlations. | |
AbstractVVSVertexPtr | HGGVertex_ |
Pointer to the H-> 2 gluon vertex (used in gg->H) | |
AbstractFFSVertexPtr | HFFVertex_ |
Pointer to the fermion-fermion Higgs vertex (used in qq->H) | |
GenericMassGeneratorPtr | hmass_ |
The mass generator for the Higgs. | |
Energy | mh_ |
On-shell mass for the higgs. | |
Energy | wh_ |
On-shell width for the higgs. | |
unsigned int | minLoop_ |
Stuff for the ME correction. | |
unsigned int | maxLoop_ |
Maximum flavour of quarks to include in the loops. | |
unsigned int | massOption_ |
Option for treatment of the fermion loops. | |
unsigned int | mu_R_opt_ |
Option for dynamic scale choice in alpha_S (0=mT,>0=pT) | |
unsigned int | mu_F_opt_ |
Option for dynamic scale choice in PDFs (0=mT,>0=pT) | |
Complex | bi_ [5] |
Storage of the loop functions. | |
complex< InvEnergy2 > | ci_ [8] |
C functions. | |
complex< InvEnergy4 > | di_ [4] |
D functions. | |
ShowerAlphaPtr | alpha_ |
Pointer to the object calculating the strong coupling. | |
Energy2 | mh2_ |
Mass squared of Higgs. | |
double | channelwgtA_ |
Relative weight of the \(qg\) to the \(gg\) channel. | |
double | channelwgtB_ |
Relative weight for the \(\bar{q}g\) to the \(gg\) channel. | |
vector< double > | channelWeights_ |
Weights for the channels as a vector. | |
double | ggPow_ |
Power for the \(\frac{{\rm d}\hat{s}}{\hat{s}^n}\) importance sampling of the \(gg\) component. | |
double | qgPow_ |
Power for the \(\frac{{\rm d}\hat{s}}{\hat{s}^n}\) importance sampling of the \(qg\) and \(\bar{q}g\) components. | |
double | enhance_ |
The enhancement factor for initial-state radiation. | |
unsigned int | nover_ |
Number of weights greater than 1. | |
unsigned int | ntry_ |
Number of attempts. | |
unsigned int | ngen_ |
Number which suceed. | |
double | maxwgt_ |
Maximum weight. | |
double | power_ |
Constants for the sampling. | |
double | pregg_ |
The prefactor, \(c\) for the \(gg\) channel. | |
double | preqg_ |
The prefactor, \(c\) for the \(qg\) channel. | |
double | pregqbar_ |
The prefactor, \(c\) for the \(g\bar{q}\) channel. | |
vector< double > | prefactor_ |
The prefactors as a vector for easy use. | |
Energy | minpT_ |
The transverse momentum of the jet. | |
vector< tcBeamPtr > | beams_ |
Properties of the incoming particles. | |
vector< tcPDPtr > | partons_ |
Pointers to the ParticleDataObjects for the partons. | |
double | yh_ |
Properties of the boson and jets. | |
Energy | mass_ |
The mass of the Higgs boson. | |
double | yj_ |
the rapidity of the jet | |
Energy | pt_ |
The transverse momentum of the jet. | |
tcPDPtr | out_ |
The outgoing parton. | |
bool | spinCorrelations_ |
Whether of not to construct the vertex for spin correlations. | |
static const complex< Energy2 > | epsi_ |
Small complex number to regularize some integrals. | |
virtual void | doinit () |
Initialize this object after the setup phase before saving an EventGenerator to disk. | |
virtual void | dofinish () |
Finalize this object. | |
Energy4 | loME () const |
Members to calculate the real emission matrix elements. | |
Energy2 | ggME (Energy2 s, Energy2 t, Energy2 u) |
The matrix element for \(gg\to H g\). | |
Energy2 | qgME (Energy2 s, Energy2 t, Energy2 u) |
The matrix element for \(qg\to H q\). | |
Energy2 | qbargME (Energy2 s, Energy2 t, Energy2 u) |
The matrix element for \(qbarg\to H qbar\). | |
Complex | B (Energy2 s, Energy2 mf2) const |
Members to calculate the functions for the loop diagrams. | |
complex< InvEnergy2 > | C (Energy2 s, Energy2 mf2) const |
The \(C(s)\) function of NBP339 (1990) 38-66. | |
complex< InvEnergy4 > | D (Energy2 s, Energy2 t, Energy2 u, Energy2 mf2) const |
The \(C(s)\) function of NBP339 (1990) 38-66. | |
Complex | dIntegral (Energy2 a, Energy2 b, double y0) const |
The integral \(\int\frac{dy}{y-y_0}\log(a-i\epsilon-b y(1-y))\) from NBP339 (1990) 38-66. | |
complex< Energy > | me1 (Energy2 s, Energy2 t, Energy2 u, Energy2 mf2, unsigned int i, unsigned int j, unsigned int k, unsigned int i1, unsigned int j1, unsigned int k1) const |
The \(M_{+++}\) matrix element of NBP339 (1990) 38-66. | |
complex< Energy > | me2 (Energy2 s, Energy2 t, Energy2 u, Energy2 mf2) const |
The \(M_{++-}\) matrix element of NBP339 (1990) 38-66. | |
Complex | F (double x) const |
The \(F(x)\) function for the leading-order result. | |
tPDPtr | quarkFlavour (tcPDFPtr pdf, Energy2 scale, double x, tcBeamPtr beam, double &pdfweight, bool anti) |
Method to extract the PDF weight for quark/antiquark initiated processes and select the quark flavour. | |
bool | applyHard (ParticleVector gluons, vector< tcBeamPtr > beams, PPtr higgs, unsigned int &iemit, unsigned int &itype, vector< Lorentz5Momentum > &pnew, pair< double, double > &xnew, tPDPtr &out) |
Return the momenta and type of hard matrix element correction. | |
bool | getEvent (vector< Lorentz5Momentum > &pnew, int &emissiontype) |
generates the hardest emission (yj,p) | |
double | getResult (int emis_type, Energy pt, double yj, tcPDPtr &outParton) |
Returns the matrix element for a given type of process, rapidity of the jet \(y_j\) and transverse momentum \(p_T\). | |
MEPP2Higgs & | operator= (const MEPP2Higgs &)=delete |
The assignment operator is private and must never be called. | |
double | ggME (vector< VectorWaveFunction > g1, vector< VectorWaveFunction > g2, ScalarWaveFunction &, bool calc) const |
Members to return the matrix elements for the different subprocesses. | |
double | qqME (vector< SpinorWaveFunction > &fin, vector< SpinorBarWaveFunction > &ain, ScalarWaveFunction &, bool calc) const |
Calculates the matrix element for the process q,qbar->h. | |
Functions used by the persistent I/O system. | |
void | persistentOutput (PersistentOStream &os) const |
Function used to write out object persistently. | |
void | persistentInput (PersistentIStream &is, int version) |
Function used to read in object persistently. | |
static void | Init () |
The standard Init function used to initialize the interfaces. | |
Additional Inherited Members | |
Public Types inherited from Herwig::HwMEBase | |
enum | POWHEGType { No , ISR , FSR , Both } |
Virtual members to be overridden by inheriting classes which implement hard corrections. More... | |
Public Types inherited from ThePEG::MEBase | |
typedef vector< DiagPtr > | DiagramVector |
typedef DiagramVector::size_type | DiagramIndex |
typedef vector< ReweightPtr > | ReweightVector |
Public Types inherited from ThePEG::InterfacedBase | |
enum | InitState |
Public Types inherited from ThePEG::Pointer::ReferenceCounted | |
typedef unsigned int | CounterType |
Public Types inherited from ThePEG::LastXCombInfo< StandardXComb > | |
typedef ThePEG::Ptr< XC >::pointer | XCPtr |
typedef ThePEG::Ptr< XC >::const_pointer | cXCPtr |
typedef ThePEG::Ptr< XC >::transient_pointer | tXCPtr |
typedef ThePEG::Ptr< XC >::transient_const_pointer | tcXCPtr |
Static Public Member Functions inherited from Herwig::HwMEBase | |
static void | Init () |
The standard Init function used to initialize the interfaces. | |
Static Public Member Functions inherited from ThePEG::MEBase | |
static void | Init () |
Static Public Member Functions inherited from ThePEG::HandlerBase | |
static void | Init () |
Static Public Member Functions inherited from ThePEG::Interfaced | |
static void | Init () |
Static Public Member Functions inherited from ThePEG::InterfacedBase | |
static void | Init () |
Static Public Member Functions inherited from ThePEG::Base | |
static void | Init () |
Public Attributes inherited from ThePEG::InterfacedBase | |
initializing | |
uninitialized | |
initialized | |
runready | |
Public Attributes inherited from ThePEG::Pointer::ReferenceCounted | |
const unsigned long | uniqueId |
Static Protected Member Functions inherited from ThePEG::Interfaced | |
static void | registerRepository (IBPtr) |
static void | registerRepository (IBPtr, string newName) |
Protected Attributes inherited from ThePEG::LastXCombInfo< StandardXComb > | |
XCPtr | theLastXComb |
The MEPP2Higgs class implements the matrix element for the process pp->Higgs with different Higgs shape prescriptions (see details in hep-ph/9505211) and the NLL corrected Higgs width (see details in the FORTRAN HERWIG manual).
Definition at line 38 of file MEPP2Higgs.h.
|
protected |
Return the momenta and type of hard matrix element correction.
gluons | The original incoming particles. |
beams | The BeamParticleData objects |
higgs | The original outgoing higgs |
iemit | Whether the first (0) or second (1) particle emitted the radiation |
itype | The type of radiated particle (0 is gluon, 1 is quark and 2 is antiquark) |
pnew | The momenta of the new particles |
xnew | The new values of the momentuym fractions |
out | The ParticleData object for the outgoing parton |
|
virtual |
Apply the hard matrix element correction to a given hard process or decay.
Reimplemented from Herwig::HwMEBase.
|
protected |
Members to calculate the functions for the loop diagrams.
The \(B(s)\) function of NBP339 (1990) 38-66
s | The scale |
mf2 | The fermion mass squared. |
|
protected |
The \(C(s)\) function of NBP339 (1990) 38-66.
s | The scale |
mf2 | The fermion mass squared. |
|
inlineprotectedvirtual |
Make a simple clone of this object.
Implements ThePEG::InterfacedBase.
Reimplemented in Herwig::MEPP2HiggsPowheg.
Definition at line 227 of file MEPP2Higgs.h.
|
virtual |
Return a Selector with possible colour geometries for the selected diagram weighted by their relative probabilities.
diag | the diagram chosen. |
Implements ThePEG::MEBase.
|
virtual |
Construct the vertex of spin correlations.
Reimplemented from ThePEG::MEBase.
|
protected |
The \(C(s)\) function of NBP339 (1990) 38-66.
s | The \(s\) invariant |
t | The \(t\) invariant |
u | The \(u\) invariant |
mf2 | The fermion mass squared |
|
virtual |
Get diagram selector.
With the information previously supplied with the setKinematics method, a derived class may optionally override this method to weight the given diagrams with their (although certainly not physical) relative probabilities.
dv | the diagrams to be weighted. |
Reimplemented from ThePEG::MEBase.
|
protected |
The integral \(\int\frac{dy}{y-y_0}\log(a-i\epsilon-b y(1-y))\) from NBP339 (1990) 38-66.
a | The parameter \(a\). |
b | The parameter \(b\). |
y0 | The parameter \(y_0\). |
|
protectedvirtual |
Finalize this object.
Called in the run phase just after a run has ended. Used eg. to write out statistics.
Reimplemented from ThePEG::InterfacedBase.
|
protectedvirtual |
Initialize this object after the setup phase before saving an EventGenerator to disk.
InitException | if object could not be initialized properly. |
Reimplemented from ThePEG::MEBase.
|
virtual |
Return the matrix element for the kinematical configuation previously provided by the last call to setKinematics().
Uses me().
Reimplemented from Herwig::HwMEBase.
|
inlineprotectedvirtual |
Make a clone of this object, possibly modifying the cloned object to make it sane.
Reimplemented from ThePEG::InterfacedBase.
Reimplemented in Herwig::MEPP2HiggsPowheg.
Definition at line 233 of file MEPP2Higgs.h.
|
virtual |
Apply the POWHEG style correction.
Reimplemented from Herwig::HwMEBase.
|
virtual |
Generate internal degrees of freedom given nDim() uniform random numbers in the interval \( ]0,1[ \).
To help the phase space generator, the dSigHatDR should be a smooth function of these numbers, although this is not strictly necessary.
r | a pointer to the first of nDim() consecutive random numbers. |
Reimplemented from Herwig::HwMEBase.
Reimplemented in Herwig::MEPP2HiggsPowheg.
|
virtual |
Add all possible diagrams with the add() function.
Implements ThePEG::MEBase.
|
protected |
generates the hardest emission (yj,p)
pnew | The momenta of the new particles |
emissiontype | The type of emission, as for getResult |
|
protected |
Returns the matrix element for a given type of process, rapidity of the jet \(y_j\) and transverse momentum \(p_T\).
emis_type | the type of emission, (0 is \(gg\to h^0g\), 1 is \(qg\to h^0q\) and 2 is \(g\bar{q}\to h^0\bar{q}\)) |
pt | The transverse momentum of the jet |
yj | The rapidity of the jet |
outParton | the outgoing parton |
|
private |
Members to return the matrix elements for the different subprocesses.
Calculates the matrix element for the process g,g->h (via quark loops)
g1 | a vector of wave functions of the first incoming gluon |
g2 | a vector of wave functions of the second incoming gluon |
calc | Whether or not to calculate the matrix element for spin correlations |
|
inlinevirtual |
Has an old fashioned ME correction.
Reimplemented from Herwig::HwMEBase.
Definition at line 76 of file MEPP2Higgs.h.
|
inlinevirtual |
Has a POWHEG style correction.
Reimplemented from Herwig::HwMEBase.
Definition at line 71 of file MEPP2Higgs.h.
|
static |
The standard Init function used to initialize the interfaces.
Called exactly once for each class by the class description system before the main function starts or when this class is dynamically loaded.
|
virtual |
Initialize the ME correction.
Reimplemented from Herwig::HwMEBase.
|
protected |
Members to calculate the real emission matrix elements.
The leading-order matrix element for \(gg\to H\)
|
protected |
The \(M_{+++}\) matrix element of NBP339 (1990) 38-66.
s | The \(s\) invariant |
t | The \(t\) invariant |
u | The \(u\) invariant |
mf2 | The fermion mass squared. |
i | Which of the stored values to use for \(D(u,t)\). |
j | Which of the stored values to use for \(D(u,s)\). |
k | Which of the stored values to use for \(D(s,t)\). |
i1 | Which of the stored values to use for \(C_1(s)\). |
j1 | Which of the stored values to use for \(C_1(t)\). |
k1 | Which of the stored values to use for \(C_1(u)\). |
|
virtual |
The matrix element for the kinematical configuration previously provided by the last call to setKinematics(), suitably scaled by sHat() to give a dimension-less number.
Implements ThePEG::MEBase.
Reimplemented in Herwig::MEPP2HiggsPowheg.
|
protected |
The \(M_{++-}\) matrix element of NBP339 (1990) 38-66.
s | The \(s\) invariant |
t | The \(t\) invariant |
u | The \(u\) invariant |
mf2 | The fermion mass squared. |
|
virtual |
The number of internal degrees of freedom used in the matrix element.
Reimplemented from Herwig::HwMEBase.
Reimplemented in Herwig::MEPP2HiggsPowheg.
|
privatedelete |
The assignment operator is private and must never be called.
In fact, it should not even be implemented.
|
virtual |
Return the order in \(\alpha_{EW}\) in which this matrix element is given.
Implements ThePEG::MEBase.
|
virtual |
Return the order in \(\alpha_S\) in which this matrix element is given.
Implements ThePEG::MEBase.
void Herwig::MEPP2Higgs::persistentInput | ( | PersistentIStream & | is, |
int | version | ||
) |
Function used to read in object persistently.
is | the persistent input stream read from. |
version | the version number of the object when written. |
void Herwig::MEPP2Higgs::persistentOutput | ( | PersistentOStream & | os | ) | const |
Function used to write out object persistently.
os | the persistent output stream written to. |
|
private |
Calculates the matrix element for the process q,qbar->h.
fin | a vector of quark spinors |
ain | a vector of anti-quark spinors |
calc | Whether or not to calculate the matrix element for spin correlations |
|
virtual |
Return the scale associated with the last set phase space point.
Implements ThePEG::MEBase.
Reimplemented in Herwig::MEPP2HiggsPowheg.
|
inlinevirtual |
Set the typed and momenta of the incoming and outgoing partons to be used in subsequent calls to me() and colourGeometries() according to the associated XComb object.
Reimplemented from Herwig::HwMEBase.
Definition at line 59 of file MEPP2Higgs.h.
References mh2_, Herwig::HwMEBase::setKinematics(), and ThePEG::MEBase::sHat().
|
virtual |
Apply the soft matrix element correction.
parent | The initial particle in the current branching |
progenitor | The progenitor particle of the jet |
fs | Whether the emission is initial or final-state |
highestpT | The highest pT so far in the shower |
ids | ids of the particles produced in the branching |
z | The momentum fraction of the branching |
scale | the evolution scale of the branching |
pT | The transverse momentum of the branching |
Reimplemented from Herwig::HwMEBase.
|
private |
Pointer to the object calculating the strong coupling.
Definition at line 561 of file MEPP2Higgs.h.
|
private |
Properties of the incoming particles.
Pointers to the BeamParticleData objects
Definition at line 664 of file MEPP2Higgs.h.
|
mutableprivate |
|
private |
Weights for the channels as a vector.
Definition at line 581 of file MEPP2Higgs.h.
|
private |
Relative weight of the \(qg\) to the \(gg\) channel.
Definition at line 571 of file MEPP2Higgs.h.
|
private |
Relative weight for the \(\bar{q}g\) to the \(gg\) channel.
Definition at line 576 of file MEPP2Higgs.h.
|
mutableprivate |
C functions.
Definition at line 550 of file MEPP2Higgs.h.
|
mutableprivate |
D functions.
Definition at line 555 of file MEPP2Higgs.h.
|
private |
The enhancement factor for initial-state radiation.
Definition at line 598 of file MEPP2Higgs.h.
|
staticprivate |
Small complex number to regularize some integrals.
Definition at line 536 of file MEPP2Higgs.h.
|
private |
Power for the \(\frac{{\rm d}\hat{s}}{\hat{s}^n}\) importance sampling of the \(gg\) component.
Definition at line 587 of file MEPP2Higgs.h.
|
private |
Pointer to the fermion-fermion Higgs vertex (used in qq->H)
Definition at line 479 of file MEPP2Higgs.h.
|
private |
Pointer to the H-> 2 gluon vertex (used in gg->H)
Definition at line 474 of file MEPP2Higgs.h.
|
private |
The mass generator for the Higgs.
Definition at line 484 of file MEPP2Higgs.h.
|
private |
The mass of the Higgs boson.
Definition at line 684 of file MEPP2Higgs.h.
|
private |
Option for treatment of the fermion loops.
Definition at line 518 of file MEPP2Higgs.h.
|
private |
Maximum flavour of incoming quarks.
Definition at line 464 of file MEPP2Higgs.h.
|
private |
Maximum flavour of quarks to include in the loops.
Definition at line 513 of file MEPP2Higgs.h.
|
private |
Maximum weight.
Definition at line 618 of file MEPP2Higgs.h.
|
private |
Matrix element for spin correlations.
Definition at line 469 of file MEPP2Higgs.h.
|
private |
|
private |
On-shell mass for the higgs.
Definition at line 489 of file MEPP2Higgs.h.
|
private |
Minimum flavour of incoming quarks.
Definition at line 459 of file MEPP2Higgs.h.
|
private |
Stuff for the ME correction.
Parameters for the evaluation of the loops for the matrix elements Minimum flavour of quarks to include in the loops
Definition at line 508 of file MEPP2Higgs.h.
|
private |
The transverse momentum of the jet.
Definition at line 655 of file MEPP2Higgs.h.
|
private |
The value associated to the fixed factorization scale option.
Definition at line 444 of file MEPP2Higgs.h.
|
private |
Option for dynamic scale choice in PDFs (0=mT,>0=pT)
Definition at line 528 of file MEPP2Higgs.h.
|
private |
Option for dynamic scale choice in alpha_S (0=mT,>0=pT)
Definition at line 523 of file MEPP2Higgs.h.
|
private |
Number which suceed.
Definition at line 613 of file MEPP2Higgs.h.
|
private |
Number of weights greater than 1.
Definition at line 603 of file MEPP2Higgs.h.
|
private |
Number of attempts.
Definition at line 608 of file MEPP2Higgs.h.
|
private |
The outgoing parton.
Definition at line 699 of file MEPP2Higgs.h.
|
private |
Pointers to the ParticleDataObjects for the partons.
Definition at line 669 of file MEPP2Higgs.h.
|
private |
Constants for the sampling.
The distribution is assumed to have the form \(\frac{c}{{\rm GeV}}\times\left(\frac{{\rm GeV}}{p_T}\right)^n\) The power, \(n\), for the sampling
Definition at line 629 of file MEPP2Higgs.h.
|
private |
The prefactors as a vector for easy use.
Definition at line 649 of file MEPP2Higgs.h.
|
private |
The prefactor, \(c\) for the \(gg\) channel.
Definition at line 634 of file MEPP2Higgs.h.
|
private |
The prefactor, \(c\) for the \(g\bar{q}\) channel.
Definition at line 644 of file MEPP2Higgs.h.
|
private |
The prefactor, \(c\) for the \(qg\) channel.
Definition at line 639 of file MEPP2Higgs.h.
|
private |
The processes to be included (GG->H and/or qq->H)
Definition at line 454 of file MEPP2Higgs.h.
|
private |
The transverse momentum of the jet.
Definition at line 694 of file MEPP2Higgs.h.
|
private |
Power for the \(\frac{{\rm d}\hat{s}}{\hat{s}^n}\) importance sampling of the \(qg\) and \(\bar{q}g\) components.
Definition at line 593 of file MEPP2Higgs.h.
|
private |
Selects a dynamic (sHat) or fixed factorization scale.
Definition at line 439 of file MEPP2Higgs.h.
|
private |
Defines the Higgs resonance shape.
Definition at line 449 of file MEPP2Higgs.h.
|
private |
Whether of not to construct the vertex for spin correlations.
Definition at line 705 of file MEPP2Higgs.h.
|
private |
On-shell width for the higgs.
Definition at line 494 of file MEPP2Higgs.h.
|
private |
Properties of the boson and jets.
The rapidity of the Higgs boson
Definition at line 679 of file MEPP2Higgs.h.
|
private |
the rapidity of the jet
Definition at line 689 of file MEPP2Higgs.h.