Herwig 7.3.0
|
The MEPP2ZHPowheg class implements the matrix element for \(q\bar{q}\to Z^0h^0\). More...
#include <MEPP2ZHPowheg.h>
Public Member Functions | |
MEPP2ZHPowheg () | |
The default constructor. | |
Virtual functions required by the MEBase class. | |
virtual Energy2 | scale () const |
Return the scale associated with the last set phase space point. | |
virtual int | nDim () const |
The number of internal degreed of freedom used in the matrix element. | |
virtual bool | generateKinematics (const double *r) |
Generate internal degrees of freedom given 'nDim()' uniform random numbers in the interval ]0,1[. | |
virtual CrossSection | dSigHatDR () const |
Return the matrix element for the kinematical configuation previously provided by the last call to setKinematics(). | |
![]() | |
MEPP2ZH () | |
The default constructor. | |
virtual void | getDiagrams () const |
Add all possible diagrams with the add() function. | |
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. | |
![]() | |
MEfftoVH () | |
The default constructor. | |
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 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. | |
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. | |
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. | |
![]() | |
DrellYanBase () | |
The default constructor. | |
virtual POWHEGType | hasPOWHEGCorrection () |
Has a POWHEG style correction. | |
virtual bool | hasMECorrection () |
Has an old fashioned ME correction. | |
virtual void | initializeMECorrection (RealEmissionProcessPtr, double &initial, double &final) |
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 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. | |
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. | |
![]() | |
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. | |
![]() | |
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) |
![]() | |
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 |
![]() | |
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 |
![]() | |
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 |
![]() | |
void | debug () const |
virtual void | debugme () const |
![]() | |
CounterType | referenceCount () const |
![]() | |
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 |
![]() | |
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. | |
![]() | |
![]() | |
double | helicityME (vector< SpinorWaveFunction > &fin, vector< SpinorBarWaveFunction > &ain, vector< SpinorBarWaveFunction > &fout, vector< SpinorWaveFunction > &aout, bool me) const |
Matrix element for \(f\bar{f}\to V h^0\to f'\bar{f'} h^0\). | |
PDPtr | WPlus () const |
Access to the vector ParticleData objects. | |
PDPtr | WMinus () const |
Access to the \(W^-\) data. | |
PDPtr | Z0 () const |
Access to the \(Z^0\) data. | |
PDPtr | higgs () const |
Access to the higgs data. | |
void | higgs (PDPtr in) |
Set the higgs data. | |
void | setWWHVertex (AbstractVVSVertexPtr in) |
Set the pointer to the vector-vector-Higgs vertex. | |
void | lineShape (unsigned int in) |
Set the line shape treatment. | |
unsigned int | maxFlavour () const |
Maximum flavour of the incoming partons. | |
![]() | |
bool | applyHard (ParticleVector &quarks, vector< tcBeamPtr > beams, Lorentz5Momentum boson, unsigned int &iemit, unsigned int &itype, vector< Lorentz5Momentum > &pnew, LorentzRotation &trans, pair< double, double > &xnew, Energy2 shad) |
Return the momenta and type of hard matrix element correction. | |
double | getResult (int emis_type, Energy pt, double yj) |
Returns the matrix element for a given type of process, rapidity of the jet \(y_j\) and transverse momentum \(p_T\). | |
bool | getEvent (vector< Lorentz5Momentum > &pnew, int &emissiontype) |
generates the hardest emission (yj,p) | |
virtual void | dofinish () |
Finalize this object. | |
![]() | |
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). | |
![]() | |
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 |
![]() | |
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) |
![]() | |
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 &) |
![]() | |
ReferenceCounted (const ReferenceCounted &) | |
ReferenceCounted & | operator= (const ReferenceCounted &) |
![]() | |
const Named & | operator= (const Named &other) |
const string & | name (const string &newName) |
Standard Interfaced functions. | |
double | _xb_a |
The momentum fraction of the first parton in the Born process. | |
double | _xb_b |
The momentum fraction of the second parton in the Born process. | |
tcPDPtr | _parton_a |
The ParticleData object for the first parton in the Born process. | |
tcPDPtr | _parton_b |
The ParticleData object for the second parton in the Born process. | |
Ptr< BeamParticleData >::transient_const_pointer | _hadron_A |
The BeamParticleData object for the first hadron. | |
Ptr< BeamParticleData >::transient_const_pointer | _hadron_B |
The BeamParticleData object for the second hadron. | |
tcPDPtr | _gluon |
the ParticleData object for the gluon | |
const double | TR_ |
The \(T_R\) colour factor. | |
const double | CF_ |
The \(C_F\) colour factor. | |
double | _alphaS2Pi |
The value of \(\frac{\alpha_S}{2\pi}\) used for the calculation. | |
Energy2 | _mll2 |
The mass squared of the lepton pair. | |
Energy2 | _mu2 |
The renormalization/factorization scale. | |
unsigned int | _contrib |
Parameters for the NLO weight. | |
unsigned int | _nlo_alphaS_opt |
Whether to use a fixed or a running QCD coupling for the NLO weight. | |
double | _fixed_alphaS |
The value of alphaS to use for the nlo weight if _nloalphaSopt=1. | |
double | _a |
The magnitude of the correction term to reduce the negative contribution. | |
double | _p |
The power of the correction term to reduce the negative contribution. | |
unsigned int | _scaleopt |
Choice of the scale. | |
Energy | _fixedScale |
Fixed scale if used. | |
double | _scaleFact |
Prefactor if variable scale used. | |
double | _xt |
Radiation variables. | |
double | _v |
The \(v\) angular variable. | |
double | _oldq |
Values of the PDF's before radiation. | |
double | _oldqbar |
For the antiquark. | |
virtual void | doinit () |
Initialize this object after the setup phase before saving an EventGenerator to disk. | |
MEPP2ZHPowheg & | operator= (const MEPP2ZHPowheg &)=delete |
The assignment operator is private and must never be called. | |
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. | |
double | NLOweight () const |
Calculate the correction weight with which leading-order configurations are re-weighted. | |
double | x (double xt, double v) const |
Calculate the variable \(x=M_{B}^2/s\) from the integration variables. | |
double | x_a (double x, double v) const |
Calculate the momentum fraction of the first parton. | |
double | x_b (double x, double v) const |
Calculate the momentum fraction of second parton. | |
double | xbar (double v) const |
Calculate the minimum of \(x\). | |
double | Ltilde_qg (double x, double v) const |
Calculate the ratio of the radiative luminosity funcion to the Born luminosity function for the \(qg\) initiated channel. | |
double | Ltilde_gq (double x, double v) const |
Calculate the ratio of the radiative luminosity funcion to the Born luminosity function for the \(g\bar{q}\) initiated channel. | |
double | Ltilde_qq (double x, double v) const |
Calculate the ratio of the radiative luminosity funcion to the Born luminosity function for the \(q\bar{q}\) initiated channel. | |
double | Vtilde_qq () const |
Calculate the soft-virtual contribution to the NLO weight. | |
double | Ccalbar_qg (double x) const |
Function for calculation of the \(g\bar{q}\) and \(g\bar{q}\) initiated real contribution. | |
double | Fcal_qg (double x, double v) const |
Function for calculation of the \(qg\) initiated real contribution. | |
double | Fcal_gq (double x, double v) const |
Function for calculation of the \(g\bar{q}\) initiated real contribution. | |
double | Fcal_qq (double x, double v) const |
Function for calculation of the \(q\bar{q}\) initiated real contribution. | |
double | Ftilde_qg (double xt, double v) const |
Function for calculation of the \(qg\) initiated real contribution. | |
double | Ftilde_gq (double xt, double v) const |
Function for calculation of the \(g\bar{q}\) initiated real contribution. | |
double | Ftilde_qq (double xt, double v) const |
Function for calculation of the \(q\bar{q}\) initiated real contribution. | |
double | Ctilde_qg (double x, double v) const |
Function for calculation of the \(qg\) initiated real contribution. | |
double | Ctilde_gq (double x, double v) const |
Function for calculation of the \(g\bar{q}\) initiated real contribution. | |
double | Ctilde_qq (double x, double v) const |
Function for calculation of the \(q\bar{q}\) initiated real contribution. | |
Additional Inherited Members | |
![]() | |
enum | POWHEGType { No , ISR , FSR , Both } |
Virtual members to be overridden by inheriting classes which implement hard corrections. More... | |
![]() | |
typedef vector< DiagPtr > | DiagramVector |
typedef DiagramVector::size_type | DiagramIndex |
typedef vector< ReweightPtr > | ReweightVector |
![]() | |
enum | InitState |
![]() | |
typedef unsigned int | CounterType |
![]() | |
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 void | Init () |
The standard Init function used to initialize the interfaces. | |
![]() | |
static void | Init () |
The standard Init function used to initialize the interfaces. | |
![]() | |
static void | Init () |
The standard Init function used to initialize the interfaces. | |
![]() | |
static void | Init () |
The standard Init function used to initialize the interfaces. | |
![]() | |
static void | Init () |
![]() | |
static void | Init () |
![]() | |
static void | Init () |
![]() | |
static void | Init () |
![]() | |
static void | Init () |
![]() | |
initializing | |
uninitialized | |
initialized | |
runready | |
![]() | |
const unsigned long | uniqueId |
![]() | |
static void | registerRepository (IBPtr) |
static void | registerRepository (IBPtr, string newName) |
![]() | |
XCPtr | theLastXComb |
The MEPP2ZHPowheg class implements the matrix element for \(q\bar{q}\to Z^0h^0\).
Definition at line 22 of file MEPP2ZHPowheg.h.
|
inlineprotectedvirtual |
Make a simple clone of this object.
Reimplemented from Herwig::MEPP2ZH.
Definition at line 205 of file MEPP2ZHPowheg.h.
|
protectedvirtual |
Initialize this object after the setup phase before saving an EventGenerator to disk.
InitException | if object could not be initialized properly. |
Reimplemented from Herwig::MEPP2ZH.
|
virtual |
Return the matrix element for the kinematical configuation previously provided by the last call to setKinematics().
Uses me().
Reimplemented from Herwig::MEfftoVH.
|
inlineprotectedvirtual |
Make a clone of this object, possibly modifying the cloned object to make it sane.
Reimplemented from Herwig::MEPP2ZH.
Definition at line 211 of file MEPP2ZHPowheg.h.
|
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. Return false if the chosen points failed the kinematical cuts.
Reimplemented from Herwig::MEfftoVH.
|
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 |
The number of internal degreed of freedom used in the matrix element.
Reimplemented from Herwig::MEfftoVH.
|
privatedelete |
The assignment operator is private and must never be called.
In fact, it should not even be implemented.
void Herwig::MEPP2ZHPowheg::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::MEPP2ZHPowheg::persistentOutput | ( | PersistentOStream & | os | ) | const |
Function used to write out object persistently.
os | the persistent output stream written to. |
|
virtual |
Return the scale associated with the last set phase space point.
Reimplemented from Herwig::MEfftoVH.
|
private |
The magnitude of the correction term to reduce the negative contribution.
Definition at line 318 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The value of \(\frac{\alpha_S}{2\pi}\) used for the calculation.
Definition at line 284 of file MEPP2ZHPowheg.h.
|
private |
Parameters for the NLO weight.
Whether to generate the positive, negative or leading order contribution
Definition at line 303 of file MEPP2ZHPowheg.h.
|
private |
The value of alphaS to use for the nlo weight if _nloalphaSopt=1.
Definition at line 313 of file MEPP2ZHPowheg.h.
|
private |
Fixed scale if used.
Definition at line 339 of file MEPP2ZHPowheg.h.
|
private |
the ParticleData object for the gluon
Definition at line 269 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The BeamParticleData object for the first hadron.
Definition at line 259 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The BeamParticleData object for the second hadron.
Definition at line 264 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The mass squared of the lepton pair.
Definition at line 289 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The renormalization/factorization scale.
Definition at line 294 of file MEPP2ZHPowheg.h.
|
private |
Whether to use a fixed or a running QCD coupling for the NLO weight.
Definition at line 308 of file MEPP2ZHPowheg.h.
|
mutableprivate |
|
mutableprivate |
For the antiquark.
Definition at line 374 of file MEPP2ZHPowheg.h.
|
private |
The power of the correction term to reduce the negative contribution.
Definition at line 323 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The ParticleData object for the first parton in the Born process.
Definition at line 249 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The ParticleData object for the second parton in the Born process.
Definition at line 254 of file MEPP2ZHPowheg.h.
|
private |
Prefactor if variable scale used.
Definition at line 344 of file MEPP2ZHPowheg.h.
|
private |
|
private |
The \(v\) angular variable.
Definition at line 359 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The momentum fraction of the first parton in the Born process.
Definition at line 239 of file MEPP2ZHPowheg.h.
|
mutableprivate |
The momentum fraction of the second parton in the Born process.
Definition at line 244 of file MEPP2ZHPowheg.h.
|
private |
|
private |
The \(C_F\) colour factor.
Definition at line 279 of file MEPP2ZHPowheg.h.
|
private |
The \(T_R\) colour factor.
Definition at line 274 of file MEPP2ZHPowheg.h.