Herwig 7.3.0
|
The Baryon1MesonDecayerBase
class is the base class for the decay of a baryon to another baryon and a pseudoscalar or vector meson.
More...
#include <Baryon1MesonDecayerBase.h>
Public Member Functions | |
double | me2 (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Return the matrix element squared for a given mode and phase-space channel. | |
virtual void | constructSpinInfo (const Particle &part, ParticleVector outgoing) const |
Construct the SpinInfos for the particles produced in the decay. | |
virtual bool | twoBodyMEcode (const DecayMode &dm, int &mecode, double &coupling) const |
Specify the \(1\to2\) matrix element to be used in the running width calculation. | |
virtual void | dataBaseOutput (ofstream &os, bool header) const |
Output the setup information for the particle database. | |
![]() | |
DecayIntegrator () | |
The default constructor. | |
virtual bool | accept (tcPDPtr parent, const tPDVector &children) const |
Check if this decayer can perfom the decay for a particular mode. | |
virtual ParticleVector | decay (const Particle &parent, const tPDVector &children) const |
For a given decay mode and a given particle instance, perform the decay and return the decay products. | |
virtual int | modeNumber (bool &cc, tcPDPtr parent, const tPDVector &children) const =0 |
Which of the possible decays is required. | |
int | imode () const |
The mode being used for this decay. | |
void | addMode (PhaseSpaceModePtr mode) const |
Add a phase-space mode to the list. | |
virtual double | me2 (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const =0 |
Return the matrix element squared for a given mode and phase-space channel. | |
virtual void | constructSpinInfo (const Particle &part, ParticleVector outgoing) const =0 |
Construct the SpinInfos for the particles produced in the decay. | |
virtual void | dataBaseOutput (ofstream &os, bool header) const |
Output the setup information for the particle database. | |
void | setPartialWidth (const DecayMode &dm, int imode) |
Set the code for the partial width. | |
virtual bool | twoBodyMEcode (const DecayMode &, int &mecode, double &coupling) const |
Specify the \(1\to2\) matrix element to be used in the running width calculation. | |
virtual WidthCalculatorBasePtr | threeBodyMEIntegrator (const DecayMode &dm) const |
Method to return an object to calculate the 3 (or higher body) partial width. | |
virtual double | threeBodyMatrixElement (const int imode, const Energy2 q2, const Energy2 s3, const Energy2 s2, const Energy2 s1, const Energy m1, const Energy m2, const Energy m3) const |
The matrix element to be integrated for the three-body decays as a function of the invariant masses of pairs of the outgoing particles. | |
virtual InvEnergy | threeBodydGammads (const int imode, const Energy2 q2, const Energy2 s, const Energy m1, const Energy m2, const Energy m3) const |
The differential three body decay rate with one integral performed. | |
int | findMode (const DecayMode &dm) |
Finds the phase-space mode corresponding to a given decay mode. | |
ParticleVector | generatePhotons (const Particle &p, ParticleVector children) |
Members for the generation of QED radiation in the decays. | |
bool | canGeneratePhotons () |
check if photons can be generated in the decay | |
virtual double | oneLoopVirtualME (unsigned int imode, const Particle &part, const ParticleVector &products) |
The one-loop virtual correction. | |
bool | hasOneLoopME () |
Whether or not the one loop matrix element is implemented. | |
virtual InvEnergy2 | realEmissionME (unsigned int imode, const Particle &part, ParticleVector &products, unsigned int iemitter, double ctheta, double stheta, const LorentzRotation &rot1, const LorentzRotation &rot2) |
The real emission matrix element. | |
bool | hasRealEmissionME () |
Whether or not the real emission matrix element is implemented. | |
bool | warnings () const |
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. | |
![]() | |
HwDecayerBase () | |
The default constructor. | |
virtual bool | accept (const DecayMode &dm) const |
Check if this decayer can perfom the decay specified by the given decay mode. | |
virtual ParticleVector | decay (const DecayMode &dm, const Particle &p) const |
Perform a decay for a given DecayMode and a given Particle instance. | |
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) |
Apply the POWHEG style correction. | |
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. | |
bool | initialize () const |
Access to the initialize variable. | |
bool | databaseOutput () const |
Access the database output variable. | |
![]() | |
void | persistentOutput (PersistentOStream &os) const |
void | persistentInput (PersistentIStream &is, int version) |
virtual bool | accept (const DecayMode &dm) const=0 |
virtual bool | needsFullStep () const |
virtual ParticleVector | decay (const DecayMode &dm, const Particle &p) const=0 |
virtual ParticleVector | decay (const DecayMode &dm, const Particle &p, Step &step) const |
virtual double | brat (const DecayMode &dm, const ParticleData &pd, double oldbrat) const |
virtual double | brat (const DecayMode &dm, const Particle &p, double oldbrat) const |
virtual ParticleVector | getChildren (const DecayMode &dm, const Particle &parent) const |
virtual void | finalBoost (const Particle &parent, const ParticleVector &children) const |
virtual void | setScales (const Particle &parent, const ParticleVector &children) const |
Ptr< Amplitude >::pointer | amplitude () const |
![]() | |
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 |
Static Public Member Functions | |
static void | Init () |
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 ParticleVector | DecayParticle (tPPtr parent, Step &step, long maxtry=1000) |
![]() | |
static void | Init () |
![]() | |
static void | Init () |
![]() | |
static void | Init () |
![]() | |
static void | Init () |
Protected Member Functions | |
virtual void | halfHalfScalarCoupling (int imode, Energy m0, Energy m1, Energy m2, Complex &A, Complex &B) const |
Coupling Members. | |
virtual void | halfHalfVectorCoupling (int imode, Energy m0, Energy m1, Energy m2, Complex &A1, Complex &A2, Complex &B1, Complex &B2) const |
Couplings for spin- \(\frac12\) to spin- \(\frac12\) and a vector. | |
virtual void | halfThreeHalfScalarCoupling (int imode, Energy m0, Energy m1, Energy m2, Complex &A, Complex &B) const |
Couplings for spin- \(\frac12\) to spin- \(\frac32\) and a scalar. | |
virtual void | halfThreeHalfVectorCoupling (int imode, Energy m0, Energy m1, Energy m2, Complex &A1, Complex &A2, Complex &A3, Complex &B1, Complex &B2, Complex &B3) const |
Couplings for spin- \(\frac12\) to spin- \(\frac32\) and a vector. | |
virtual void | threeHalfHalfScalarCoupling (int imode, Energy m0, Energy m1, Energy m2, Complex &A, Complex &B) const |
Couplings for spin- \(\frac32\) to spin- \(\frac12\) and a scalar. | |
virtual void | threeHalfHalfVectorCoupling (int imode, Energy m0, Energy m1, Energy m2, Complex &A1, Complex &A2, Complex &A3, Complex &B1, Complex &B2, Complex &B3) const |
Couplings for spin- \(\frac32\) to spin- \(\frac12\) and a vector. | |
virtual void | threeHalfThreeHalfScalarCoupling (int imode, Energy m0, Energy m1, Energy m2, Complex &A1, Complex &A2, Complex &B1, Complex &B2) const |
Couplings for spin- \(\frac32\) to spin- \(\frac32\) and a scalar. | |
![]() | |
virtual void | doinitrun () |
Initialize this object. | |
ParticleVector | generate (bool inter, bool cc, const unsigned int &imode, const Particle &inpart) const |
Generate the momenta for the decay. | |
void | imode (int in) |
Set the mode being use for this decay. | |
void | ME (DecayMEPtr in) const |
Set the helicity matrix element for the decay. | |
DecayMEPtr | ME () const |
The helicity amplitude matrix element for spin correlations. | |
void | resetIntermediate (tcPDPtr part, Energy mass, Energy width) |
Reset the properities of all intermediates. | |
Energy | initializePhaseSpaceMode (unsigned int imode, bool init, bool onShell=false) const |
Initialize the phase-space mode. | |
void | generateIntermediates (bool in) |
Methods to set variables in inheriting classes. | |
bool | generateIntermediates () const |
Set whether or not the intermediates are included. | |
void | hasOneLoopME (bool in) |
Whether or not the one loop matrix element is implemented. | |
void | hasRealEmissionME (bool in) |
Whether or not the real emission matrix element is implemented. | |
void | epsilonPS (Energy in) |
Set the epsilon parameter. | |
void | clearModes () |
Clear the models. | |
unsigned int | numberModes () const |
Number of decay modes. | |
tPhaseSpaceModePtr | mode (unsigned int ix) |
Pointer to a mode. | |
tcPhaseSpaceModePtr | mode (unsigned int ix) const |
Pointer to a mode. | |
![]() | |
virtual void | dofinish () |
Finalize this object. | |
void | fixRho (RhoDMatrix &) const |
Set rho to be diagonal if no correlations. | |
![]() | |
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) |
Private Member Functions | |
double | halfHalfScalar (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Matrix Element Calculation Members. | |
double | halfHalfVector (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Matrix element for spin- \(\frac12\) to spin- \(\frac12\) and a vector. | |
double | halfThreeHalfScalar (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Matrix element for spin- \(\frac12\) to spin- \(\frac32\) and a scalar. | |
double | halfThreeHalfVector (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Matrix element for spin- \(\frac12\) to spin- \(\frac32\) and a vector. | |
double | threeHalfHalfScalar (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Matrix element for spin- \(\frac32\) to spin- \(\frac12\) and a scalar. | |
double | threeHalfHalfVector (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Matrix element for spin- \(\frac32\) to spin- \(\frac12\) and a vector. | |
double | threeHalfThreeHalfScalar (const int ichan, const Particle &part, const tPDVector &outgoing, const vector< Lorentz5Momentum > &momenta, MEOption meopt) const |
Matrix element for spin- \(\frac32\) to spin- \(\frac32\) and a scalar. | |
Baryon1MesonDecayerBase & | operator= (const Baryon1MesonDecayerBase &)=delete |
Private and non-existent assignment operator. | |
Private Attributes | |
RhoDMatrix | _rho |
Spin density matrx. | |
vector< Helicity::LorentzSpinor< SqrtEnergy > > | _inHalf |
Spin- \(\frac12\) spinor. | |
vector< Helicity::LorentzSpinorBar< SqrtEnergy > > | _inHalfBar |
Spin- \(\frac12\) barred spinor. | |
vector< Helicity::LorentzRSSpinor< SqrtEnergy > > | _inThreeHalf |
Spin- \(\frac32\) spinor. | |
vector< Helicity::LorentzRSSpinorBar< SqrtEnergy > > | _inThreeHalfBar |
Spin- \(\frac32\) barred spinor. | |
vector< Helicity::LorentzPolarizationVector > | _inVec |
Polarization vector. | |
Friends | |
class | BaryonWidthGenerator |
The BaryonWidthGenerator is a friend to get access to the couplings. | |
Additional Inherited Members | |
![]() | |
enum | MEOption { Initialize , Calculate , Terminate } |
Enum for the matrix element option. More... | |
![]() | |
enum | POWHEGType { No , ISR , FSR , Both } |
Virtual members to be overridden by inheriting classes which implement hard corrections. More... | |
![]() | |
enum | InitState |
![]() | |
typedef unsigned int | CounterType |
![]() | |
initializing | |
uninitialized | |
initialized | |
runready | |
![]() | |
const unsigned long | uniqueId |
![]() | |
static void | registerRepository (IBPtr) |
static void | registerRepository (IBPtr, string newName) |
The Baryon1MesonDecayerBase
class is the base class for the decay of a baryon to another baryon and a pseudoscalar or vector meson.
All the matrix elements involving either a spin-1/2 or spin-3/2 baryons are now implemented apart from \(\frac32\to\frac32+1\). The matrix elements are implemented in a general form with general couplings which must be supplied in classes inheriting from the one by implementing one of the coupling members.
\[\mathcal{M} = \bar{u}(p_1)(A+B\gamma_5)u(p_0)\]
\[\mathcal{M} = \bar{u}(p_1)\epsilon^{*\beta}\left[ \gamma_\beta(A_1+B_1\gamma_5) +p_{0\beta}(A_2+B_2\gamma_5)\right]u(p_0)\]
\[\bar{u}^\alpha(p_1) p_{0\alpha}\left[A+B\gamma_5\right]u(p_0)\]
\[\bar{u}^\alpha(p_1)\epsilon^{*\beta}\left[ g_{\alpha\beta}(A_1+B_1\gamma_5) +p_{0\alpha}(A_2+B_2\gamma_5) +p_{0\alpha}p_{0\beta}(A_3+B_3\gamma_5) \right]u(p_0)\]
\[\bar{u}(p_1) p_{1\alpha}\left[A+B\gamma_5\right]u^\alpha(p_0)\]
\[\bar{u}(p_1)\epsilon^{*\beta}\left[ g_{\alpha\beta}(A_1+B_1\gamma_5) +p_{1\alpha}(A_2+B_2\gamma_5) +p_{1\alpha}p_{0\beta}(A_3+B_3\gamma_5) \right]u^\alpha(p_0)\]
\[\bar{u}^\alpha(p_1)\left[(A_1+B_1\gamma_5)g_{\alpha\beta} +p_{0\alpha}p_{1\beta}(A_2+B_2\gamma_5)\right]u^\beta(p_0)\]
Definition at line 57 of file Baryon1MesonDecayerBase.h.
|
virtual |
Construct the SpinInfos for the particles produced in the decay.
Implements Herwig::DecayIntegrator.
|
virtual |
Output the setup information for the particle database.
os | The stream to output the information to |
header | Whether or not to output the information for MySQL |
Reimplemented from Herwig::DecayIntegrator.
Reimplemented in Herwig::KornerKramerCharmDecayer, Herwig::NonLeptonicHyperonDecayer, Herwig::NonLeptonicOmegaDecayer, Herwig::OmegaXiStarPionDecayer, Herwig::RadiativeDoublyHeavyBaryonDecayer, Herwig::RadiativeHeavyBaryonDecayer, Herwig::RadiativeHyperonDecayer, Herwig::StrongHeavyBaryonDecayer, Herwig::SU3BaryonDecupletOctetPhotonDecayer, Herwig::SU3BaryonDecupletOctetScalarDecayer, Herwig::SU3BaryonOctetDecupletScalarDecayer, Herwig::SU3BaryonOctetOctetPhotonDecayer, Herwig::SU3BaryonOctetOctetScalarDecayer, Herwig::SU3BaryonSingletOctetPhotonDecayer, and Herwig::SU3BaryonSingletOctetScalarDecayer.
|
private |
Matrix Element Calculation Members.
Matrix element for spin- \(\frac12\) to spin- \(\frac12\) and a scalar.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
|
protectedvirtual |
Coupling Members.
Couplings for spin- \(\frac12\) to spin- \(\frac12\) and a scalar. This method must be implemented in any class inheriting from this one which includes \(\frac12\to\frac12+0\) decays.
imode | The mode |
m0 | The mass of the decaying particle. |
m1 | The mass of the outgoing baryon. |
m2 | The mass of the outgoing meson. |
A | The coupling \(A\) described above. |
B | The coupling \(B\) described above. |
Reimplemented in Herwig::KornerKramerCharmDecayer, Herwig::NonLeptonicHyperonDecayer, Herwig::StrongHeavyBaryonDecayer, Herwig::SU3BaryonOctetOctetScalarDecayer, and Herwig::SU3BaryonSingletOctetScalarDecayer.
|
private |
Matrix element for spin- \(\frac12\) to spin- \(\frac12\) and a vector.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
|
protectedvirtual |
Couplings for spin- \(\frac12\) to spin- \(\frac12\) and a vector.
This method must be implemented in any class inheriting from this one which includes \(\frac12\to\frac12+1\) decays.
imode | The mode |
m0 | The mass of the decaying particle. |
m1 | The mass of the outgoing baryon. |
m2 | The mass of the outgoing meson. |
A1 | The coupling \(A_1\) described above. |
A2 | The coupling \(A_2\) described above. |
B1 | The coupling \(B_1\) described above. |
B2 | The coupling \(B_2\) described above. |
Reimplemented in Herwig::KornerKramerCharmDecayer, Herwig::RadiativeDoublyHeavyBaryonDecayer, Herwig::RadiativeHeavyBaryonDecayer, Herwig::RadiativeHyperonDecayer, Herwig::SU3BaryonOctetOctetPhotonDecayer, and Herwig::SU3BaryonSingletOctetPhotonDecayer.
|
private |
Matrix element for spin- \(\frac12\) to spin- \(\frac32\) and a scalar.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
|
protectedvirtual |
Couplings for spin- \(\frac12\) to spin- \(\frac32\) and a scalar.
This method must be implemented in any class inheriting from this one which includes \(\frac12\to\frac32+0\) or \(\frac32\to\frac12+0\) decays.
imode | The mode |
m0 | The mass of the decaying particle. |
m1 | The mass of the outgoing baryon. |
m2 | The mass of the outgoing meson. |
A | The coupling \(A\) described above. |
B | The coupling \(B\) described above. |
Reimplemented in Herwig::KornerKramerCharmDecayer, Herwig::StrongHeavyBaryonDecayer, and Herwig::SU3BaryonOctetDecupletScalarDecayer.
|
private |
Matrix element for spin- \(\frac12\) to spin- \(\frac32\) and a vector.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
|
protectedvirtual |
Couplings for spin- \(\frac12\) to spin- \(\frac32\) and a vector.
This method must be implemented in any class inheriting from this one which includes \(\frac12\to\frac32+1\) or \(\frac32\to\frac12+1\) decays.
imode | The mode |
m0 | The mass of the decaying particle. |
m1 | The mass of the outgoing baryon. |
m2 | The mass of the outgoing meson. |
A1 | The coupling \(A_1\) described above. |
A2 | The coupling \(A_2\) described above. |
A3 | The coupling \(A_3\) described above. |
B1 | The coupling \(B_1\) described above. |
B2 | The coupling \(B_2\) described above. |
B3 | The coupling \(B_3\) described above. |
Reimplemented in Herwig::KornerKramerCharmDecayer.
|
virtual |
Return the matrix element squared for a given mode and phase-space channel.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
Implements Herwig::DecayIntegrator.
|
private |
Matrix element for spin- \(\frac32\) to spin- \(\frac12\) and a scalar.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
|
protectedvirtual |
Couplings for spin- \(\frac32\) to spin- \(\frac12\) and a scalar.
This method must be implemented in any class inheriting from this one which includes \(\frac12\to\frac32+0\) or \(\frac32\to\frac12+0\) decays.
imode | The mode |
m0 | The mass of the decaying particle. |
m1 | The mass of the outgoing baryon. |
m2 | The mass of the outgoing meson. |
A | The coupling \(A\) described above. |
B | The coupling \(B\) described above. |
Reimplemented in Herwig::NonLeptonicOmegaDecayer, Herwig::StrongHeavyBaryonDecayer, Herwig::SU3BaryonDecupletOctetScalarDecayer, Herwig::SU3BaryonOctetOctetScalarDecayer, and Herwig::SU3BaryonSingletOctetScalarDecayer.
|
private |
Matrix element for spin- \(\frac32\) to spin- \(\frac12\) and a vector.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
|
protectedvirtual |
Couplings for spin- \(\frac32\) to spin- \(\frac12\) and a vector.
This method must be implemented in any class inheriting from this one which includes \(\frac12\to\frac32+1\) or \(\frac32\to\frac12+1\) decays.
imode | The mode |
m0 | The mass of the decaying particle. |
m1 | The mass of the outgoing baryon. |
m2 | The mass of the outgoing meson. |
A1 | The coupling \(A_1\) described above. |
A2 | The coupling \(A_2\) described above. |
A3 | The coupling \(A_3\) described above. |
B1 | The coupling \(B_1\) described above. |
B2 | The coupling \(B_2\) described above. |
B3 | The coupling \(B_3\) described above. |
Reimplemented in Herwig::RadiativeDoublyHeavyBaryonDecayer, Herwig::RadiativeHeavyBaryonDecayer, Herwig::SU3BaryonDecupletOctetPhotonDecayer, Herwig::SU3BaryonOctetOctetPhotonDecayer, and Herwig::SU3BaryonSingletOctetPhotonDecayer.
|
private |
Matrix element for spin- \(\frac32\) to spin- \(\frac32\) and a scalar.
ichan | The channel we are calculating the matrix element for. |
part | The decaying Particle. |
outgoing | The particles produced in the decay |
momenta | The momenta of the particles produced in the decay |
meopt | Option for the calculation of the matrix element |
|
protectedvirtual |
Couplings for spin- \(\frac32\) to spin- \(\frac32\) and a scalar.
This method must be implemented in any class inheriting from this one which includes \(\frac32\to\frac32+0\) decays.
imode | The mode |
m0 | The mass of the decaying particle. |
m1 | The mass of the outgoing baryon. |
m2 | The mass of the outgoing meson. |
A1 | The coupling \(A_1\) described above. |
A2 | The coupling \(A_2\) described above. |
B1 | The coupling \(B_1\) described above. |
B2 | The coupling \(B_2\) described above. |
Reimplemented in Herwig::OmegaXiStarPionDecayer, Herwig::StrongHeavyBaryonDecayer, and Herwig::SU3BaryonOctetDecupletScalarDecayer.
|
virtual |
Specify the \(1\to2\) matrix element to be used in the running width calculation.
dm | The DecayMode |
mecode | The code for the matrix element as described in the GenericWidthGenerator class. |
coupling | The coupling for the matrix element. |
Reimplemented from Herwig::DecayIntegrator.
|
friend |
The BaryonWidthGenerator is a friend to get access to the couplings.
Definition at line 62 of file Baryon1MesonDecayerBase.h.
|
mutableprivate |
Spin- \(\frac12\) spinor.
Definition at line 356 of file Baryon1MesonDecayerBase.h.
|
mutableprivate |
Spin- \(\frac12\) barred spinor.
Definition at line 361 of file Baryon1MesonDecayerBase.h.
|
mutableprivate |
Spin- \(\frac32\) spinor.
Definition at line 366 of file Baryon1MesonDecayerBase.h.
|
mutableprivate |
Spin- \(\frac32\) barred spinor.
Definition at line 371 of file Baryon1MesonDecayerBase.h.
|
mutableprivate |
Polarization vector.
Definition at line 376 of file Baryon1MesonDecayerBase.h.
|
mutableprivate |
Spin density matrx.
Definition at line 351 of file Baryon1MesonDecayerBase.h.