Belle II Software development
|
Class to store reconstructed particles. More...
#include <Particle.h>
Public Types | |
enum | EParticleSourceObject { c_Undefined = 0 , c_Track = 1 , c_ECLCluster = 2 , c_KLMCluster = 3 , c_V0 = 4 , c_MCParticle = 5 , c_Composite = 6 , c_NoMDSTSource = 7 } |
particle source enumerators More... | |
enum | EFlavorType { c_Unflavored = 0 , c_Flavored = 1 } |
describes flavor type, see getFlavorType(). More... | |
enum | { c_DimPosition = 3 , c_DimMomentum = 4 , c_DimMatrix = 7 , c_SizeMatrix = c_DimMatrix * (c_DimMatrix + 1) / 2 } |
error matrix dimensions and size of 1D representation More... | |
enum | { c_Px , c_Py , c_Pz , c_E , c_X , c_Y , c_Z } |
enumerator used for error matrix handling, shows also in which order the rows (columns) are defined More... | |
enum | PropertyFlags { c_Ordinary = 0 , c_IsUnspecified = 1 , c_IsIgnoreRadiatedPhotons = 2 , c_IsIgnoreIntermediate = 4 , c_IsIgnoreMassive = 8 , c_IsIgnoreNeutrino = 16 , c_IsIgnoreGamma = 32 , c_IsIgnoreBrems = 64 , c_IsIgnoreMisID = 128 , c_IsIgnoreDecayInFlight = 256 } |
Flags that describe the particle property, which are used in the MC matching. More... | |
Public Member Functions | |
Particle () | |
Default constructor. | |
Particle (const ROOT::Math::PxPyPzEVector &momentum, const int pdgCode) | |
Constructor from a Lorentz vector and PDG code. | |
Particle (const ROOT::Math::PxPyPzEVector &momentum, const int pdgCode, EFlavorType flavorType, const EParticleSourceObject particleType, const unsigned mdstIndex) | |
Constructor for final state particles. | |
Particle (const ROOT::Math::PxPyPzEVector &momentum, const int pdgCode, EFlavorType flavorType, const std::vector< int > &daughterIndices, TClonesArray *arrayPointer=nullptr) | |
Constructor for composite particles. | |
Particle (const ROOT::Math::PxPyPzEVector &momentum, const int pdgCode, EFlavorType flavorType, const std::vector< int > &daughterIndices, int properties, TClonesArray *arrayPointer=nullptr) | |
Constructor for composite particles. | |
Particle (const ROOT::Math::PxPyPzEVector &momentum, const int pdgCode, EFlavorType flavorType, const std::vector< int > &daughterIndices, int properties, const std::vector< int > &daughterProperties, TClonesArray *arrayPointer=nullptr) | |
Constructor for composite particles. | |
Particle (const Track *track, const Const::ChargedStable &chargedStable) | |
Constructor from a reconstructed track (mdst object Track);. | |
Particle (int trackArrayIndex, const TrackFitResult *trackFit, const Const::ChargedStable &chargedStable) | |
Constructor from a reconstructed Track given as TrackFitResult. | |
Particle (const ECLCluster *eclCluster, const Const::ParticleType &type=Const::photon) | |
Constructor of a photon from a reconstructed ECL cluster that is not matched to any charged track. | |
Particle (const KLMCluster *klmCluster, const int pdgCode=Const::Klong.getPDGCode()) | |
Constructor from a reconstructed KLM cluster. | |
Particle (const MCParticle *MCparticle) | |
Constructor from MC particle (mdst object MCParticle) | |
~Particle () | |
Destructor. | |
void | setPDGCode (const int pdg) |
Sets PDG code. | |
void | set4Vector (const ROOT::Math::PxPyPzEVector &p4) |
Sets Lorentz vector. | |
void | set4VectorDividingByMomentumScaling (const ROOT::Math::PxPyPzEVector &p4) |
Sets Lorentz vector dividing by the momentum scaling factor. | |
void | setVertex (const ROOT::Math::XYZVector &vertex) |
Sets position (decay vertex) | |
void | setEnergyLossCorrection (double energyLossCorrection) |
Sets Energy loss correction. | |
double | getMomentumLossCorrectionFactor () const |
Returns effect of energy correction on the particle momentum. | |
void | setMomentumScalingFactor (double momentumScalingFactor) |
Sets momentum scaling. | |
void | setMomentumSmearingFactor (double momentumSmearingFactor) |
Sets momentum smearing. | |
void | setJacobiMatrix (const TMatrixF &jacobiMatrix) |
Sets 4x6 jacobi matrix. | |
void | setMomentumVertexErrorMatrix (const TMatrixFSym &errMatrix) |
Sets 7x7 error matrix. | |
void | setPValue (double pValue) |
Sets chi^2 probability of fit. | |
void | setProperty (const int properties) |
sets m_properties | |
void | updateMomentum (const ROOT::Math::PxPyPzEVector &p4, const ROOT::Math::XYZVector &vertex, const TMatrixFSym &errMatrix, double pValue) |
Sets Lorentz vector, position, 7x7 error matrix and p-value. | |
void | updateMass (const int pdgCode) |
Updates particle mass with the mass of the particle corresponding to the given PDG. | |
void | appendDaughter (const Particle *daughter, const bool updateType=true, const int daughterProperty=c_Ordinary) |
Appends index of daughter to daughters index array. | |
void | appendDaughter (int particleIndex, const bool updateType=true) |
Appends index of daughter to daughters index array. | |
void | removeDaughter (const Particle *daughter, const bool updateType=true) |
Removes index of daughter from daughters index array. | |
bool | replaceDaughter (const Particle *oldDaughter, Particle *newDaughter) |
Replace index of given daughter with new daughter, return true if a replacement is made. | |
bool | replaceDaughterRecursively (const Particle *oldDaughter, Particle *newDaughter) |
Apply replaceDaughter to all Particles in the decay tree by looping recursively through it, return true if a replacement is made. | |
int | getPDGCode (void) const |
Returns PDG code. | |
double | getCharge (void) const |
Returns particle charge. | |
EFlavorType | getFlavorType () const |
Returns flavor type of the decay (for FS particles: flavor type of particle) | |
EParticleSourceObject | getParticleSource () const |
Returns particle source as defined with enum EParticleSourceObject. | |
unsigned | getMdstArrayIndex (void) const |
Returns 0-based index of MDST store array object (0 for composite particles) | |
int | getProperty () const |
Returns particle property as a bit pattern The values are defined in the PropertyFlags enum and described in detail there. | |
double | getMass () const |
Returns invariant mass (= nominal for FS particles) | |
double | getPDGMass (void) const |
Returns uncertainty on the invariant mass (requires valid momentum error matrix) | |
double | getPDGLifetime () const |
Returns particle nominal lifetime. | |
double | getEnergy () const |
Returns total energy. | |
ROOT::Math::PxPyPzEVector | get4Vector () const |
Returns Lorentz vector. | |
ROOT::Math::XYZVector | getMomentum () const |
Returns momentum vector. | |
double | getMomentumMagnitude () const |
Returns momentum magnitude. | |
double | getP () const |
Returns momentum magnitude (same as getMomentumMagnitude but with shorter name) | |
double | getPx () const |
Returns x component of momentum. | |
double | getPy () const |
Returns y component of momentum. | |
double | getPz () const |
Returns z component of momentum. | |
double | getEffectiveMomentumScale () const |
Returns effective momentum scale which is the product of the momentum scaling and smearing factors. | |
double | getEnergyLossCorrection () const |
Returns Energy Loss Correction. | |
ROOT::Math::XYZVector | getVertex () const |
Returns vertex position (POCA for charged, IP for neutral FS particles) | |
double | getX () const |
Returns x component of vertex position. | |
double | getY () const |
Returns y component of vertex position. | |
double | getZ () const |
Returns z component of vertex position. | |
double | getPValue () const |
Returns chi^2 probability of fit if done or -1. | |
TMatrixFSym | getMomentumVertexErrorMatrix () const |
Returns 7x7 error matrix. | |
TMatrixFSym | getMomentumErrorMatrix () const |
Returns the 4x4 momentum error matrix. | |
TMatrixFSym | getVertexErrorMatrix () const |
Returns the 3x3 position error sub-matrix. | |
double | getCosHelicity (const Particle *mother=nullptr) const |
Returns cosine of the helicity angle The helicity angle is defined in the rest frame of the particle as the angle between the negative momentum of the mother and. | |
double | getCosHelicityDaughter (unsigned iDaughter, unsigned iGrandDaughter=0) const |
Returns cosine of the helicity angle of the given daughter defined by given grand daughter. | |
double | getAcoplanarity () const |
Returns acoplanarity angle defined as the angle between the decay planes of the grand daughters in the particle's rest frame This assumes that the particle and its daughters have two daughters each. | |
int | getMdstSource () const |
Returns unique identifier of final state particle (needed in particle combiner) | |
unsigned | getNDaughters (void) const |
Returns number of daughter particles. | |
const std::vector< int > & | getDaughterIndices () const |
Returns a vector of store array indices of daughter particles. | |
const std::vector< int > & | getDaughterProperties () const |
Returns a vector of properties of daughter particles. | |
const Particle * | getDaughter (unsigned i) const |
Returns a pointer to the i-th daughter particle. | |
bool | forEachDaughter (const std::function< bool(const Particle *)> &function, bool recursive=true, bool includeSelf=true) const |
Apply a function to all daughters of this particle. | |
std::vector< Belle2::Particle * > | getDaughters () const |
Returns a vector of pointers to daughter particles. | |
std::vector< const Belle2::Particle * > | getFinalStateDaughters () const |
Returns a vector of pointers to Final State daughter particles. | |
std::vector< const Belle2::Particle * > | getAllDaughters () const |
Returns a vector of pointers to all generations' daughter particles. | |
std::vector< int > | getMdstArrayIndices (EParticleSourceObject type) const |
Returns a vector of StoreArray indices of given MDST dataobjects. | |
bool | overlapsWith (const Particle *oParticle) const |
Returns true if final state ancestors of oParticle overlap. | |
bool | isCopyOf (const Particle *oParticle, bool doDetailedComparison=false) const |
Returns true if this Particle and oParticle are copies of each other. | |
const Track * | getTrack () const |
Returns the pointer to the Track object that was used to create this Particle (ParticleType == c_Track). | |
const TrackFitResult * | getTrackFitResult () const |
Returns the pointer to the TrackFitResult that was used to create this Particle (ParticleType == c_Track). | |
const V0 * | getV0 () const |
Returns the pointer to the V0 object that was used to create this Particle (if ParticleType == c_V0). | |
const PIDLikelihood * | getPIDLikelihood () const |
Returns the pointer to the PIDLikelihood object that is related to the Track, which was used to create this Particle (ParticleType == c_Track). | |
const ECLCluster * | getECLCluster () const |
Returns the pointer to the ECLCluster object that was used to create this Particle (if ParticleType == c_ECLCluster). | |
double | getECLClusterEnergy () const |
Returns the energy of the ECLCluster for the particle. | |
const KLMCluster * | getKLMCluster () const |
Returns the pointer to the KLMCluster object that was used to create this Particle (ParticleType == c_KLMCluster). | |
const MCParticle * | getMCParticle () const |
Returns the pointer to the MCParticle object that was used to create this Particle (ParticleType == c_MCParticle). | |
std::string | getName () const override |
Return name of this particle. | |
std::string | getInfoHTML () const override |
Return a short summary of this object's contents in HTML format. | |
void | print () const |
Prints the contents of a Particle object to standard output. | |
std::vector< std::string > | getExtraInfoNames () const |
get a list of the extra info names | |
void | removeExtraInfo () |
Remove all stored extra info fields. | |
double | getExtraInfo (const std::string &name) const |
Return given value if set. | |
bool | hasExtraInfo (const std::string &name) const |
Return whether the extra info with the given name is set. | |
int | getExtraInfoMap () const |
Return the id of the associated ParticleExtraInfoMap or -1 if no map is set. | |
unsigned int | getExtraInfoSize () const |
Return the size of the extra info array. | |
void | writeExtraInfo (const std::string &name, const double value) |
Sets the user defined extraInfo. | |
void | setExtraInfo (const std::string &name, double value) |
Sets the user-defined data of given name to the given value. | |
void | addExtraInfo (const std::string &name, double value) |
Sets the user-defined data of given name to the given value. | |
TClonesArray * | getArrayPointer () const |
Returns the pointer to the store array which holds the daughter particles. | |
int | getPDGCodeUsedForFit () const |
Return the always positive PDG code which was used for the track fit (if there was a track fit) of this particle. | |
bool | wasExactFitHypothesisUsed () const |
Returns true if the type represented by this Particle object was used use as a mass hypothesis during the track of this Particle's parameters. | |
bool | isMostLikely () const |
Returns true if the (track-based) particle is created with its most likely mass hypothesis based on PID likelihood. | |
std::pair< Const::ChargedStable, const TrackFitResult * > | getMostLikelyTrackFitResult () const |
For a (track-based) particle, returns the charged stable mass hypothesis associated to the most probable TrackFitResult, and the TrackFitResult itself. | |
bool | isMostLikelyTrackFitResult () const |
Returns true if the (track-based) particle is created with its most likely mass hypothesis based on TrackFitResult. | |
ECLCluster::EHypothesisBit | getECLClusterEHypothesisBit () const |
Returns the ECLCluster EHypothesisBit for this Particle. | |
const Particle * | getParticleFromGeneralizedIndexString (const std::string &generalizedIndex) const |
Explores the decay tree of the particle and returns the (grand^n)daughter identified by a generalized index. | |
void | updateJacobiMatrix () |
Propagate the photon energy scaling to jacobian elements that were calculated using energy. | |
void | fillFSPDaughters (std::vector< const Belle2::Particle * > &fspDaughters) const |
Fill final state particle daughters into a vector. | |
void | fillAllDaughters (std::vector< const Belle2::Particle * > &allDaughters) const |
Fill all generations' daughters into a vector. | |
void | addRelationTo (const RelationsInterface< BASE > *object, float weight=1.0, const std::string &namedRelation="") const |
Add a relation from this object to another object (with caching). | |
void | addRelationTo (const TObject *object, float weight=1.0, const std::string &namedRelation="") const |
Add a relation from this object to another object (no caching, can be quite slow). | |
void | copyRelations (const RelationsInterface< BASE > *sourceObj) |
Copies all relations of sourceObj (pointing from or to sourceObj) to this object (including weights). | |
template<class TO > | |
RelationVector< TO > | getRelationsTo (const std::string &name="", const std::string &namedRelation="") const |
Get the relations that point from this object to another store array. | |
template<class FROM > | |
RelationVector< FROM > | getRelationsFrom (const std::string &name="", const std::string &namedRelation="") const |
Get the relations that point from another store array to this object. | |
template<class T > | |
RelationVector< T > | getRelationsWith (const std::string &name="", const std::string &namedRelation="") const |
Get the relations between this object and another store array. | |
template<class TO > | |
TO * | getRelatedTo (const std::string &name="", const std::string &namedRelation="") const |
Get the object to which this object has a relation. | |
template<class FROM > | |
FROM * | getRelatedFrom (const std::string &name="", const std::string &namedRelation="") const |
Get the object from which this object has a relation. | |
template<class T > | |
T * | getRelated (const std::string &name="", const std::string &namedRelation="") const |
Get the object to or from which this object has a relation. | |
template<class TO > | |
std::pair< TO *, float > | getRelatedToWithWeight (const std::string &name="", const std::string &namedRelation="") const |
Get first related object & weight of relation pointing to an array. | |
template<class FROM > | |
std::pair< FROM *, float > | getRelatedFromWithWeight (const std::string &name="", const std::string &namedRelation="") const |
Get first related object & weight of relation pointing from an array. | |
template<class T > | |
std::pair< T *, float > | getRelatedWithWeight (const std::string &name="", const std::string &namedRelation="") const |
Get first related object & weight of relation pointing from/to an array. | |
std::string | getInfo () const |
Return a short summary of this object's contents in raw text format. | |
std::string | getArrayName () const |
Get name of array this object is stored in, or "" if not found. | |
int | getArrayIndex () const |
Returns this object's array index (in StoreArray), or -1 if not found. | |
Private Member Functions | |
void | setMomentumPositionErrorMatrix (const TrackFitResult *trackFit) |
Sets the momentum, position and error matrix for this particle (created from charged Track) | |
void | resetErrorMatrix () |
Resets 7x7 error matrix All elements are set to 0.0. | |
void | resetJacobiMatrix () |
Resets 4x6 error matrix All elements are set to 0.0. | |
void | storeErrorMatrix (const TMatrixFSym &errMatrix) |
Stores 7x7 error matrix into private member m_errMatrix. | |
void | storeJacobiMatrix (const TMatrixF &jacobiMatrix) |
Stores 4x6 Jacobi matrix into private member m_jacobiMatrix. | |
void | fillDecayChain (std::vector< int > &decayChain) const |
Fill vector with (PDGCode, MdstSource) pairs for the entire decay chain. | |
void | setFlavorType () |
sets m_flavorType using m_pdgCode | |
void | setMdstArrayIndex (const int arrayIndex) |
set mdst array index | |
int | generatePDGCodeFromCharge (const int chargedSign, const Const::ChargedStable &chargedStable) |
Generate the PDG code with correct sign, using the charge. | |
ClassDefOverride (Particle, 17) | |
Class to store reconstructed particles. | |
ClassDef (RelationsInterface, 0) | |
defines interface for accessing relations of objects in StoreArray. | |
Private Attributes | |
int | m_pdgCode |
PDG code. | |
int | m_pdgCodeUsedForFit = 0 |
PDG code used for the track fit. | |
double | m_mass |
particle (invariant) mass | |
double | m_px |
momentum component x | |
double | m_py |
momentum component y | |
double | m_pz |
momentum component z | |
double | m_momentumScale = 1.0 |
effective momentum scale factor | |
double | m_momentumScalingFactor = 1.0 |
momentum scaling factor | |
double | m_momentumSmearingFactor = 1.0 |
momentum smearing factor | |
double | m_energyLossCorrection = 0.0 |
energy loss correction. | |
double | m_x |
position component x | |
double | m_y |
position component y | |
double | m_z |
position component z | |
double | m_errMatrix [c_SizeMatrix] = {} |
error matrix (1D representation) | |
double | m_jacobiMatrix [c_SizeMatrix] = {} |
error matrix (1D representation) | |
double | m_pValue |
chi^2 probability of the fit. | |
std::vector< int > | m_daughterIndices |
daughter particle indices | |
EFlavorType | m_flavorType |
flavor type. | |
EParticleSourceObject | m_particleSource |
(mdst) source of particle | |
unsigned | m_mdstIndex |
0-based index of MDST store array object | |
int | m_properties |
particle property | |
std::vector< int > | m_daughterProperties |
daughter particle properties | |
int | m_identifier = -1 |
Identifier that can be used to identify whether the particle is unique or is a copy or representation of another. | |
std::vector< double > | m_extraInfo |
Stores associated user defined values. | |
TClonesArray * | m_arrayPointer |
Internal pointer to DataStore array containing the daughters of this particle. | |
DataStore::StoreEntry * | m_cacheDataStoreEntry |
Cache of the data store entry to which this object belongs. | |
int | m_cacheArrayIndex |
Cache of the index in the TClonesArray to which this object belongs. | |
Friends | |
class | ParticleSubset |
Class to store reconstructed particles.
This class is a common representation of all particle types, e.g.:
Private members are limited to those which completely define the particle and that are common to all particle types. These are:
Additional private members are needed in order to make composite particles (via combinations):
Finally, it is possible to store user-defined floating-point values using addExtraInfo() and getExtraInfo(), identified by a string key. These are general purpose functions for collecting additional information about reconstructed particles that can not be included into any existing data object. Different Particle objects can store different sets of values, and there are no hard-coded limitations on the number of values stored.
Definition at line 75 of file Particle.h.
anonymous enum |
error matrix dimensions and size of 1D representation
Definition at line 102 of file Particle.h.
anonymous enum |
enumerator used for error matrix handling, shows also in which order the rows (columns) are defined
Definition at line 110 of file Particle.h.
enum EFlavorType |
describes flavor type, see getFlavorType().
Enumerator | |
---|---|
c_Unflavored | Is its own antiparticle or we don't know whether it is a particle/antiparticle. |
c_Flavored | Is either particle or antiparticle. |
Definition at line 94 of file Particle.h.
particle source enumerators
Definition at line 82 of file Particle.h.
enum PropertyFlags |
Flags that describe the particle property, which are used in the MC matching.
Definition at line 116 of file Particle.h.
Particle | ( | ) |
Default constructor.
All private members are set to 0. Particle type is set to c_Undefined.
Definition at line 45 of file Particle.cc.
Particle | ( | const ROOT::Math::PxPyPzEVector & | momentum, |
const int | pdgCode | ||
) |
Constructor from a Lorentz vector and PDG code.
All other private members are set to their default values (0).
momentum | Lorentz vector |
pdgCode | PDG code |
Definition at line 54 of file Particle.cc.
Particle | ( | const ROOT::Math::PxPyPzEVector & | momentum, |
const int | pdgCode, | ||
EFlavorType | flavorType, | ||
const EParticleSourceObject | particleType, | ||
const unsigned | mdstIndex | ||
) |
Constructor for final state particles.
All other private members are set to their default values (0).
momentum | Lorentz vector |
pdgCode | PDG code |
flavorType | flavor type |
particleType | particle source |
mdstIndex | mdst index |
Definition at line 68 of file Particle.cc.
Particle | ( | const ROOT::Math::PxPyPzEVector & | momentum, |
const int | pdgCode, | ||
EFlavorType | flavorType, | ||
const std::vector< int > & | daughterIndices, | ||
TClonesArray * | arrayPointer = nullptr |
||
) |
Constructor for composite particles.
All other private members are set to their default values (0).
momentum | Lorentz vector |
pdgCode | PDG code |
flavorType | decay flavor type |
daughterIndices | indices of daughters in StoreArray<Particle> |
arrayPointer | pointer to store array which stores the daughters, if the particle itself is stored in the same array the pointer can be automatically determined |
Definition at line 89 of file Particle.cc.
Particle | ( | const ROOT::Math::PxPyPzEVector & | momentum, |
const int | pdgCode, | ||
EFlavorType | flavorType, | ||
const std::vector< int > & | daughterIndices, | ||
int | properties, | ||
TClonesArray * | arrayPointer = nullptr |
||
) |
Constructor for composite particles.
All other private members are set to their default values (0).
momentum | Lorentz vector |
pdgCode | PDG code |
flavorType | decay flavor type |
daughterIndices | indices of daughters in StoreArray<Particle> |
properties | particle property |
arrayPointer | pointer to store array which stores the daughters, if the particle itself is stored in the same array the pointer can be automatically determined |
Definition at line 122 of file Particle.cc.
Particle | ( | const ROOT::Math::PxPyPzEVector & | momentum, |
const int | pdgCode, | ||
EFlavorType | flavorType, | ||
const std::vector< int > & | daughterIndices, | ||
int | properties, | ||
const std::vector< int > & | daughterProperties, | ||
TClonesArray * | arrayPointer = nullptr |
||
) |
Constructor for composite particles.
All other private members are set to their default values (0).
momentum | Lorentz vector |
pdgCode | PDG code |
flavorType | decay flavor type |
daughterIndices | indices of daughters in StoreArray<Particle> |
properties | particle property |
daughterProperties | daughter particle properties |
arrayPointer | pointer to store array which stores the daughters, if the particle itself is stored in the same array the pointer can be automatically determined |
Definition at line 158 of file Particle.cc.
Particle | ( | const Track * | track, |
const Const::ChargedStable & | chargedStable | ||
) |
Constructor from a reconstructed track (mdst object Track);.
track | pointer to Track object |
chargedStable | Type of charged particle |
Definition at line 193 of file Particle.cc.
Particle | ( | int | trackArrayIndex, |
const TrackFitResult * | trackFit, | ||
const Const::ChargedStable & | chargedStable | ||
) |
Constructor from a reconstructed Track given as TrackFitResult.
To be used to create Particle objects from tracks with full control over the hypothesis (e.g. V0 daughters).
trackArrayIndex | track StoreArray index |
trackFit | pointer to TrackFitResult object |
chargedStable | Type of charged particle |
Definition at line 200 of file Particle.cc.
|
explicit |
Constructor of a photon from a reconstructed ECL cluster that is not matched to any charged track.
eclCluster | pointer to ECLCluster object |
type | the kind of ParticleType we want (photon by default) |
Definition at line 225 of file Particle.cc.
|
explicit |
Constructor from a reconstructed KLM cluster.
klmCluster | pointer to KLMCluster object |
pdgCode | PDG code (Klong by default) |
Definition at line 295 of file Particle.cc.
|
explicit |
Constructor from MC particle (mdst object MCParticle)
MCparticle | pointer to MCParticle object |
Definition at line 321 of file Particle.cc.
void addExtraInfo | ( | const std::string & | name, |
double | value | ||
) |
Sets the user-defined data of given name to the given value.
throws std::runtime_error if variable is already set.
Definition at line 1336 of file Particle.cc.
|
inlineinherited |
Add a relation from this object to another object (with caching).
object | The object to which the relation should point. |
weight | The weight of the relation. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 142 of file RelationsObject.h.
|
inlineinherited |
Add a relation from this object to another object (no caching, can be quite slow).
object | The object to which the relation should point. |
weight | The weight of the relation. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 155 of file RelationsObject.h.
void appendDaughter | ( | const Particle * | daughter, |
const bool | updateType = true , |
||
const int | daughterProperty = c_Ordinary |
||
) |
Appends index of daughter to daughters index array.
daughter | pointer to the daughter particle |
updateType | bool to set whether particle type should be updated |
daughterProperty | property of the daughter particle |
Definition at line 676 of file Particle.cc.
|
inline |
Appends index of daughter to daughters index array.
particleIndex | index of daughter in StoreArray<Particle> |
updateType | bool to set whether particle type should be updated |
Definition at line 416 of file Particle.h.
|
inlineinherited |
Copies all relations of sourceObj (pointing from or to sourceObj) to this object (including weights).
Useful if you want to make a complete copy of a StoreArray object to make modifications to it, but retain all information on linked objects.
Note: this only works if sourceObj inherits from the same base (e.g. RelationsObject), and only for related objects that also inherit from the same base.
Definition at line 170 of file RelationsObject.h.
void fillAllDaughters | ( | std::vector< const Belle2::Particle * > & | allDaughters | ) | const |
Fill all generations' daughters into a vector.
Function is called recursively
allDaughters | vector of daughter particles |
Definition at line 1127 of file Particle.cc.
|
private |
Fill vector with (PDGCode, MdstSource) pairs for the entire decay chain.
Used to determine if two Particles are copies or not.
Function is called recursively
decayChain | vector of (PDGCode, MdstSource) pairs for each particle in the decay chain of this particle |
Definition at line 1140 of file Particle.cc.
void fillFSPDaughters | ( | std::vector< const Belle2::Particle * > & | fspDaughters | ) | const |
Fill final state particle daughters into a vector.
Function is called recursively
fspDaughters | vector of daughter particles |
Definition at line 1114 of file Particle.cc.
bool forEachDaughter | ( | const std::function< bool(const Particle *)> & | function, |
bool | recursive = true , |
||
bool | includeSelf = true |
||
) | const |
Apply a function to all daughters of this particle.
function | function object to run on each daughter. If this function returns true the processing will be stopped immediately. |
recursive | if true go through all daughters of daughters as well |
includeSelf | if true also apply the function to this particle |
Definition at line 1358 of file Particle.cc.
|
private |
Generate the PDG code with correct sign, using the charge.
chargedSign | charge of the particle |
chargedStable | Type of charged particle |
Definition at line 1382 of file Particle.cc.
|
inline |
Returns Lorentz vector.
Definition at line 547 of file Particle.h.
double getAcoplanarity | ( | ) | const |
Returns acoplanarity angle defined as the angle between the decay planes of the grand daughters in the particle's rest frame This assumes that the particle and its daughters have two daughters each.
Definition at line 533 of file Particle.cc.
std::vector< const Belle2::Particle * > getAllDaughters | ( | ) | const |
Returns a vector of pointers to all generations' daughter particles.
Definition at line 657 of file Particle.cc.
|
inlineinherited |
Returns this object's array index (in StoreArray), or -1 if not found.
Definition at line 385 of file RelationsObject.h.
|
inlineinherited |
Get name of array this object is stored in, or "" if not found.
Definition at line 377 of file RelationsObject.h.
|
inline |
Returns the pointer to the store array which holds the daughter particles.
Definition at line 953 of file Particle.h.
double getCharge | ( | void | ) | const |
Returns particle charge.
Definition at line 622 of file Particle.cc.
double getCosHelicity | ( | const Particle * | mother = nullptr | ) | const |
Returns cosine of the helicity angle The helicity angle is defined in the rest frame of the particle as the angle between the negative momentum of the mother and.
mother | mother particle, if not given the center of mass system is taken as mother frame |
Definition at line 459 of file Particle.cc.
double getCosHelicityDaughter | ( | unsigned | iDaughter, |
unsigned | iGrandDaughter = 0 |
||
) | const |
Returns cosine of the helicity angle of the given daughter defined by given grand daughter.
iDaughter | 0-based index of daughter particle |
iGrandDaughter | 0-based index of grand daughter particle |
Definition at line 502 of file Particle.cc.
const Particle * getDaughter | ( | unsigned | i | ) | const |
Returns a pointer to the i-th daughter particle.
i | 0-based index of daughter particle |
Definition at line 631 of file Particle.cc.
|
inline |
Returns a vector of store array indices of daughter particles.
Definition at line 736 of file Particle.h.
|
inline |
Returns a vector of properties of daughter particles.
Definition at line 745 of file Particle.h.
std::vector< Belle2::Particle * > getDaughters | ( | ) | const |
Returns a vector of pointers to daughter particles.
Definition at line 637 of file Particle.cc.
const ECLCluster * getECLCluster | ( | ) | const |
Returns the pointer to the ECLCluster object that was used to create this Particle (if ParticleType == c_ECLCluster).
Returns the pointer to the most energetic ECLCluster matched to the track (if ParticleType == c_Track). NULL pointer is returned, if the Particle has no relation to an ECLCluster (either the particle is a different type or there was no track match).
Definition at line 891 of file Particle.cc.
|
inline |
Returns the ECLCluster EHypothesisBit for this Particle.
Definition at line 1001 of file Particle.h.
double getECLClusterEnergy | ( | ) | const |
Returns the energy of the ECLCluster for the particle.
The return value depends on the ECLCluster hypothesis.
Definition at line 919 of file Particle.cc.
|
inline |
Returns effective momentum scale which is the product of the momentum scaling and smearing factors.
Definition at line 614 of file Particle.h.
|
inline |
Returns total energy.
Definition at line 535 of file Particle.h.
|
inline |
Returns Energy Loss Correction.
Definition at line 623 of file Particle.h.
double getExtraInfo | ( | const std::string & | name | ) | const |
Return given value if set.
throws std::runtime_error if variable is not set.
Definition at line 1289 of file Particle.cc.
|
inline |
Return the id of the associated ParticleExtraInfoMap or -1 if no map is set.
Definition at line 921 of file Particle.h.
std::vector< std::string > getExtraInfoNames | ( | ) | const |
get a list of the extra info names
Definition at line 1175 of file Particle.cc.
|
inline |
Return the size of the extra info array.
Definition at line 927 of file Particle.h.
std::vector< const Belle2::Particle * > getFinalStateDaughters | ( | ) | const |
Returns a vector of pointers to Final State daughter particles.
Definition at line 649 of file Particle.cc.
|
inline |
Returns flavor type of the decay (for FS particles: flavor type of particle)
Definition at line 469 of file Particle.h.
|
inlineinherited |
Return a short summary of this object's contents in raw text format.
Returns the contents of getInfoHTML() while translating line-breaks etc.
Definition at line 370 of file RelationsObject.h.
|
overridevirtual |
Return a short summary of this object's contents in HTML format.
Reimplemented from RelationsInterface< BASE >.
Definition at line 1188 of file Particle.cc.
const KLMCluster * getKLMCluster | ( | ) | const |
Returns the pointer to the KLMCluster object that was used to create this Particle (ParticleType == c_KLMCluster).
Returns the pointer to the KLMCluster object associated to this Particle if ParticleType == c_Track. NULL pointer is returned, if the Particle has no relation to the KLMCluster.
Definition at line 926 of file Particle.cc.
|
inline |
Returns invariant mass (= nominal for FS particles)
Definition at line 507 of file Particle.h.
const MCParticle * getMCParticle | ( | ) | const |
Returns the pointer to the MCParticle object that was used to create this Particle (ParticleType == c_MCParticle).
Returns the best MC match for this particle (if ParticleType == c_Track or c_ECLCluster or c_KLMCluster) NULL pointer is returned, if the Particle was not made from MCParticle or not matched.
Definition at line 942 of file Particle.cc.
|
inline |
Returns 0-based index of MDST store array object (0 for composite particles)
Definition at line 487 of file Particle.h.
std::vector< int > getMdstArrayIndices | ( | EParticleSourceObject | type | ) | const |
Returns a vector of StoreArray indices of given MDST dataobjects.
type | EParticleSourceObject corresponding to a given MDST dataobject |
Definition at line 665 of file Particle.cc.
int getMdstSource | ( | ) | const |
Returns unique identifier of final state particle (needed in particle combiner)
Definition at line 369 of file Particle.cc.
|
inline |
Returns momentum vector.
Definition at line 560 of file Particle.h.
TMatrixFSym getMomentumErrorMatrix | ( | ) | const |
Returns the 4x4 momentum error matrix.
Definition at line 435 of file Particle.cc.
|
inline |
Returns effect of energy correction on the particle momentum.
Definition at line 315 of file Particle.h.
|
inline |
TMatrixFSym getMomentumVertexErrorMatrix | ( | ) | const |
Returns 7x7 error matrix.
Definition at line 420 of file Particle.cc.
std::pair< Const::ChargedStable, const TrackFitResult * > getMostLikelyTrackFitResult | ( | ) | const |
For a (track-based) particle, returns the charged stable mass hypothesis associated to the most probable TrackFitResult, and the TrackFitResult itself.
Definition at line 1398 of file Particle.cc.
|
overridevirtual |
Return name of this particle.
Reimplemented from RelationsInterface< BASE >.
Definition at line 1165 of file Particle.cc.
|
inline |
Returns number of daughter particles.
Definition at line 727 of file Particle.h.
|
inline |
Returns momentum magnitude (same as getMomentumMagnitude but with shorter name)
Definition at line 578 of file Particle.h.
const Particle * getParticleFromGeneralizedIndexString | ( | const std::string & | generalizedIndex | ) | const |
Explores the decay tree of the particle and returns the (grand^n)daughter identified by a generalized index.
The generalized index consists of a colon-separated list of daughter indexes, starting from the root particle: 0:1:3 identifies the fourth daughter (3) of the second daughter (1) of the first daughter (0) of the mother particle.
generalizedIndex | the generalized index of the particle to be returned |
Definition at line 956 of file Particle.cc.
|
inline |
Returns particle source as defined with enum EParticleSourceObject.
Definition at line 478 of file Particle.h.
|
inline |
|
inline |
Return the always positive PDG code which was used for the track fit (if there was a track fit) of this particle.
This can be different than the Particle's PDG id as not all mass hypothesis are fitted during the reconstruction.
Definition at line 965 of file Particle.h.
double getPDGLifetime | ( | ) | const |
Returns particle nominal lifetime.
Definition at line 613 of file Particle.cc.
double getPDGMass | ( | void | ) | const |
Returns uncertainty on the invariant mass (requires valid momentum error matrix)
Definition at line 604 of file Particle.cc.
const PIDLikelihood * getPIDLikelihood | ( | ) | const |
Returns the pointer to the PIDLikelihood object that is related to the Track, which was used to create this Particle (ParticleType == c_Track).
NULL pointer is returned, if the Particle was not made from Track or if the Track has no relation to the PIDLikelihood
Definition at line 871 of file Particle.cc.
|
inline |
Returns particle property as a bit pattern The values are defined in the PropertyFlags enum and described in detail there.
Definition at line 498 of file Particle.h.
|
inline |
Returns chi^2 probability of fit if done or -1.
Definition at line 667 of file Particle.h.
|
inline |
Returns x component of momentum.
Definition at line 587 of file Particle.h.
|
inline |
Returns y component of momentum.
Definition at line 596 of file Particle.h.
|
inline |
Returns z component of momentum.
Definition at line 605 of file Particle.h.
|
inlineinherited |
Get the object to or from which this object has a relation.
T | The class of objects to or from which the relation points. |
name | The name of the store array to or from which the relation points. If empty the default store array name for class T will be used. If the special name "ALL" is given all store arrays containing objects of type T are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 278 of file RelationsObject.h.
|
inlineinherited |
Get the object from which this object has a relation.
FROM | The class of objects from which the relation points. |
name | The name of the store array from which the relation points. If empty the default store array name for class FROM will be used. If the special name "ALL" is given all store arrays containing objects of type FROM are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 263 of file RelationsObject.h.
|
inlineinherited |
Get first related object & weight of relation pointing from an array.
FROM | The class of objects from which the relation points. |
name | The name of the store array from which the relation points. If empty the default store array name for class FROM will be used. If the special name "ALL" is given all store arrays containing objects of type FROM are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 314 of file RelationsObject.h.
|
inlineinherited |
Get the object to which this object has a relation.
TO | The class of objects to which the relation points. |
name | The name of the store array to which the relation points. If empty the default store array name for class TO will be used. If the special name "ALL" is given all store arrays containing objects of type TO are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 248 of file RelationsObject.h.
|
inlineinherited |
Get first related object & weight of relation pointing to an array.
TO | The class of objects to which the relation points. |
name | The name of the store array to which the relation points. If empty the default store array name for class TO will be used. If the special name "ALL" is given all store arrays containing objects of type TO are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 297 of file RelationsObject.h.
|
inlineinherited |
Get first related object & weight of relation pointing from/to an array.
T | The class of objects to or from which the relation points. |
name | The name of the store array to or from which the relation points. If empty the default store array name for class T will be used. If the special name "ALL" is given all store arrays containing objects of type T are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 331 of file RelationsObject.h.
|
inlineinherited |
Get the relations that point from another store array to this object.
FROM | The class of objects from which the relations point. |
name | The name of the store array from which the relations point. If empty the default store array name for class FROM will be used. If the special name "ALL" is given all store arrays containing objects of type FROM are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 212 of file RelationsObject.h.
|
inlineinherited |
Get the relations that point from this object to another store array.
TO | The class of objects to which the relations point. |
name | The name of the store array to which the relations point. If empty the default store array name for class TO will be used. If the special name "ALL" is given all store arrays containing objects of type TO are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 197 of file RelationsObject.h.
|
inlineinherited |
Get the relations between this object and another store array.
Relations in both directions are returned.
T | The class of objects to or from which the relations point. |
name | The name of the store array to or from which the relations point. If empty the default store array name for class T will be used. If the special name "ALL" is given all store arrays containing objects of type T are considered. |
namedRelation | Additional name for the relation, or "" for the default naming |
Definition at line 230 of file RelationsObject.h.
const Track * getTrack | ( | ) | const |
Returns the pointer to the Track object that was used to create this Particle (ParticleType == c_Track).
NULL pointer is returned, if the Particle was not made from Track.
Definition at line 845 of file Particle.cc.
const TrackFitResult * getTrackFitResult | ( | ) | const |
Returns the pointer to the TrackFitResult that was used to create this Particle (ParticleType == c_Track).
NULL pointer is returned, if the Particle was not made from Track.
Definition at line 854 of file Particle.cc.
const V0 * getV0 | ( | ) | const |
Returns the pointer to the V0 object that was used to create this Particle (if ParticleType == c_V0).
NULL pointer is returned if the Particle was not made from a V0.
Definition at line 880 of file Particle.cc.
|
inline |
Returns vertex position (POCA for charged, IP for neutral FS particles)
Definition at line 631 of file Particle.h.
TMatrixFSym getVertexErrorMatrix | ( | ) | const |
Returns the 3x3 position error sub-matrix.
Definition at line 447 of file Particle.cc.
|
inline |
Returns x component of vertex position.
Definition at line 640 of file Particle.h.
|
inline |
Returns y component of vertex position.
Definition at line 649 of file Particle.h.
|
inline |
Returns z component of vertex position.
Definition at line 658 of file Particle.h.
bool hasExtraInfo | ( | const std::string & | name | ) | const |
Return whether the extra info with the given name is set.
Definition at line 1266 of file Particle.cc.
bool isCopyOf | ( | const Particle * | oParticle, |
bool | doDetailedComparison = false |
||
) | const |
Returns true if this Particle and oParticle are copies of each other.
Copies are defined as: o) The decay chain of both Particles is exactly the same o) Both Particles are constructed from exactly the same final state particles
M1 and M2 are not copies since condition 2 is not fulfilled. M1 and M3 are not copies since condition 1 is not fulfilled. M1 and M4 are copies since both conditions are fulfilled.
oParticle | pointer to other particle |
doDetailedComparison | if true, this means that particles of different PDG codes, but created from the same track or cluster will be indicated as copies. Returns B2FATAL in case of comparison of c_MCParticle type to a non c_MCParticle. |
Definition at line 752 of file Particle.cc.
bool isMostLikely | ( | ) | const |
Returns true if the (track-based) particle is created with its most likely mass hypothesis based on PID likelihood.
Definition at line 1391 of file Particle.cc.
bool isMostLikelyTrackFitResult | ( | ) | const |
Returns true if the (track-based) particle is created with its most likely mass hypothesis based on TrackFitResult.
Definition at line 1416 of file Particle.cc.
bool overlapsWith | ( | const Particle * | oParticle | ) | const |
Returns true if final state ancestors of oParticle overlap.
oParticle | pointer to particle |
Definition at line 737 of file Particle.cc.
void print | ( | ) | const |
Prints the contents of a Particle object to standard output.
Definition at line 1170 of file Particle.cc.
void removeDaughter | ( | const Particle * | daughter, |
const bool | updateType = true |
||
) |
Removes index of daughter from daughters index array.
daughter | pointer to the daughter particle |
updateType | bool whether particle type should be updated if last daughter was removed |
Definition at line 688 of file Particle.cc.
void removeExtraInfo | ( | ) |
Remove all stored extra info fields.
Definition at line 1284 of file Particle.cc.
Replace index of given daughter with new daughter, return true if a replacement is made.
oldDaughter | pointer to the daughter that will be removed |
newDaughter | pointer to the particle that will be added as a daughter |
Definition at line 705 of file Particle.cc.
Apply replaceDaughter to all Particles in the decay tree by looping recursively through it, return true if a replacement is made.
oldDaughter | pointer to the daughter that will be removed |
newDaughter | pointer to the particle that will be added as a daughter |
Definition at line 723 of file Particle.cc.
|
private |
Resets 7x7 error matrix All elements are set to 0.0.
Definition at line 1079 of file Particle.cc.
|
private |
Resets 4x6 error matrix All elements are set to 0.0.
Definition at line 1085 of file Particle.cc.
|
inline |
|
inline |
Sets Lorentz vector dividing by the momentum scaling factor.
p4 | Lorentz vector |
Definition at line 283 of file Particle.h.
|
inline |
Sets Energy loss correction.
energyLossCorrection | Correction factor |
Definition at line 306 of file Particle.h.
void setExtraInfo | ( | const std::string & | name, |
double | value | ||
) |
Sets the user-defined data of given name to the given value.
throws std::runtime_error if variable isn't set.
Definition at line 1317 of file Particle.cc.
|
private |
sets m_flavorType using m_pdgCode
Definition at line 1150 of file Particle.cc.
void setJacobiMatrix | ( | const TMatrixF & | jacobiMatrix | ) |
Sets 4x6 jacobi matrix.
jacobiMatrix | 4x6 momentum and vertex error matrix (order: px,py,pz,E,x,y,z) |
Definition at line 407 of file Particle.cc.
|
private |
set mdst array index
Definition at line 350 of file Particle.cc.
|
private |
Sets the momentum, position and error matrix for this particle (created from charged Track)
Definition at line 1001 of file Particle.cc.
|
inline |
Sets momentum scaling.
momentumScalingFactor | scaling factor |
Definition at line 334 of file Particle.h.
|
inline |
Sets momentum smearing.
momentumSmearingFactor | scaling factor |
Definition at line 344 of file Particle.h.
void setMomentumVertexErrorMatrix | ( | const TMatrixFSym & | errMatrix | ) |
Sets 7x7 error matrix.
errMatrix | 7x7 momentum and vertex error matrix (order: px,py,pz,E,x,y,z) |
Definition at line 393 of file Particle.cc.
|
inline |
|
inline |
sets m_properties
Definition at line 374 of file Particle.h.
|
inline |
Sets chi^2 probability of fit.
pValue | p-value of fit |
Definition at line 366 of file Particle.h.
|
inline |
|
private |
Stores 7x7 error matrix into private member m_errMatrix.
errMatrix | 7x7 error matrix |
Definition at line 1091 of file Particle.cc.
|
private |
Stores 4x6 Jacobi matrix into private member m_jacobiMatrix.
jacobiMatrix | 4x6 error matrix |
Definition at line 1102 of file Particle.cc.
void updateJacobiMatrix | ( | ) |
Propagate the photon energy scaling to jacobian elements that were calculated using energy.
Definition at line 257 of file Particle.cc.
void updateMass | ( | const int | pdgCode | ) |
Updates particle mass with the mass of the particle corresponding to the given PDG.
pdgCode | PDG code of the particle with the desired mass |
Definition at line 597 of file Particle.cc.
|
inline |
Sets Lorentz vector, position, 7x7 error matrix and p-value.
p4 | Lorentz vector |
vertex | point (position or vertex) |
errMatrix | 7x7 momentum and vertex error matrix (order: px,py,pz,E,x,y,z) |
pValue | chi^2 probability of the fit |
Definition at line 386 of file Particle.h.
|
inline |
Returns true if the type represented by this Particle object was used use as a mass hypothesis during the track of this Particle's parameters.
Definition at line 975 of file Particle.h.
void writeExtraInfo | ( | const std::string & | name, |
const double | value | ||
) |
Sets the user defined extraInfo.
Adds it if necessary, overwrites existing ones if they share the same name.
Definition at line 1308 of file Particle.cc.
|
friend |
Definition at line 1170 of file Particle.h.
|
mutableprivate |
Internal pointer to DataStore array containing the daughters of this particle.
This is a transient member and will not be written to file. The pointer is set by getArrayPointer() when first called.
Definition at line 1100 of file Particle.h.
|
mutableprivateinherited |
Cache of the index in the TClonesArray to which this object belongs.
Definition at line 432 of file RelationsObject.h.
|
mutableprivateinherited |
Cache of the data store entry to which this object belongs.
Definition at line 429 of file RelationsObject.h.
|
private |
daughter particle indices
Definition at line 1070 of file Particle.h.
|
private |
daughter particle properties
Definition at line 1075 of file Particle.h.
|
private |
energy loss correction.
defined as 'm_energyLossCorrection = E_measured - E_true'
Definition at line 1063 of file Particle.h.
|
private |
error matrix (1D representation)
Definition at line 1067 of file Particle.h.
|
private |
Stores associated user defined values.
Order is given by string -> index mapping in ParticleExtraInfoMap. entry 0 is reserved specifies which map to use.
Definition at line 1091 of file Particle.h.
|
private |
flavor type.
Definition at line 1071 of file Particle.h.
|
private |
Identifier that can be used to identify whether the particle is unique or is a copy or representation of another.
For example a kaon and pion particles constructed from the same Track are representations of the same physical object in the detector and cannot be used in the reconstruction of the same decay chain
Definition at line 1084 of file Particle.h.
|
private |
error matrix (1D representation)
Definition at line 1068 of file Particle.h.
|
private |
particle (invariant) mass
Definition at line 1056 of file Particle.h.
|
private |
0-based index of MDST store array object
Definition at line 1073 of file Particle.h.
|
private |
effective momentum scale factor
Definition at line 1060 of file Particle.h.
|
private |
momentum scaling factor
Definition at line 1061 of file Particle.h.
|
private |
momentum smearing factor
Definition at line 1062 of file Particle.h.
|
private |
(mdst) source of particle
Definition at line 1072 of file Particle.h.
|
private |
PDG code.
Definition at line 1054 of file Particle.h.
|
private |
PDG code used for the track fit.
Definition at line 1055 of file Particle.h.
|
private |
particle property
Definition at line 1074 of file Particle.h.
|
private |
|
private |
momentum component x
Definition at line 1057 of file Particle.h.
|
private |
momentum component y
Definition at line 1058 of file Particle.h.
|
private |
momentum component z
Definition at line 1059 of file Particle.h.
|
private |
position component x
Definition at line 1064 of file Particle.h.
|
private |
position component y
Definition at line 1065 of file Particle.h.
|
private |
position component z
Definition at line 1066 of file Particle.h.