herwig is hosted by Hepforge, IPPP Durham
Herwig  7.2.1
Herwig::DISBase Class Referenceabstract

The DISBase class is the base class for the implementation of DIS type processes including corrections in both the old fashioned matrix element and POWHEG approaches. More...

#include <DISBase.h>

Inheritance diagram for Herwig::DISBase:

Public Member Functions

 DISBase ()
 The default constructor.
 
virtual ~DISBase ()
 The default constructor.
 
virtual bool hasMECorrection ()
 Members for the old-fashioned matrix element correction. More...
 
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. More...
 
virtual POWHEGType hasPOWHEGCorrection ()
 Members for the POWHEG stype correction. More...
 
virtual RealEmissionProcessPtr generateHardest (RealEmissionProcessPtr, ShowerInteraction)
 Apply the POWHEG style correction.
 
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 degrees 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[ $. More...
 
virtual CrossSection dSigHatDR () const
 Return the matrix element squared differential in the variables given by the last call to generateKinematics().
 
Functions used by the persistent I/O system.
void persistentOutput (PersistentOStream &os) const
 Function used to write out object persistently. More...
 
void persistentInput (PersistentIStream &is, int version)
 Function used to read in object persistently. More...
 
- Public Member Functions inherited from Herwig::HwMEBase
 HwMEBase ()
 Default constructor.
 
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. More...
 
void persistentInput (PersistentIStream &is, int version)
 Function used to read in object persistently. More...
 
- 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 double alphaS () const
 
virtual double alphaEM () const
 
void setKinematics (tPPair in, const PVector &out)
 
virtual void constructVertex (tSubProPtr sub)
 
virtual void constructVertex (tSubProPtr sub, const ColourLines *cl)
 
virtual bool wantCMS () const
 
virtual bool headCuts () const
 
virtual bool ignoreCuts () const
 
virtual bool apply () const
 
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 DiagramVectordiagrams () const
 
virtual Selector< const ColourLines *> colourGeometries (tcDiagPtr diag) const=0
 
virtual const ColourLinesselectColourGeometry (tcDiagPtr diag) const
 
virtual Selector< DiagramIndexdiagrams (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 DVectormeInfo () 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)
 
virtual unsigned int orderInAlphaS () const=0
 
virtual unsigned int orderInAlphaEW () const=0
 
virtual double me2 () const=0
 
virtual double alphaS () const
 
virtual double alphaEM () const
 
void setKinematics (tPPair in, const PVector &out)
 
virtual void constructVertex (tSubProPtr sub)
 
virtual void constructVertex (tSubProPtr sub, const ColourLines *cl)
 
virtual bool wantCMS () const
 
virtual bool headCuts () const
 
virtual bool ignoreCuts () const
 
virtual bool apply () const
 
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 DiagramVectordiagrams () const
 
virtual Selector< const ColourLines *> colourGeometries (tcDiagPtr diag) const=0
 
virtual const ColourLinesselectColourGeometry (tcDiagPtr diag) const
 
virtual Selector< DiagramIndexdiagrams (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 DVectormeInfo () 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 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
 
void persistentOutput (PersistentOStream &os) const
 
void persistentInput (PersistentIStream &is, int version)
 
- Public Member Functions inherited from ThePEG::InterfacedBase
string fullName () const
 
string name () const
 
string path () const
 
string comment () const
 
void setup (istream &is)
 
virtual IBPtr fullclone () const
 
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
 
void persistentOutput (PersistentOStream &os) const
 
void persistentInput (PersistentIStream &is, int version)
 
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
 
void persistentOutput (PersistentOStream &os) const
 
void persistentInput (PersistentIStream &is, int version)
 
- Public Member Functions inherited from ThePEG::Base
void debug () 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 StandardXComblastXComb () const
 
const StandardXComblastXComb () const
 
tXCPtr lastXCombPtr () const
 
tXCPtr lastXCombPtr () const
 
const StandardXComblastHeadXComb () const
 
const StandardXComblastHeadXComb () const
 
tXCPtr lastHeadXCombPtr () const
 
tXCPtr lastHeadXCombPtr () const
 
const EventHandlerlastEventHandler () const
 
const EventHandlerlastEventHandler () const
 
tPExtrPtr lastExtractor () const
 
tPExtrPtr lastExtractor () const
 
PDFT pdf (tcPPtr parton) const
 
PDFT pdf (tcPPtr parton) const
 
const CutslastCuts () const
 
const CutslastCuts () const
 
tCutsPtr lastCutsPtr () const
 
tCutsPtr lastCutsPtr () const
 
const PPairlastParticles () const
 
const PPairlastParticles () const
 
Energy2 lastS () const
 
Energy2 lastS () const
 
const PPairlastPartons () const
 
const PPairlastPartons () 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
 
Energy2 lastScale () const
 
double lastAlphaS () const
 
double lastAlphaS () const
 
double lastAlphaEM () const
 
double lastAlphaEM () const
 
const vector< Lorentz5Momentum > & meMomenta () const
 
const vector< Lorentz5Momentum > & meMomenta () const
 
double lastME2 () const
 
double lastME2 () const
 
double lastPreweight () const
 
double lastPreweight () const
 
double jacobian () const
 
double jacobian () const
 
CrossSection lastMECrossSection () const
 
CrossSection lastMECrossSection () const
 
double lastMEPDFWeight () const
 
double lastMEPDFWeight () const
 
double lastMECouplings () const
 
double lastMECouplings () const
 
tSubProPtr subProcess () const
 
tSubProPtr subProcess () const
 
const cPDVectormePartonData () const
 
const cPDVectormePartonData () const
 

Static Public Member Functions

static void Init ()
 The standard Init function used to initialize the interfaces. More...
 
- Static Public Member Functions inherited from Herwig::HwMEBase
static void Init ()
 The standard Init function used to initialize the interfaces. More...
 
- 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 ()
 

Protected Member Functions

double NLOWeight () const
 The NLO weight.
 
virtual double A (tcPDPtr lin, tcPDPtr lout, tcPDPtr qin, tcPDPtr qout, Energy2 scale) const =0
 Calculate the coefficient A for the correlations.
 
Standard Interfaced functions.
virtual void doinit ()
 Initialize this object after the setup phase before saving an EventGenerator to disk. More...
 
double generateComptonPoint (double &xp, double &zp)
 Members for the matrix element correction. More...
 
double generateBGFPoint (double &xp, double &zp)
 Generate the values of $x_p$ and $z_p$. More...
 
vector< double > ComptonME (double xp, double x2, double xperp, bool norm)
 Return the coefficients for the matrix element piece for the QCD compton case. More...
 
vector< double > BGFME (double xp, double x2, double x3, double xperp, bool norm)
 Return the coefficients for the matrix element piece for the QCD compton case. More...
 
void generateCompton ()
 Members for the POWHEG correction. More...
 
void generateBGF ()
 Generate a BGF process.
 
- Protected Member Functions inherited from Herwig::HwMEBase
void massOption (vector< unsigned int > iopt)
 Set the treatment of the outgoing masses. More...
 
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).
 
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 rescalingOption (unsigned int iopt)
 Rescaled momenta for the helicity ME. More...
 
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.
 
- Protected Member Functions inherited from ThePEG::MEBase
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
 
virtual void doinitrun ()
 
virtual void doinitrun ()
 
- 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 IBPtr clone () const=0
 
 InterfacedBase (string newName)
 
 InterfacedBase (const InterfacedBase &i)
 
virtual void readSetup (istream &is)
 
virtual void doupdate ()
 
virtual void dofinish ()
 
virtual IVector getReferences ()
 
virtual void rebind (const TranslationMap &)
 
virtual void readSetup (istream &is)
 
virtual void doupdate ()
 
virtual void dofinish ()
 
virtual IVector getReferences ()
 
virtual void rebind (const TranslationMap &)
 
- Protected Member Functions inherited from ThePEG::Pointer::ReferenceCounted
 ReferenceCounted (const ReferenceCounted &)
 
ReferenceCountedoperator= (const ReferenceCounted &)
 
 ReferenceCounted (const ReferenceCounted &)
 
ReferenceCountedoperator= (const ReferenceCounted &)
 
- Protected Member Functions inherited from ThePEG::Named
const Namedoperator= (const Named &other)
 
const string & name (const string &newName)
 

Private Member Functions

DISBaseoperator= (const DISBase &)=delete
 The assignment operator is private and must never be called. More...
 

Private Attributes

double acoeff_
 The coefficient for the correlations.
 
ShowerAlphaPtr alpha_
 Coupling.
 
PDPtr gluon_
 Gluon particle data object.
 
tcBeamPtr hadron_
 The hadron.
 
unsigned int scaleOpt_
 Selects a dynamic or fixed factorization scale.
 
Energy muF_
 The factorization scale.
 
double scaleFact_
 Prefactor if variable scale used.
 
unsigned int contrib_
 Whether to generate the positive, negative or leading order contribution.
 
double power_
 Power for sampling $x_p$.
 
double jac_
 Jacobian for $x_p$ integral.
 
double initial_
 Parameters for the matrix element correction. More...
 
double final_
 Enchancement factor for FSR.
 
double procProb_
 Relative fraction of compton and BGF processes to generate.
 
double comptonInt_
 Integral for compton process.
 
double bgfInt_
 Integral for BGF process.
 
double comptonWeight_
 Parameters for the POWHEG correction. More...
 
double BGFWeight_
 Weight for the BGF channel.
 
Energy pTmin_
 Minimum value of $p_T$.
 
Energy2 q2_
 Parameters for the point being generated. More...
 
double l_
 
double xB_
 Borm momentum fraction.
 
tcBeamPtr beam_
 Beam particle.
 
tcPDPtr partons_ [2]
 Partons.
 
tcPDPtr leptons_ [2]
 Leptons.
 
tcPDFPtr pdf_
 PDF object.
 
LorentzRotation rot_
 Rotation to the Breit frame.
 
Lorentz5Momentum pl_ [2]
 Lepton momenta.
 
Lorentz5Momentum pq_ [2]
 Quark momenta.
 
Lorentz5Momentum q_
 q
 
Energy pTCompton_
 Compton parameters.
 
bool ComptonISFS_
 
vector< Lorentz5Momentum > ComptonMomenta_
 
Energy pTBGF_
 BGF parameters.
 
vector< Lorentz5Momentum > BGFMomenta_
 
double xp_
 The radiative variables. More...
 

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< ReweightPtrReweightVector
 
- 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< StandardXComb >::pointer XCPtr
 
typedef ThePEG::Ptr< StandardXComb >::const_pointer cXCPtr
 
typedef ThePEG::Ptr< StandardXComb >::transient_pointer tXCPtr
 
typedef ThePEG::Ptr< StandardXComb >::transient_const_pointer tcXCPtr
 
- 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
 

Detailed Description

The DISBase class is the base class for the implementation of DIS type processes including corrections in both the old fashioned matrix element and POWHEG approaches.

See also
The interfaces defined for DISBase.

Definition at line 23 of file DISBase.h.

Member Function Documentation

◆ BGFME()

vector<double> Herwig::DISBase::BGFME ( double  xp,
double  x2,
double  x3,
double  xperp,
bool  norm 
)
protected

Return the coefficients for the matrix element piece for the QCD compton case.

The output is the $a_i$ coefficients to give the function as $a_0+a_1\cos\phi+a_2\sin\phi+a_3\cos^2\phi+a_4\sin^2\phi$

Parameters
xp$x_p$
x2$x_3$
x3$x_2$
xperp$x_\perp$
normNormalise to the large $l$ value of the ME

◆ ComptonME()

vector<double> Herwig::DISBase::ComptonME ( double  xp,
double  x2,
double  xperp,
bool  norm 
)
protected

Return the coefficients for the matrix element piece for the QCD compton case.

The output is the $a_i$ coefficients to give the function as $a_0+a_1\cos\phi+a_2\sin\phi+a_3\cos^2\phi+a_4\sin^2\phi$

Parameters
xp$x_p$
x2$x_2$
xperp$x_\perp$
normNormalise to the large $l$ value of the ME

◆ doinit()

virtual void Herwig::DISBase::doinit ( )
protectedvirtual

Initialize this object after the setup phase before saving an EventGenerator to disk.

Exceptions
InitExceptionif object could not be initialized properly.

Reimplemented from ThePEG::MEBase.

Reimplemented in Herwig::MEChargedCurrentDIS, and Herwig::MENeutralCurrentDIS.

◆ generateBGFPoint()

double Herwig::DISBase::generateBGFPoint ( double &  xp,
double &  zp 
)
protected

Generate the values of $x_p$ and $z_p$.

Parameters
xpThe value of xp, output
zpThe value of zp, output

◆ generateCompton()

void Herwig::DISBase::generateCompton ( )
protected

Members for the POWHEG correction.

Generate a Compton process

◆ generateComptonPoint()

double Herwig::DISBase::generateComptonPoint ( double &  xp,
double &  zp 
)
protected

Members for the matrix element correction.

Generate the values of $x_p$ and $z_p$

Parameters
xpThe value of xp, output
zpThe value of zp, output

◆ generateKinematics()

virtual bool Herwig::DISBase::generateKinematics ( const double *  r)
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.

Parameters
ra pointer to the first of nDim() consecutive random numbers.
Returns
true if the generation succeeded, otherwise false.

Reimplemented from Herwig::HwMEBase.

◆ hasMECorrection()

virtual bool Herwig::DISBase::hasMECorrection ( )
inlinevirtual

Members for the old-fashioned matrix element correction.

Has an old fashioned ME correction

Reimplemented from Herwig::HwMEBase.

Definition at line 44 of file DISBase.h.

◆ hasPOWHEGCorrection()

virtual POWHEGType Herwig::DISBase::hasPOWHEGCorrection ( )
inlinevirtual

Members for the POWHEG stype correction.

Has a POWHEG style correction

Reimplemented from Herwig::HwMEBase.

Definition at line 86 of file DISBase.h.

◆ Init()

static void Herwig::DISBase::Init ( )
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.

◆ operator=()

DISBase& Herwig::DISBase::operator= ( const DISBase )
privatedelete

The assignment operator is private and must never be called.

In fact, it should not even be implemented.

◆ persistentInput()

void Herwig::DISBase::persistentInput ( PersistentIStream is,
int  version 
)

Function used to read in object persistently.

Parameters
isthe persistent input stream read from.
versionthe version number of the object when written.

◆ persistentOutput()

void Herwig::DISBase::persistentOutput ( PersistentOStream os) const

Function used to write out object persistently.

Parameters
osthe persistent output stream written to.

◆ softMatrixElementVeto()

virtual bool Herwig::DISBase::softMatrixElementVeto ( PPtr  parent,
PPtr  progenitor,
const bool &  fs,
const Energy &  highestpT,
const vector< tcPDPtr > &  ids,
const double &  z,
const Energy &  scale,
const Energy &  pT 
)
virtual

Apply the soft matrix element correction.

Parameters
parentThe initial particle in the current branching
progenitorThe progenitor particle of the jet
fsWhether the emission is initial or final-state
highestpTThe highest pT so far in the shower
idsids of the particles produced in the branching
zThe momentum fraction of the branching
scalethe evolution scale of the branching
pTThe transverse momentum of the branching
Returns
If true the emission should be vetoed

Reimplemented from Herwig::HwMEBase.

Member Data Documentation

◆ comptonWeight_

double Herwig::DISBase::comptonWeight_
private

Parameters for the POWHEG correction.

Weight for the compton channel

Definition at line 287 of file DISBase.h.

◆ initial_

double Herwig::DISBase::initial_
private

Parameters for the matrix element correction.

Enchancement factor for ISR

Definition at line 257 of file DISBase.h.

◆ q2_

Energy2 Herwig::DISBase::q2_
private

Parameters for the point being generated.

$Q^2$

Definition at line 307 of file DISBase.h.

◆ xp_

double Herwig::DISBase::xp_
private

The radiative variables.

The $x_p$ or $z$ real integration variable

Definition at line 396 of file DISBase.h.


The documentation for this class was generated from the following file: