ATLAS Offline Software
|
#include <TruthParticle.h>
Public Types | |
typedef ParticleImpl< TruthParticleNavigation, TruthParticleMomentum, TruthParticleBase > | TruthParticleImpl_t |
typedef std::size_t | evtIndex_t |
typedef TruthParticleNavigation | navigable_type |
publish the type of the base class (ie: 'traits-itize' it) More... | |
typedef TruthParticleMomentum | momentum_type |
publish the type of the base class (ie: 'traits-itize' it) More... | |
typedef TruthParticleBase | particle_type |
publish the type of the base class (ie: 'traits-itize' it) More... | |
typedef ParticleImpl< TruthParticleNavigation, TruthParticleMomentum, TruthParticleBase > | self_type |
publish the type of the base class (ie: 'traits-itize' it) More... | |
enum | Kind { P4EETAPHIM, P4IPTCOTTHPHIM, P4PTETAPHIM, P4PXPYPZE, UNKNOWN } |
Public Member Functions | |
TruthParticle () | |
Default constructor. More... | |
TruthParticle (const TruthParticle &rhs) | |
Copy constructor. More... | |
TruthParticle (HepMC::ConstGenParticlePtr genParticle, const TruthParticleContainer *container=0) | |
Constructor with parameters: construct a TruthParticle from a HepMC::GenParticle and the TruthParticleContainer holding this TruthParticle . More... | |
TruthParticle & | operator= (const TruthParticle &rhs) |
Assignment operator. More... | |
~TruthParticle () | |
Default constructor: More... | |
HepMC::ConstGenParticlePtr | genMother (const std::size_t i=0) const |
Retrieve the GenParticle mother of this TruthParticle. More... | |
HepMC::ConstGenParticlePtr | genParticle () const |
Retrieve the GenParticle this TruthParticle has been made from (if any) More... | |
HepMC::ConstGenParticlePtr | genChild (const std::size_t i) const |
Retrieve the i-th child (GenParticle) of this TruthParticle. More... | |
const TruthParticle * | mother (const std::size_t i=0) const |
Retrieve the i-th mother (TruthParticle) of this TruthParticle. More... | |
const TruthParticle * | child (const std::size_t i) const |
Retrieve the i-th child (TruthParticle) of this TruthParticle. More... | |
bool | hasMother (const int pdgId) const |
Return true if the given PDG::id to match can be found within the parents of this TruthParticle. More... | |
bool | hasChild (const int pdgId) const |
Return true if the given PDG::id to match can be found within the children of this TruthParticle. More... | |
bool | hasMother (const int pdgId, std::vector< unsigned int > &indices) const |
Return true if the given PDG::id to match can be found within the parents of this TruthParticle. More... | |
bool | hasChild (const int pdgId, std::vector< unsigned int > &indices) const |
Return true if the given PDG::id to match can be found within the children of this TruthParticle. More... | |
bool | hasEtIsol () const |
Return true if one has filled the Et isolation infos for this TruthParticle . More... | |
double | etIsol (const TruthParticleParameters::ConeSize coneIdx) const |
Return the transverse energy in a given cone size of isolation. More... | |
const TruthEtIsolations::EtIsol_t * | etIsol () const |
Return the transverse energies for all the isolation cones. More... | |
unsigned int | nParents () const |
Number of parents of this particle. More... | |
unsigned int | nDecay () const |
Number of children of this particle. More... | |
CLHEP::HepLorentzVector | transformVector (const HepMC::FourVector &) const |
returns a Pointer to a CLHEP::LorentzVector from a HepMC::FourVector More... | |
CLHEP::HepLorentzVector | pDecay (const std::size_t i) const |
Return the 4-vec of i-th child of this particle. More... | |
int | pdgDecay (const std::size_t i) const |
Return the PDG-Id of the i-th child of this particle. More... | |
operator const HepMC::GenParticle & () const | |
conversion operator: convert a TruthParticle to its underlying HepMC::GenParticle More... | |
evtIndex_t | genEventIndex () const |
void | setCharge (const ChargeType charge) |
Set the charge of this TruthParticle. More... | |
void | set4Mom (const HepMC::FourVector &hlv) |
void | setGenEventIndex (size_t index) |
set the GenEvent index More... | |
const navigable_type & | navigableBase () const |
access to underlying base type (INavigable-like) More... | |
navigable_type & | navigableBase () |
access to underlying base type (INavigable-like) More... | |
const momentum_type & | momentumBase () const |
access to underlying base type (I4Momentum-like) More... | |
momentum_type & | momentumBase () |
access to underlying base type (I4Momentum-like) More... | |
const particle_type & | particleBase () const |
access to underlying base type (IParticle-like) More... | |
particle_type & | particleBase () |
access to underlying base type (IParticle-like) More... | |
virtual AthenaBarCode_t | getAthenaBarCode () const |
virtual AthenaBarCodeVersion_t | getVersion () const |
virtual double | px () const =0 |
x component of momentum More... | |
virtual double | py () const =0 |
y component of momentum More... | |
virtual double | pz () const =0 |
z component of momentum More... | |
virtual double | m () const =0 |
mass More... | |
virtual double | m2 () const =0 |
mass squared More... | |
virtual double | p () const =0 |
momentum magnitude More... | |
virtual double | p2 () const =0 |
square of momentum magnitude More... | |
virtual double | rapidity () const =0 |
rapidity More... | |
virtual double | eta () const =0 |
pseudo rapidity More... | |
virtual double | phi () const =0 |
phi in [-pi,pi[ More... | |
virtual double | e () const =0 |
energy More... | |
virtual double | et () const =0 |
transverse energy defined to be e*sin(theta) More... | |
virtual double | pt () const =0 |
transverse momentum More... | |
virtual double | iPt () const =0 |
inverse of transverse momentum More... | |
virtual double | cosPhi () const =0 |
cosinus phi More... | |
virtual double | sinPhi () const =0 |
sinus phi More... | |
virtual double | tanTh () const =0 |
tan theta More... | |
virtual double | cosTh () const =0 |
cosinus theta More... | |
virtual double | sinTh () const =0 |
sinus theta More... | |
virtual double | cotTh () const =0 |
cottan theta More... | |
virtual CLHEP::HepLorentzVector | hlv () const =0 |
CLHEP HepLorentzVector. More... | |
virtual const I4MomentumError * | errors () const =0 |
Access to errors, if available; returns 0 if no errors. More... | |
virtual Kind | kind () const =0 |
tells what kind of P4XYZT this is More... | |
virtual ParticleDataType::DataType | dataType () const =0 |
Return enum indicating real data, fast, or full simulation Return Type has a DataType enum with the following values: {Data = 0, Full = 1, FastShower = 2, Fast = 3, True = 4} More... | |
virtual const Trk::RecVertex * | origin () const =0 |
Return a RecVertex corresponding to particle Origin More... | |
virtual const ElementLink< VxContainer > & | originLink () const =0 |
Return an ElementLink corresponding to particle's Origin. More... | |
virtual bool | hasCharge () const =0 |
method to check if charge information is available More... | |
virtual ChargeType | charge () const =0 |
returns charge as a typedef ChargeType currently Charge Type is a double for jets this may be changed to an int and ask jets to extend this interface More... | |
virtual bool | hasPdgId () const =0 |
method to check if particle id information is available More... | |
virtual int | pdgId () const =0 |
Return enum indicating particle id the enum file is available in Event/EventKernel/PdtPdg.h More... | |
virtual void | set4Mom (const I4Momentum &p4) |
set 4Momentum (will throw exception if cannot be implemented) More... | |
virtual void | set4Mom (const I4Momentum *const p4) |
set 4Momentum (will throw exception if cannot be implemented) More... | |
virtual void | set4Mom (const CLHEP::HepLorentzVector &hlv) |
set 4Momentum (will throw exception if cannot be implemented) More... | |
virtual void | set_dataType (ParticleDataType::DataType x) |
virtual void | set_charge (ChargeType x) |
virtual void | set_pdgId (int x) |
virtual void | set_origin (const VxContainer *theContainer, int index) |
virtual void | set_origin (const VxContainer *theContainer, const Trk::VxCandidate *vertex) |
void | set_origin (const ElementLink< VxContainer > &origin) |
virtual void | fillToken (INavigationToken &thisToken) const |
virtual void | fillToken (INavigationToken &thisToken, const std::any &weight) const |
AthenaBarCode_t | getAthenaBarCode () const |
void | setAthenaBarCode (AthenaBarCode_t) |
bool | hasSameAthenaBarCode (const IAthenaBarCode &) const |
bool | hasSameAthenaBarCodeExceptVersion (const IAthenaBarCode &) const |
AthenaBarCodeVersion_t | getVersion () const |
void | newVersion () |
void | setVersion (AthenaBarCodeVersion_t newversion) |
virtual double | px () const |
x component of momentum More... | |
virtual double | py () const |
y component of momentum More... | |
virtual double | pz () const |
z component of momentum More... | |
virtual double | m () const |
mass More... | |
virtual double | m2 () const |
mass squared More... | |
virtual double | p () const |
mass momentum magnitude More... | |
virtual double | p2 () const |
square of momentum magnitude More... | |
virtual double | rapidity () const |
rapidity More... | |
virtual double | eta () const |
pseudo rapidity More... | |
virtual double | phi () const |
phi in [-pi,pi[ More... | |
virtual double | e () const |
energy More... | |
virtual double | et () const |
transverse energy defined to be e*sin(theta) More... | |
virtual double | pt () const |
transverse momentum More... | |
virtual double | iPt () const |
inverse of transverse momentum More... | |
virtual double | cosPhi () const |
cosinus phi More... | |
virtual double | sinPhi () const |
sinus phi More... | |
virtual double | tanTh () const |
tan theta More... | |
virtual double | cosTh () const |
cosinus theta More... | |
virtual double | sinTh () const |
sinus theta More... | |
virtual double | cotTh () const |
cottan theta More... | |
virtual CLHEP::HepLorentzVector | hlv () const |
CLHEP HepLorentzVector. More... | |
virtual const I4MomentumError * | errors () const |
Access to errors, if available; returns 0 if no errors. More... | |
virtual I4Momentum::Kind | kind () const |
add Kind which tells what kind (P4XYZ) the underlying implementation has More... | |
virtual std::ostream & | dump (std::ostream &out) const |
Print I4Momentum content. More... | |
virtual ParticleDataType::DataType | dataType () const |
Return enum indicating real data, fast, or full simulation Return Type has a DataType enum with the following values: {Data = 0, Full = 1, FastShower = 2, Fast = 3, True = 4} More... | |
virtual const Trk::RecVertex * | origin () const |
Return a RecVertex corresponding to particle Origin More... | |
virtual const ElementLink< VxContainer > & | originLink () const |
Return an ElementLink corresponding to particle's Origin. More... | |
virtual bool | hasCharge () const |
method to check if charge information is available More... | |
virtual ChargeType | charge () const |
returns charge as a typedef ChargeType currently Charge Type is a double for jets this may be changed to an int and ask jets to extend this interface More... | |
virtual bool | hasPdgId () const |
method to check if particle id information is available More... | |
virtual int | pdgId () const |
Return enum indicating particle id the enum file is available in Event/EventKernel/PdtPdg.h More... | |
int | status () const |
Forwards the HepMC::GenParticle::status() information. More... | |
const HepMC::Flow | flow () const |
Forwards the HepMC::GenParticle::flow() information. More... | |
int | flow (int code_index) const |
Forwards the HepMC::GenParticle::flow(idx) information. More... | |
const HepMC::Polarization | polarization () const |
Forwards the HepMC::GenParticle::polarization() information. More... | |
int | barcode () const |
Forwards the HepMC::GenParticle::barcode() information. More... | |
long | compressedExtBarCode () const |
Forwards the HepMC::GenParticle::barcode() information. More... | |
virtual void | fillToken (INavigationToken &thisToken) const |
virtual void | fillToken (INavigationToken &thisToken, const std::any &weight) const |
AthenaBarCode_t | getAthenaBarCode () const |
void | setAthenaBarCode (AthenaBarCode_t) |
bool | hasSameAthenaBarCode (const IAthenaBarCode &) const |
bool | hasSameAthenaBarCodeExceptVersion (const IAthenaBarCode &) const |
AthenaBarCodeVersion_t | getVersion () const |
void | newVersion () |
void | setVersion (AthenaBarCodeVersion_t newversion) |
virtual double | px () const |
x component of momentum More... | |
virtual double | py () const |
y component of momentum More... | |
virtual double | pz () const |
z component of momentum More... | |
virtual double | m () const |
mass More... | |
virtual double | m2 () const |
mass squared More... | |
virtual double | p () const |
mass momentum magnitude More... | |
virtual double | p2 () const |
square of momentum magnitude More... | |
virtual double | rapidity () const |
rapidity More... | |
virtual double | eta () const |
pseudo rapidity More... | |
virtual double | phi () const |
phi in [-pi,pi[ More... | |
virtual double | e () const |
energy More... | |
virtual double | et () const |
transverse energy defined to be e*sin(theta) More... | |
virtual double | pt () const |
transverse momentum More... | |
virtual double | iPt () const |
inverse of transverse momentum More... | |
virtual double | cosPhi () const |
cosinus phi More... | |
virtual double | sinPhi () const |
sinus phi More... | |
virtual double | tanTh () const |
tan theta More... | |
virtual double | cosTh () const |
cosinus theta More... | |
virtual double | sinTh () const |
sinus theta More... | |
virtual double | cotTh () const |
cottan theta More... | |
virtual CLHEP::HepLorentzVector | hlv () const |
CLHEP HepLorentzVector. More... | |
virtual const I4MomentumError * | errors () const |
Access to errors, if available; returns 0 if no errors. More... | |
virtual I4Momentum::Kind | kind () const |
add Kind which tells what kind (P4XYZ) the underlying implementation has More... | |
virtual std::ostream & | dump (std::ostream &out) const |
Print I4Momentum content. More... | |
virtual ParticleDataType::DataType | dataType () const |
Return enum indicating real data, fast, or full simulation Return Type has a DataType enum with the following values: {Data = 0, Full = 1, FastShower = 2, Fast = 3, True = 4} More... | |
virtual const Trk::RecVertex * | origin () const |
Return a RecVertex corresponding to particle Origin More... | |
virtual const ElementLink< VxContainer > & | originLink () const |
Return an ElementLink corresponding to particle's Origin. More... | |
virtual bool | hasCharge () const |
method to check if charge information is available More... | |
virtual ChargeType | charge () const |
returns charge as a typedef ChargeType currently Charge Type is a double for jets this may be changed to an int and ask jets to extend this interface More... | |
virtual bool | hasPdgId () const |
method to check if particle id information is available More... | |
virtual int | pdgId () const |
Return enum indicating particle id the enum file is available in Event/EventKernel/PdtPdg.h More... | |
Static Public Attributes | |
static const AthenaBarCode_t | UNDEFINEDBARCODE = (AthenaBarCode_t)(-1) |
static const AthenaBarCode_t | UNDEFINEDVERSION = UNDEFINEDBARCODE |
Protected Member Functions | |
void | setGenParticle (HepMC::ConstGenParticlePtr particle) |
Fill the data members of ParticleBase from the GenParticle. More... | |
Protected Attributes | |
const TruthParticleContainer * | m_container |
Pointer to the collection holding ourself. More... | |
std::vector< int > | m_mothers |
vector of barcodes of all the mothers of this particle. More... | |
std::vector< int > | m_children |
vector of barcodes of all the children of this particle. More... | |
evtIndex_t | m_nGenEventIdx |
the index of the GenEvent this particle is in More... | |
Private Attributes | |
TruthParticleNavigation | m_nav |
The navigable part. More... | |
TruthParticleMomentum | m_mom |
The 4-momentum part. More... | |
TruthParticleBase | m_part |
The particle-id part. More... | |
(HepMC) Monte Carlo particle.
Adds isolation information. Adapts the HepMC::GenParticle
to the IParticle
interface.
Definition at line 53 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
typedef std::size_t TruthParticle::evtIndex_t |
Definition at line 71 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inherited |
publish the type of the base class (ie: 'traits-itize' it)
Definition at line 52 of file ParticleImpl.h.
|
inherited |
publish the type of the base class (ie: 'traits-itize' it)
Definition at line 48 of file ParticleImpl.h.
|
inherited |
publish the type of the base class (ie: 'traits-itize' it)
Definition at line 56 of file ParticleImpl.h.
|
inherited |
publish the type of the base class (ie: 'traits-itize' it)
Definition at line 62 of file ParticleImpl.h.
typedef ParticleImpl< TruthParticleNavigation, TruthParticleMomentum, TruthParticleBase > TruthParticle::TruthParticleImpl_t |
Definition at line 69 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inherited |
Enumerator | |
---|---|
P4EETAPHIM | |
P4IPTCOTTHPHIM | |
P4PTETAPHIM | |
P4PXPYPZE | |
UNKNOWN |
Definition at line 33 of file I4Momentum.h.
TruthParticle::TruthParticle | ( | ) |
TruthParticle::TruthParticle | ( | const TruthParticle & | rhs | ) |
TruthParticle::TruthParticle | ( | HepMC::ConstGenParticlePtr | genParticle, |
const TruthParticleContainer * | container = 0 |
||
) |
Constructor with parameters: construct a TruthParticle
from a HepMC::GenParticle
and the TruthParticleContainer
holding this TruthParticle
.
Definition at line 56 of file TruthParticle.cxx.
|
inline |
Default constructor:
Definition at line 276 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inline |
Forwards the HepMC::GenParticle::barcode() information.
Definition at line 304 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inlinevirtualinherited |
returns charge as a typedef ChargeType currently Charge Type is a double for jets this may be changed to an int and ask jets to extend this interface
Definition at line 248 of file ParticleImpl.h.
|
pure virtualinherited |
returns charge as a typedef ChargeType currently Charge Type is a double for jets this may be changed to an int and ask jets to extend this interface
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Analysis::ParticleShallowClone, and ParticleBase.
const TruthParticle * TruthParticle::child | ( | const std::size_t | i | ) | const |
Retrieve the i-th child (TruthParticle) of this TruthParticle.
Definition at line 98 of file TruthParticle.cxx.
|
inline |
Forwards the HepMC::GenParticle::barcode() information.
Definition at line 138 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inlinevirtualinherited |
|
pure virtualinherited |
cosinus phi
Implemented in CaloCell, CaloVertexedCell, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4IPtCotThPhiMBase, P4EEtaPhiMBase, P4PtEtaPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
|
pure virtualinherited |
cosinus theta
Implemented in CaloCell, CaloVertexedCell, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4IPtCotThPhiMBase, P4EEtaPhiMBase, P4PtEtaPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
|
pure virtualinherited |
|
inlinevirtualinherited |
Return enum indicating real data, fast, or full simulation Return Type has a DataType enum with the following values: {Data = 0, Full = 1, FastShower = 2, Fast = 3, True = 4}
IParticle interface forwarding
Definition at line 230 of file ParticleImpl.h.
|
pure virtualinherited |
Return enum indicating real data, fast, or full simulation Return Type has a DataType enum with the following values: {Data = 0, Full = 1, FastShower = 2, Fast = 3, True = 4}
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Analysis::ParticleShallowClone, and ParticleBase.
|
inlinevirtualinherited |
|
inlinevirtualinherited |
|
pure virtualinherited |
energy
Implemented in CaloTower, CaloCell, CaloVertexedCell, CaloCluster, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4PxPyPzE, TrigT2Jet, P4EEtaPhiM, P4PtEtaPhiMBase, and P4IPtCotThPhiMBase.
|
inlinevirtualinherited |
Access to errors, if available; returns 0 if no errors.
Definition at line 214 of file ParticleImpl.h.
|
pure virtualinherited |
Access to errors, if available; returns 0 if no errors.
Implemented in egamma, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4PtEtaPhiM, P4PxPyPzE, P4EEtaPhiM, P4IPtCotThPhiM, P4EEtaPhiMBase, P4PtEtaPhiMBase, P4IPtCotThPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
transverse energy defined to be e*sin(theta)
Definition at line 176 of file ParticleImpl.h.
|
pure virtualinherited |
transverse energy defined to be e*sin(theta)
Implemented in CaloCell, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4PtEtaPhiMBase, P4PxPyPzEBase, P4IPtCotThPhiMBase, and P4EEtaPhiMBase.
|
inlinevirtualinherited |
|
pure virtualinherited |
pseudo rapidity
Implemented in TileTrackMuFeature, CombinedMuonFeature, IsoMuonFeature, TrigMuonClusterFeature, CaloTower, CaloCell, CaloVertexedCell, CaloCluster, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, Muon_ROI, EmTau_ROI, Jet_ROI, TrigT2Jet, P4PtEtaPhiM, P4EEtaPhiM, P4IPtCotThPhiMBase, and P4PxPyPzEBase.
const TruthEtIsolations::EtIsol_t * TruthParticle::etIsol | ( | ) | const |
Return the transverse energies for all the isolation cones.
Definition at line 188 of file TruthParticle.cxx.
double TruthParticle::etIsol | ( | const TruthParticleParameters::ConeSize | coneIdx | ) | const |
Return the transverse energy in a given cone size of isolation.
Note that the size of the code must be one of the encoded sizes (see TruthParticleParamDefs.h file) and that the index is checked for out of bounds.
Definition at line 194 of file TruthParticle.cxx.
|
inlinevirtualinherited |
INavigable
interface forwarding
Implements INavigable.
Definition at line 104 of file ParticleImpl.h.
|
inlinevirtualinherited |
Implements INavigable.
Definition at line 106 of file ParticleImpl.h.
|
inline |
Forwards the HepMC::GenParticle::flow() information.
Definition at line 289 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inline |
Forwards the HepMC::GenParticle::flow(idx) information.
Definition at line 294 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
HepMC::ConstGenParticlePtr TruthParticle::genChild | ( | const std::size_t | i | ) | const |
Retrieve the i-th child (GenParticle) of this TruthParticle.
Definition at line 118 of file TruthParticle.cxx.
|
inline |
Definition at line 211 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
HepMC::ConstGenParticlePtr TruthParticle::genMother | ( | const std::size_t | i = 0 | ) | const |
Retrieve the GenParticle mother of this TruthParticle.
Definition at line 107 of file TruthParticle.cxx.
|
inline |
Retrieve the GenParticle this TruthParticle has been made from (if any)
Definition at line 279 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inlinevirtualinherited |
Reimplemented in Rec::TrackParticle, Analysis::ParticleShallowClone, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, and AthenaBarCodeBase.
Definition at line 67 of file AthenaKernel/AthenaKernel/IAthenaBarCode.h.
|
inlineinherited |
IAthenaBarCode
interface forwarding
Definition at line 114 of file ParticleImpl.h.
|
inlinevirtualinherited |
Reimplemented in Analysis::ParticleShallowClone, Rec::TrackParticle, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, and AthenaBarCodeBase.
Definition at line 85 of file AthenaKernel/AthenaKernel/IAthenaBarCode.h.
|
inlineinherited |
Definition at line 119 of file ParticleImpl.h.
|
inlinevirtualinherited |
method to check if charge information is available
Definition at line 242 of file ParticleImpl.h.
|
pure virtualinherited |
method to check if charge information is available
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Analysis::ParticleShallowClone, and ParticleBase.
bool TruthParticle::hasChild | ( | const int | pdgId | ) | const |
Return true if the given PDG::id to match can be found within the children of this TruthParticle.
Definition at line 141 of file TruthParticle.cxx.
bool TruthParticle::hasChild | ( | const int | pdgId, |
std::vector< unsigned int > & | indices | ||
) | const |
Return true if the given PDG::id to match can be found within the children of this TruthParticle.
It also fills the given vector with the indices toward the matching particles.
Definition at line 168 of file TruthParticle.cxx.
bool TruthParticle::hasEtIsol | ( | ) | const |
Return true if one has filled the Et isolation infos for this TruthParticle
.
Definition at line 183 of file TruthParticle.cxx.
bool TruthParticle::hasMother | ( | const int | pdgId | ) | const |
Return true if the given PDG::id to match can be found within the parents of this TruthParticle.
Definition at line 129 of file TruthParticle.cxx.
bool TruthParticle::hasMother | ( | const int | pdgId, |
std::vector< unsigned int > & | indices | ||
) | const |
Return true if the given PDG::id to match can be found within the parents of this TruthParticle.
It also fills the given vector with the indices toward the matching particles.
Definition at line 153 of file TruthParticle.cxx.
|
inlinevirtualinherited |
method to check if particle id information is available
Definition at line 252 of file ParticleImpl.h.
|
pure virtualinherited |
method to check if particle id information is available
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Analysis::ParticleShallowClone, and ParticleBase.
|
inlinevirtualinherited |
Reimplemented from IAthenaBarCode.
Definition at line 117 of file ParticleImpl.h.
|
inlinevirtualinherited |
Reimplemented from IAthenaBarCode.
Definition at line 118 of file ParticleImpl.h.
|
inlinevirtualinherited |
CLHEP HepLorentzVector.
Definition at line 212 of file ParticleImpl.h.
|
pure virtualinherited |
CLHEP HepLorentzVector.
Implemented in CaloCluster, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4EEtaPhiMBase, P4PtEtaPhiMBase, P4IPtCotThPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
inverse of transverse momentum
Definition at line 184 of file ParticleImpl.h.
|
pure virtualinherited |
inverse of transverse momentum
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4IPtCotThPhiM, P4EEtaPhiMBase, P4PtEtaPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
add Kind which tells what kind (P4XYZ) the underlying implementation has
Definition at line 217 of file ParticleImpl.h.
|
pure virtualinherited |
tells what kind of P4XYZT this is
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4EEtaPhiMBase, P4PtEtaPhiMBase, P4IPtCotThPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
|
pure virtualinherited |
mass
Implemented in TileTrackMuFeature, CombinedMuonFeature, IsoMuonFeature, TrigMuonClusterFeature, CaloTower, CaloCell, CaloVertexedCell, CaloCluster, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, Muon_ROI, EmTau_ROI, P4Impl< P4Mom_t >, Jet_ROI, TrigT2Jet, P4PtEtaPhiM, P4EEtaPhiM, P4IPtCotThPhiM, and P4PxPyPzEBase.
|
inlinevirtualinherited |
|
pure virtualinherited |
|
inlineinherited |
access to underlying base type (I4Momentum-like)
Definition at line 272 of file ParticleImpl.h.
|
inlineinherited |
access to underlying base type (I4Momentum-like)
Definition at line 95 of file ParticleImpl.h.
const TruthParticle * TruthParticle::mother | ( | const std::size_t | i = 0 | ) | const |
Retrieve the i-th mother (TruthParticle) of this TruthParticle.
Definition at line 90 of file TruthParticle.cxx.
|
inlineinherited |
access to underlying base type (INavigable-like)
Definition at line 268 of file ParticleImpl.h.
|
inlineinherited |
access to underlying base type (INavigable-like)
Definition at line 91 of file ParticleImpl.h.
|
inline |
Number of children of this particle.
Definition at line 312 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inlinevirtualinherited |
Reimplemented from IAthenaBarCode.
Definition at line 120 of file ParticleImpl.h.
|
inline |
Number of parents of this particle.
Definition at line 309 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inline |
conversion operator: convert a TruthParticle
to its underlying HepMC::GenParticle
Definition at line 321 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
TruthParticle & TruthParticle::operator= | ( | const TruthParticle & | rhs | ) |
|
inlinevirtualinherited |
Return a RecVertex corresponding to particle Origin
Definition at line 234 of file ParticleImpl.h.
|
pure virtualinherited |
Return a RecVertex corresponding to particle Origin
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Analysis::ParticleShallowClone, and ParticleBase.
|
inlinevirtualinherited |
Return an ElementLink corresponding to particle's Origin.
Definition at line 238 of file ParticleImpl.h.
|
pure virtualinherited |
Return an ElementLink corresponding to particle's Origin.
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Analysis::ParticleShallowClone, and ParticleBase.
|
inlinevirtualinherited |
mass momentum magnitude
Definition at line 152 of file ParticleImpl.h.
|
pure virtualinherited |
|
inlinevirtualinherited |
square of momentum magnitude
Definition at line 156 of file ParticleImpl.h.
|
pure virtualinherited |
square of momentum magnitude
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4IPtCotThPhiMBase, P4EEtaPhiMBase, P4PtEtaPhiMBase, and P4PxPyPzEBase.
|
inlineinherited |
access to underlying base type (IParticle-like)
Definition at line 276 of file ParticleImpl.h.
|
inlineinherited |
access to underlying base type (IParticle-like)
Definition at line 99 of file ParticleImpl.h.
CLHEP::HepLorentzVector TruthParticle::pDecay | ( | const std::size_t | i | ) | const |
int TruthParticle::pdgDecay | ( | const std::size_t | i | ) | const |
Return the PDG-Id of the i-th child of this particle.
Definition at line 221 of file TruthParticle.cxx.
|
inlinevirtualinherited |
Return enum indicating particle id the enum file is available in Event/EventKernel/PdtPdg.h
Definition at line 257 of file ParticleImpl.h.
|
pure virtualinherited |
Return enum indicating particle id the enum file is available in Event/EventKernel/PdtPdg.h
Implemented in ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Analysis::ParticleShallowClone, and ParticleBase.
|
inlinevirtualinherited |
|
pure virtualinherited |
phi in [-pi,pi[
Implemented in TileTrackMuFeature, CombinedMuonFeature, IsoMuonFeature, TrigMuonClusterFeature, CaloTower, CaloCell, CaloVertexedCell, CaloCluster, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, Muon_ROI, EmTau_ROI, Jet_ROI, TrigT2Jet, P4PtEtaPhiM, P4EEtaPhiM, P4IPtCotThPhiM, and P4PxPyPzEBase.
|
inline |
Forwards the HepMC::GenParticle::polarization() information.
Definition at line 299 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inlinevirtualinherited |
transverse momentum
Definition at line 180 of file ParticleImpl.h.
|
pure virtualinherited |
transverse momentum
Implemented in TileTrackMuFeature, IsoMuonFeature, CombinedMuonFeature, TrigMuonClusterFeature, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, Muon_ROI, EmTau_ROI, Jet_ROI, P4PtEtaPhiM, P4IPtCotThPhiMBase, P4EEtaPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
x component of momentum
I4Momentum interface forwarding
Definition at line 132 of file ParticleImpl.h.
|
pure virtualinherited |
|
inlinevirtualinherited |
y component of momentum
Definition at line 136 of file ParticleImpl.h.
|
pure virtualinherited |
|
inlinevirtualinherited |
z component of momentum
Definition at line 140 of file ParticleImpl.h.
|
pure virtualinherited |
|
inlinevirtualinherited |
|
pure virtualinherited |
|
inlinevirtualinherited |
set 4Momentum (will throw exception if cannot be implemented)
Implements I4Momentum.
Definition at line 285 of file ParticleImpl.h.
|
inline |
Definition at line 222 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inlinevirtualinherited |
set 4Momentum (will throw exception if cannot be implemented)
Implements I4Momentum.
Definition at line 281 of file ParticleImpl.h.
|
inlinevirtualinherited |
set 4Momentum (will throw exception if cannot be implemented)
Implements I4Momentum.
Definition at line 283 of file ParticleImpl.h.
|
inlinevirtualinherited |
Definition at line 291 of file ParticleImpl.h.
|
inlinevirtualinherited |
Definition at line 289 of file ParticleImpl.h.
|
inlineinherited |
Definition at line 299 of file ParticleImpl.h.
|
inlinevirtualinherited |
Definition at line 297 of file ParticleImpl.h.
|
inlinevirtualinherited |
Definition at line 295 of file ParticleImpl.h.
|
inlinevirtualinherited |
Definition at line 293 of file ParticleImpl.h.
|
inlinevirtualinherited |
Reimplemented from IAthenaBarCode.
Definition at line 115 of file ParticleImpl.h.
|
inline |
Set the charge of this TruthParticle.
Definition at line 327 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inline |
set the GenEvent index
Definition at line 338 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
protected |
Fill the data members of ParticleBase from the GenParticle.
Definition at line 240 of file TruthParticle.cxx.
|
inlinevirtualinherited |
Reimplemented from IAthenaBarCode.
Definition at line 121 of file ParticleImpl.h.
|
inlinevirtualinherited |
|
pure virtualinherited |
sinus phi
Implemented in CaloCell, CaloVertexedCell, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4IPtCotThPhiMBase, P4EEtaPhiMBase, P4PtEtaPhiMBase, and P4PxPyPzEBase.
|
inlinevirtualinherited |
|
pure virtualinherited |
sinus theta
Implemented in CaloCell, CaloVertexedCell, ParticleSigStateImpl< INavigable_t, I4Momentum_t, IParticle_t >, ParticleImpl< INavigable_t, I4Momentum_t, IParticle_t >, Nav4MomWrapper< Navigable_t, P4Momentum_t >, P4Impl< P4Mom_t >, P4IPtCotThPhiMBase, P4EEtaPhiMBase, P4PtEtaPhiMBase, and P4PxPyPzEBase.
|
inline |
Forwards the HepMC::GenParticle::status() information.
HepMC::GenParticle forwarding interface
Definition at line 284 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
inlinevirtualinherited |
|
pure virtualinherited |
|
inline |
returns a Pointer to a CLHEP::LorentzVector from a HepMC::FourVector
Definition at line 332 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
protected |
vector of barcodes of all the children of this particle.
This will be forwarded to the container holding ourself to be able to retrieve TruthParticle pointers.
Definition at line 260 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
protected |
Pointer to the collection holding ourself.
Definition at line 248 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
privateinherited |
The 4-momentum part.
Definition at line 310 of file ParticleImpl.h.
|
protected |
vector of barcodes of all the mothers of this particle.
This will be forwarded to the container holding ourself to be able to retrieve TruthParticle pointers.
Definition at line 254 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
privateinherited |
The navigable part.
Definition at line 307 of file ParticleImpl.h.
|
protected |
the index of the GenEvent this particle is in
Definition at line 263 of file PhysicsAnalysis/TruthParticleID/McParticleEvent/McParticleEvent/TruthParticle.h.
|
privateinherited |
The particle-id part.
Definition at line 313 of file ParticleImpl.h.
|
staticinherited |
Definition at line 52 of file AthenaKernel/AthenaKernel/IAthenaBarCode.h.
|
staticinherited |
Definition at line 53 of file AthenaKernel/AthenaKernel/IAthenaBarCode.h.