#include <BaseParticlePropagator.h>
Public Member Functions | |
bool | backPropagate () |
BaseParticlePropagator () | |
Default c'tor. More... | |
BaseParticlePropagator (const RawParticle &myPart, double r, double z, double B) | |
BaseParticlePropagator (const RawParticle &myPart, double r, double z, double B, double t) | |
double | getMagneticField () const |
Get the magnetic field. More... | |
int | getSuccess () const |
Has propagation been performed and was barrel or endcap reached ? More... | |
bool | hasDecayed () const |
Has the particle decayed while propagated ? More... | |
double | helixCentreDistToAxis () const |
The distance between the cylinder and the helix axes. More... | |
double | helixCentreDistToAxis (double xC, double yC) const |
double | helixCentrePhi () const |
The azimuth if the vector joining the cylinder and the helix axes. More... | |
double | helixCentrePhi (double xC, double yC) const |
double | helixCentreX () const |
The x coordinate of the helix axis. More... | |
double | helixCentreX (double radius, double phi) const |
double | helixCentreY () const |
The y coordinate of the helix axis. More... | |
double | helixCentreY (double radius, double phi) const |
double | helixRadius () const |
The helix Radius. More... | |
double | helixRadius (double pT) const |
double | helixStartPhi () const |
The azimuth of the momentum at the vertex. More... | |
void | increaseRCyl (double delta) |
Just an internal trick. More... | |
void | init () |
Initialize internal switches and quantities. More... | |
bool | inside () const |
Is the vertex inside the cylinder ? (stricly inside : true) More... | |
bool | inside (double rPos2) const |
bool | onBarrel () const |
Is the vertex already on the cylinder barrel ? More... | |
bool | onBarrel (double rPos2) const |
bool | onEndcap () const |
Is the vertex already on the cylinder endcap ? More... | |
bool | onEndcap (double rPos2) const |
bool | onFiducial () const |
Is the vertex on some material ? More... | |
bool | onSurface () const |
Is the vertex already on the cylinder surface ? More... | |
bool | onSurface (double rPos2) const |
bool | propagate () |
BaseParticlePropagator | propagated () const |
bool | propagateToBeamCylinder (const XYZTLorentzVector &v, double radius=0.) |
bool | propagateToClosestApproach (double x0=0., double y0=0, bool first=true) |
bool | propagateToEcal (bool first=true) |
bool | propagateToEcalEntrance (bool first=true) |
bool | propagateToHcalEntrance (bool first=true) |
bool | propagateToHcalExit (bool first=true) |
bool | propagateToHOLayer (bool first=true) |
bool | propagateToNominalVertex (const XYZTLorentzVector &hit2=XYZTLorentzVector(0., 0., 0., 0.)) |
bool | propagateToPreshowerLayer1 (bool first=true) |
bool | propagateToPreshowerLayer2 (bool first=true) |
bool | propagateToVFcalEntrance (bool first=true) |
void | resetDebug () |
void | setDebug () |
Set the debug leve;. More... | |
void | setMagneticField (double b) |
Set the magnetic field. More... | |
void | setPropagationConditions (double r, double z, bool firstLoop=true) |
Set the propagation characteristics (rCyl, zCyl and first loop only) More... | |
void | setProperDecayTime (double t) |
Set the proper decay time. More... | |
double | xyImpactParameter (double x0=0., double y0=0.) const |
Transverse impact parameter. More... | |
double | zImpactParameter (double x0=0, double y0=0.) const |
Longitudinal impact parameter. More... | |
Public Member Functions inherited from RawParticle | |
void | boost (double bx, double by, double bz) |
void | boost (const Boost &b) |
double | charge () const |
get the MEASURED charge More... | |
void | chargeConjugate () |
double | cos2Theta () const |
Cos**2(theta) is faster to determine than eta. More... | |
double | cos2ThetaV () const |
double | et () const |
get the transverse energy More... | |
double | eta () const |
int | isUsed () const |
double | mass () const |
get the MEASURED mass More... | |
const XYZTLorentzVector & | momentum () const |
the momentum fourvector More... | |
RawParticle & | operator= (const RawParticle &rhs) |
double | PDGcharge () const |
get the THEORETICAL charge More... | |
double | PDGcTau () const |
get the THEORETICAL lifetime More... | |
double | PDGmass () const |
get the THEORETICAL mass More... | |
std::string | PDGname () const |
get the PDG name More... | |
int | pid () const |
get the HEP particle ID number More... | |
void | print () const |
void | printName () const |
double | r () const |
vertex radius More... | |
double | R () const |
vertex radius More... | |
double | r2 () const |
vertex radius**2 More... | |
double | R2 () const |
vertex radius**2 More... | |
RawParticle () | |
RawParticle (const XYZTLorentzVector &p) | |
RawParticle (const int id, const XYZTLorentzVector &p) | |
RawParticle (const std::string name, const XYZTLorentzVector &p) | |
RawParticle (const XYZTLorentzVector &p, const XYZTLorentzVector &xStart) | |
RawParticle (double px, double py, double pz, double e) | |
RawParticle (const RawParticle &p) | |
void | reUse () |
void | rotate (double rphi, const XYZVector &raxis) |
void | rotate (const Rotation &r) |
void | rotate (const Rotation3D &r) |
void | rotate (const RotationX &r) |
void | rotate (const RotationY &r) |
void | rotate (const RotationZ &r) |
void | rotateX (double rphi) |
void | rotateY (double rphi) |
void | rotateZ (double rphi) |
void | setCharge (float q) |
set the MEASURED charge More... | |
void | setID (const int id) |
void | setID (const std::string name) |
void | setMass (float m) |
set the RECONSTRUCTED mass More... | |
void | setStatus (int istat) |
void | setT (const double t) |
set the time of creation More... | |
void | setVertex (const XYZTLorentzVector &vtx) |
set the vertex More... | |
void | setVertex (double xv, double yv, double zv, double tv) |
int | status () const |
get the particle status More... | |
double | t () const |
vertex time More... | |
double | T () const |
vertex time More... | |
void | translate (const XYZVector &t) |
void | use () |
const XYZTLorentzVector & | vertex () const |
the vertex fourvector More... | |
double | x () const |
x of vertex More... | |
double | X () const |
x of vertex More... | |
double | y () const |
y of vertex More... | |
double | Y () const |
y of vertex More... | |
double | z () const |
z of vertex More... | |
double | Z () const |
z of vertex More... | |
virtual | ~RawParticle () |
Protected Member Functions | |
double | c_light () const |
The speed of light in mm/ns (!) without clhep (yeaaahhh!) More... | |
Protected Attributes | |
bool | fiducial |
The particle traverses some real material. More... | |
int | success |
0:propagation still be done, 1:reached 'barrel', 2:reached 'endcaps' More... | |
Protected Attributes inherited from RawParticle | |
double | myCharge |
the MEASURED charge More... | |
int | myId |
the particle id number HEP-PID More... | |
const ParticleData * | myInfo |
The pointer to the PDG info. More... | |
double | myMass |
the RECONSTRUCTED mass More... | |
int | myStatus |
the status code according to PYTHIA More... | |
int | myUsed |
status of the locking More... | |
XYZTLorentzVector | myVertex |
the four vector of the vertex More... | |
Private Attributes | |
double | bField |
Magnetic field in the cylinder, oriented along the Z axis. More... | |
bool | debug |
The debug level. More... | |
bool | decayed |
The particle decayed while propagated ! More... | |
bool | firstLoop |
Do only the first half-loop. More... | |
int | propDir |
The propagation direction. More... | |
double | properDecayTime |
The proper decay time of the particle. More... | |
double | properTime |
The proper time of the particle. More... | |
double | rCyl |
Simulated particle that is to be resp has been propagated. More... | |
double | rCyl2 |
double | zCyl |
Half-height of the cylinder (centred at 0,0,0) to which propagation is done. More... | |
Additional Inherited Members | |
Public Types inherited from RawParticle | |
typedef ROOT::Math::Boost | Boost |
typedef ROOT::Math::AxisAngle | Rotation |
typedef ROOT::Math::Rotation3D | Rotation3D |
typedef ROOT::Math::RotationX | RotationX |
typedef ROOT::Math::RotationY | RotationY |
typedef ROOT::Math::RotationZ | RotationZ |
This class is aimed at propagating charged and neutral particles (yet under the form of a RawParticle) from a given vertex to a cylinder, defined by a radius rCyl and a length 2*zCyl, centered in (0,0,0) and whose axis is parallel to the B field (B is oriented along z, by definition of the z axis).
The main method
bool propagate()
returns true if an intersection between the propagated RawParticle and the cylinder is found. The location of the intersection is given by the value of success:
The method
propagated()
returns a new RawParticle with the propagated coordinates, if overwriting is not considered an advantage by the user.
Particles can be propagated backward with the method
backPropagate()
Member functions
o propagateToPreshowerLayer1(), o propagateToPreshowerLayer2(), o propagateToEcalEntrance(), o propagateToHcalEntrance(), o propagateToHcalExit(), o propagateToClosestApproach(),
only need a momentum, a vertex and an electric charge to operate. Radii, half-lengths and default B field (4T) are set therein by default.
As of today, no average loss of energy (dE/dx, Brems) is considered in the propagation. No uncertainty (multiple scattering, dE/dx, Brems) is yet implemented.
Definition at line 82 of file BaseParticlePropagator.h.
BaseParticlePropagator::BaseParticlePropagator | ( | ) |
Default c'tor.
Definition at line 4 of file BaseParticlePropagator.cc.
Referenced by ParticlePropagator::ParticlePropagator().
BaseParticlePropagator::BaseParticlePropagator | ( | const RawParticle & | myPart, |
double | r, | ||
double | z, | ||
double | B | ||
) |
Constructors taking as arguments a RawParticle, as well as the radius, half-height and magnetic field defining the cylinder for which propagation is to be performed, and optionally, the proper decay time
Definition at line 15 of file BaseParticlePropagator.cc.
References init().
BaseParticlePropagator::BaseParticlePropagator | ( | const RawParticle & | myPart, |
double | r, | ||
double | z, | ||
double | B, | ||
double | t | ||
) |
Definition at line 8 of file BaseParticlePropagator.cc.
References init().
bool BaseParticlePropagator::backPropagate | ( | ) |
Update the current instance, after the back-propagation of the particle to the surface of the cylinder
Definition at line 320 of file BaseParticlePropagator.cc.
References RawParticle::charge(), propagate(), propDir, and RawParticle::setCharge().
Referenced by propagated(), and propagateToClosestApproach().
|
inlineprotected |
The speed of light in mm/ns (!) without clhep (yeaaahhh!)
Definition at line 153 of file BaseParticlePropagator.h.
Referenced by helixRadius(), and propagateToBeamCylinder().
|
inline |
Get the magnetic field.
Definition at line 303 of file BaseParticlePropagator.h.
References bField.
Referenced by TrajectoryManager::createPSimHits(), and ConvBremSeedProducer::produce().
|
inline |
Has propagation been performed and was barrel or endcap reached ?
Definition at line 297 of file BaseParticlePropagator.h.
References success.
Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), AntiElectronIDMVA6::atECalEntrance(), FBaseSimEvent::fill(), ConvBremSeedProducer::GoodCluster(), ConvBremSeedProducer::produce(), TrajectoryManager::propagateToCalorimeters(), and TrajectoryManager::propagateToLayer().
|
inline |
Has the particle decayed while propagated ?
Definition at line 294 of file BaseParticlePropagator.h.
References decayed.
Referenced by ParticlePropagator::propagateToBoundSurface(), and TrajectoryManager::propagateToCalorimeters().
|
inline |
The distance between the cylinder and the helix axes.
Definition at line 229 of file BaseParticlePropagator.h.
References helixCentreX(), helixCentreY(), and mathSSE::sqrt().
Referenced by propagate(), propagateToBeamCylinder(), propagateToClosestApproach(), and xyImpactParameter().
|
inline |
|
inline |
The azimuth if the vector joining the cylinder and the helix axes.
Definition at line 242 of file BaseParticlePropagator.h.
References helixCentreX(), and helixCentreY().
Referenced by propagate().
|
inline |
Definition at line 249 of file BaseParticlePropagator.h.
|
inline |
The x coordinate of the helix axis.
Definition at line 207 of file BaseParticlePropagator.h.
References helixRadius(), helixStartPhi(), funct::sin(), and RawParticle::X().
Referenced by helixCentreDistToAxis(), helixCentrePhi(), propagate(), propagateToBeamCylinder(), propagateToClosestApproach(), and xyImpactParameter().
|
inline |
Definition at line 212 of file BaseParticlePropagator.h.
References funct::sin(), and RawParticle::X().
|
inline |
The y coordinate of the helix axis.
Definition at line 218 of file BaseParticlePropagator.h.
References funct::cos(), helixRadius(), helixStartPhi(), and RawParticle::Y().
Referenced by helixCentreDistToAxis(), helixCentrePhi(), propagate(), propagateToBeamCylinder(), propagateToClosestApproach(), and xyImpactParameter().
|
inline |
Definition at line 223 of file BaseParticlePropagator.h.
References funct::cos(), and RawParticle::Y().
|
inline |
The helix Radius.
Definition at line 183 of file BaseParticlePropagator.h.
References c_light(), RawParticle::charge(), MillePedeFileConverter_cfg::e, and reco::tau::disc::Pt().
Referenced by helixCentreX(), helixCentreY(), propagate(), propagateToClosestApproach(), propagateToNominalVertex(), and xyImpactParameter().
|
inline |
Definition at line 195 of file BaseParticlePropagator.h.
References c_light(), RawParticle::charge(), and MillePedeFileConverter_cfg::e.
|
inline |
The azimuth of the momentum at the vertex.
Definition at line 201 of file BaseParticlePropagator.h.
Referenced by helixCentreX(), helixCentreY(), propagate(), propagateToClosestApproach(), and xyImpactParameter().
|
inline |
Just an internal trick.
Definition at line 171 of file BaseParticlePropagator.h.
References delta, rCyl, and xyImpactParameter().
void BaseParticlePropagator::init | ( | void | ) |
Initialize internal switches and quantities.
Definition at line 23 of file BaseParticlePropagator.cc.
References debug, decayed, fiducial, firstLoop, propDir, properTime, and success.
Referenced by BaseParticlePropagator().
|
inline |
Is the vertex inside the cylinder ? (stricly inside : true)
Definition at line 255 of file BaseParticlePropagator.h.
References RawParticle::R2(), and RawParticle::Z().
Referenced by propagate().
|
inline |
Definition at line 258 of file BaseParticlePropagator.h.
References RawParticle::Z().
|
inline |
Is the vertex already on the cylinder barrel ?
Definition at line 272 of file BaseParticlePropagator.h.
References RawParticle::R2(), and RawParticle::Z().
Referenced by onSurface(), and propagate().
|
inline |
Definition at line 277 of file BaseParticlePropagator.h.
References RawParticle::Z().
|
inline |
Is the vertex already on the cylinder endcap ?
Definition at line 282 of file BaseParticlePropagator.h.
References RawParticle::R2(), and RawParticle::Z().
Referenced by onSurface(), and propagate().
|
inline |
Definition at line 286 of file BaseParticlePropagator.h.
References RawParticle::Z().
|
inline |
Is the vertex on some material ?
Definition at line 291 of file BaseParticlePropagator.h.
References fiducial.
Referenced by TrajectoryManager::propagateToLayer().
|
inline |
Is the vertex already on the cylinder surface ?
Definition at line 263 of file BaseParticlePropagator.h.
References onBarrel(), and onEndcap().
Referenced by propagate().
|
inline |
Definition at line 267 of file BaseParticlePropagator.h.
References onBarrel(), and onEndcap().
bool BaseParticlePropagator::propagate | ( | ) |
Update the current instance, after the propagation of the particle to the surface of the cylinder
Definition at line 43 of file BaseParticlePropagator.cc.
References bField, RawParticle::charge(), funct::cos(), decayed, delta, hiPixelPairStep_cff::deltaPhi, firstLoop, helixCentreDistToAxis(), helixCentrePhi(), helixCentreX(), helixCentreY(), helixRadius(), helixStartPhi(), inside(), M_PI, RawParticle::mass(), min(), onBarrel(), onEndcap(), onSurface(), propDir, properDecayTime, properTime, PVValHelper::pT, reco::tau::disc::Pt(), RawParticle::R2(), TCMET_cfi::radius, rCyl, rCyl2, RawParticle::setVertex(), funct::sin(), mathSSE::sqrt(), success, RawParticle::T(), RawParticle::X(), RawParticle::Y(), RawParticle::Z(), and zCyl.
Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), backPropagate(), ConvBremSeedProducer::produce(), propagated(), ParticlePropagator::propagateToBoundSurface(), propagateToEcal(), propagateToEcalEntrance(), propagateToHcalEntrance(), propagateToHcalExit(), propagateToHOLayer(), propagateToPreshowerLayer1(), propagateToPreshowerLayer2(), and propagateToVFcalEntrance().
BaseParticlePropagator BaseParticlePropagator::propagated | ( | ) | const |
Return a new instance, corresponding to the particle propagated to the surface of the cylinder
Definition at line 335 of file BaseParticlePropagator.cc.
References backPropagate(), firstLoop, propagate(), and success.
Referenced by ParticlePropagator::propagated().
bool BaseParticlePropagator::propagateToBeamCylinder | ( | const XYZTLorentzVector & | v, |
double | radius = 0. |
||
) |
Definition at line 630 of file BaseParticlePropagator.cc.
References a, b, bField, EnergyCorrector::c, c_light(), RawParticle::charge(), funct::cos(), gather_cfg::cout, PVValHelper::dx, PVValHelper::dy, PVValHelper::dz, MillePedeFileConverter_cfg::e, helixCentreDistToAxis(), helixCentreX(), helixCentreY(), mps_fire::i, propagateToClosestApproach(), PVValHelper::pT, reco::tau::disc::Pt(), RawParticle::r(), RawParticle::r2(), TCMET_cfi::radius, RawParticle::setCharge(), funct::sin(), mathSSE::sqrt(), RawParticle::X(), RawParticle::Y(), and RawParticle::Z().
bool BaseParticlePropagator::propagateToClosestApproach | ( | double | x0 = 0. , |
double | y0 = 0 , |
||
bool | first = true |
||
) |
Update the particle after propagation to the closest approach from Z axis, to the preshower layer 1 & 2, to the ECAL entrance, to the HCAL entrance, the HCAL 2nd and 3rd layer (not coded yet), the VFCAL entrance, or any BoundSurface(disk or cylinder)
Definition at line 358 of file BaseParticlePropagator.cc.
References backPropagate(), bField, RawParticle::charge(), helixCentreDistToAxis(), helixCentreX(), helixCentreY(), helixRadius(), helixStartPhi(), RawParticle::momentum(), PVValHelper::pT, reco::tau::disc::Pt(), TCMET_cfi::radius, setPropagationConditions(), RawParticle::setVertex(), mathSSE::sqrt(), RawParticle::vertex(), RawParticle::X(), RawParticle::Y(), and RawParticle::z().
Referenced by propagateToBeamCylinder(), ParticlePropagator::propagateToClosestApproach(), and propagateToNominalVertex().
bool BaseParticlePropagator::propagateToEcal | ( | bool | first = true | ) |
Definition at line 430 of file BaseParticlePropagator.cc.
References propagate(), and setPropagationConditions().
bool BaseParticlePropagator::propagateToEcalEntrance | ( | bool | first = true | ) |
Definition at line 487 of file BaseParticlePropagator.cc.
References RawParticle::cos2ThetaV(), propagate(), setPropagationConditions(), and success.
Referenced by PFTrackTransformer::addPointsAndBrems(), AntiElectronIDMVA6::atECalEntrance(), FBaseSimEvent::fill(), ConvBremSeedProducer::GoodCluster(), and TrajectoryManager::propagateToCalorimeters().
bool BaseParticlePropagator::propagateToHcalEntrance | ( | bool | first = true | ) |
Definition at line 513 of file BaseParticlePropagator.cc.
References RawParticle::cos2ThetaV(), propagate(), propDir, setPropagationConditions(), and success.
Referenced by PFTrackTransformer::addPointsAndBrems(), FBaseSimEvent::fill(), and TrajectoryManager::propagateToCalorimeters().
bool BaseParticlePropagator::propagateToHcalExit | ( | bool | first = true | ) |
Definition at line 566 of file BaseParticlePropagator.cc.
References propagate(), propDir, and setPropagationConditions().
Referenced by PFTrackTransformer::addPointsAndBrems(), and FBaseSimEvent::fill().
bool BaseParticlePropagator::propagateToHOLayer | ( | bool | first = true | ) |
Definition at line 584 of file BaseParticlePropagator.cc.
References funct::abs(), propagate(), propDir, setPropagationConditions(), success, and RawParticle::Z().
Referenced by PFTrackTransformer::addPointsAndBrems(), and FBaseSimEvent::fill().
bool BaseParticlePropagator::propagateToNominalVertex | ( | const XYZTLorentzVector & | hit2 = XYZTLorentzVector(0.,0.,0.,0.) | ) |
Definition at line 606 of file BaseParticlePropagator.cc.
References bField, RawParticle::charge(), funct::cos(), PVValHelper::dx, PVValHelper::dy, helixRadius(), phi, propagateToClosestApproach(), EnergyCorrector::pt, PVValHelper::pT, funct::sin(), mathSSE::sqrt(), RawParticle::X(), and RawParticle::Y().
Referenced by ParticlePropagator::propagateToNominalVertex().
bool BaseParticlePropagator::propagateToPreshowerLayer1 | ( | bool | first = true | ) |
Definition at line 446 of file BaseParticlePropagator.cc.
References propagate(), RawParticle::R2(), setPropagationConditions(), and success.
Referenced by PFTrackTransformer::addPointsAndBrems(), FBaseSimEvent::fill(), and TrajectoryManager::propagateToCalorimeters().
bool BaseParticlePropagator::propagateToPreshowerLayer2 | ( | bool | first = true | ) |
Definition at line 466 of file BaseParticlePropagator.cc.
References propagate(), RawParticle::R2(), setPropagationConditions(), and success.
Referenced by PFTrackTransformer::addPointsAndBrems(), FBaseSimEvent::fill(), and TrajectoryManager::propagateToCalorimeters().
bool BaseParticlePropagator::propagateToVFcalEntrance | ( | bool | first = true | ) |
Definition at line 543 of file BaseParticlePropagator.cc.
References RawParticle::cos2ThetaV(), propagate(), propDir, setPropagationConditions(), and success.
Referenced by FBaseSimEvent::fill(), and TrajectoryManager::propagateToCalorimeters().
|
inline |
Definition at line 307 of file BaseParticlePropagator.h.
|
inline |
|
inline |
Set the magnetic field.
Definition at line 300 of file BaseParticlePropagator.h.
References b.
Referenced by PFTrackTransformer::addPointsAndBrems(), FBaseSimEvent::fill(), ParticlePropagator::ParticlePropagator(), ParticlePropagator::propagateToBoundSurface(), ParticlePropagator::propagateToClosestApproach(), and ParticlePropagator::propagateToNominalVertex().
void BaseParticlePropagator::setPropagationConditions | ( | double | r, |
double | z, | ||
bool | firstLoop = true |
||
) |
Set the propagation characteristics (rCyl, zCyl and first loop only)
Definition at line 350 of file BaseParticlePropagator.cc.
References f, firstLoop, RawParticle::R(), rCyl, rCyl2, RawParticle::Z(), and zCyl.
Referenced by PFTrackTransformer::addPoints(), PFTrackTransformer::addPointsAndBrems(), propagateToClosestApproach(), propagateToEcal(), propagateToEcalEntrance(), propagateToHcalEntrance(), propagateToHcalExit(), propagateToHOLayer(), propagateToPreshowerLayer1(), propagateToPreshowerLayer2(), propagateToVFcalEntrance(), and ParticlePropagator::setPropagationConditions().
|
inline |
Set the proper decay time.
Definition at line 168 of file BaseParticlePropagator.h.
References RawParticle::t().
Referenced by ParticlePropagator::initProperDecayTime(), and ParticlePropagator::ParticlePropagator().
double BaseParticlePropagator::xyImpactParameter | ( | double | x0 = 0. , |
double | y0 = 0. |
||
) | const |
Transverse impact parameter.
Definition at line 755 of file BaseParticlePropagator.cc.
References bField, RawParticle::charge(), helixCentreDistToAxis(), helixCentreX(), helixCentreY(), helixRadius(), helixStartPhi(), PVValHelper::pT, reco::tau::disc::Pt(), TCMET_cfi::radius, RawParticle::X(), and RawParticle::Y().
Referenced by increaseRCyl().
|
inline |
Longitudinal impact parameter.
Definition at line 177 of file BaseParticlePropagator.h.
References mathSSE::sqrt(), RawParticle::X(), RawParticle::Y(), and RawParticle::Z().
|
private |
Magnetic field in the cylinder, oriented along the Z axis.
Definition at line 140 of file BaseParticlePropagator.h.
Referenced by getMagneticField(), propagate(), propagateToBeamCylinder(), propagateToClosestApproach(), propagateToNominalVertex(), and xyImpactParameter().
|
private |
The debug level.
Definition at line 144 of file BaseParticlePropagator.h.
Referenced by rrapi.RRApi::dprint(), pkg.AbstractPkg::generate(), rrapi.RRApi::get(), pkg.AbstractPkg::get_kwds(), init(), and pkg.AbstractPkg::write().
|
private |
The particle decayed while propagated !
Definition at line 159 of file BaseParticlePropagator.h.
Referenced by hasDecayed(), init(), and propagate().
|
protected |
The particle traverses some real material.
Definition at line 150 of file BaseParticlePropagator.h.
Referenced by init(), onFiducial(), and ParticlePropagator::propagateToBoundSurface().
|
private |
Do only the first half-loop.
Definition at line 157 of file BaseParticlePropagator.h.
Referenced by init(), propagate(), propagated(), ParticlePropagator::setPropagationConditions(), and setPropagationConditions().
|
private |
The propagation direction.
Definition at line 163 of file BaseParticlePropagator.h.
Referenced by backPropagate(), init(), propagate(), propagateToHcalEntrance(), propagateToHcalExit(), propagateToHOLayer(), and propagateToVFcalEntrance().
|
private |
The proper decay time of the particle.
Definition at line 142 of file BaseParticlePropagator.h.
Referenced by ParticlePropagator::initProperDecayTime(), and propagate().
|
private |
The proper time of the particle.
Definition at line 161 of file BaseParticlePropagator.h.
Referenced by init(), and propagate().
|
private |
Simulated particle that is to be resp has been propagated.
Radius of the cylinder (centred at 0,0,0) to which propagation is done
Definition at line 135 of file BaseParticlePropagator.h.
Referenced by increaseRCyl(), propagate(), and setPropagationConditions().
|
private |
Definition at line 136 of file BaseParticlePropagator.h.
Referenced by propagate(), and setPropagationConditions().
|
protected |
0:propagation still be done, 1:reached 'barrel', 2:reached 'endcaps'
Definition at line 148 of file BaseParticlePropagator.h.
Referenced by getSuccess(), init(), propagate(), propagated(), ParticlePropagator::propagateToBoundSurface(), propagateToEcalEntrance(), propagateToHcalEntrance(), propagateToHOLayer(), propagateToPreshowerLayer1(), propagateToPreshowerLayer2(), and propagateToVFcalEntrance().
|
private |
Half-height of the cylinder (centred at 0,0,0) to which propagation is done.
Definition at line 138 of file BaseParticlePropagator.h.
Referenced by propagate(), and setPropagationConditions().