CMS 3D CMS Logo

List of all members | Public Types | Public Member Functions | Private Member Functions | Private Attributes
TrajectoryManager Class Reference

#include <TrajectoryManager.h>

Public Types

typedef ROOT::Math::AxisAngle Rotation
 

Public Member Functions

void createPSimHits (const TrackerLayer &layer, const ParticlePropagator &P_before, std::map< double, PSimHit > &theHitMap, int trackID, int partID, const TrackerTopology *tTopo)
 Create a vector of PSimHits. More...
 
void initializeRecoGeometry (const GeometricSearchTracker *geomSearchTracker, const TrackerInteractionGeometry *interactionGeometry, const MagneticFieldMap *aFieldMap)
 Initialize the Reconstruction Geometry. More...
 
void initializeTrackerGeometry (const TrackerGeometry *geomTracker)
 Initialize the full Tracker Geometry. More...
 
void loadSimHits (edm::PSimHitContainer &c) const
 
void propagateToCalorimeters (ParticlePropagator &PP, int fsimi, RandomEngineAndDistribution const *)
 Propagate the particle through the calorimeters. More...
 
bool propagateToLayer (ParticlePropagator &PP, unsigned layer)
 
void reconstruct (const TrackerTopology *tTopo, RandomEngineAndDistribution const *)
 Does the real job. More...
 
const TrackerInteractionGeometrytheGeometry ()
 Returns the pointer to geometry. More...
 
 TrajectoryManager ()
 Default Constructor. More...
 
 TrajectoryManager (FSimEvent *aSimEvent, const edm::ParameterSet &matEff, const edm::ParameterSet &simHits, const edm::ParameterSet &decays)
 Constructor from a FSimEvent. More...
 
 ~TrajectoryManager ()
 Default Destructor. More...
 

Private Member Functions

const DetLayerdetLayer (const TrackerLayer &layer, float zpos) const
 Returns the DetLayer pointer corresponding to the FAMOS layer. More...
 
void initializeLayerMap ()
 Initialize correspondence map between Famos interaction geometry and tracker reco geometry. More...
 
void makePSimHits (const GeomDet *det, const TrajectoryStateOnSurface &ts, std::map< double, PSimHit > &theHitMap, int tkID, float el, float thick, int pID, const TrackerTopology *tTopo)
 and there More...
 
std::pair< double, PSimHitmakeSinglePSimHit (const GeomDetUnit &det, const TrajectoryStateOnSurface &ts, int tkID, float el, float thick, int pID, const TrackerTopology *tTopo) const
 and there More...
 
TrajectoryStateOnSurface makeTrajectoryState (const DetLayer *layer, const ParticlePropagator &pp, const MagneticField *field) const
 Teddy, you must put comments there. More...
 
void moveAllDaughters (int fsimi, const Rotation &r, double rescale)
 Move, rescale and rotate all daughters after propagation, material effects and decay of the mother. More...
 
void updateWithDaughters (ParticlePropagator &PP, int fsimi, RandomEngineAndDistribution const *)
 Decay the particle and update the SimEvent with daughters. More...
 

Private Attributes

const MagneticFieldMap_theFieldMap
 
const TrackerInteractionGeometry_theGeometry
 
std::string decayer
 
double distCut
 
bool firstLoop
 
PythiaDecaysmyDecayEngine
 
FSimEventmySimEvent
 
double pTmin
 
const GeometricSearchTrackertheGeomSearchTracker
 
const TrackerGeometrytheGeomTracker
 
std::vector< const DetLayer * > theLayerMap
 
MaterialEffectstheMaterialEffects
 
int theNegLayerOffset
 
std::map< unsigned, std::map< double, PSimHit > > thePSimHits
 
bool use_hardcoded
 

Detailed Description

Definition at line 59 of file TrajectoryManager.h.

Member Typedef Documentation

typedef ROOT::Math::AxisAngle TrajectoryManager::Rotation

Definition at line 64 of file TrajectoryManager.h.

Constructor & Destructor Documentation

TrajectoryManager::TrajectoryManager ( )
inline

Default Constructor.

Definition at line 67 of file TrajectoryManager.h.

References EnergyCorrector::c, createTree::pp, alignCSCRings::r, MuonErrorMatrixAdjuster_cfi::rescale, and trackerHits::simHits.

67 {;}
TrajectoryManager::TrajectoryManager ( FSimEvent aSimEvent,
const edm::ParameterSet matEff,
const edm::ParameterSet simHits,
const edm::ParameterSet decays 
)

Constructor from a FSimEvent.

Definition at line 46 of file TrajectoryManager.cc.

References distCut, firstLoop, edm::ParameterSet::getParameter(), edm::ParameterSet::getUntrackedParameter(), TrajectoryFactories_cff::MaterialEffects, myDecayEngine, pTmin, theMaterialEffects, and use_hardcoded.

49  :
50  mySimEvent(aSimEvent),
51  _theGeometry(nullptr),
52  _theFieldMap(nullptr),
53  theMaterialEffects(nullptr),
54  myDecayEngine(nullptr),
55  theGeomTracker(nullptr),
56  theGeomSearchTracker(nullptr),
57  theLayerMap(56, static_cast<const DetLayer*>(nullptr)), // reserve space for layers here
59  // myHistos(0),
60  use_hardcoded(true)
61 
62 {
63  //std::cout << "TrajectoryManager.cc 1 use_hardcoded = " << use_hardcoded << std::endl;
64  use_hardcoded = matEff.getParameter<bool>("use_hardcoded_geometry");
65 
66  // Initialize Bthe stable particle decay engine
67  if ( decays.getParameter<bool>("ActivateDecays")) {
69  distCut = decays.getParameter<double>("DistCut");
70  }
71  // Initialize the Material Effects updator, if needed
72  if ( matEff.getParameter<bool>("PairProduction") ||
73  matEff.getParameter<bool>("Bremsstrahlung") ||
74  matEff.getParameter<bool>("MuonBremsstrahlung") ||
75  matEff.getParameter<bool>("EnergyLoss") ||
76  matEff.getParameter<bool>("MultipleScattering") ||
77  matEff.getParameter<bool>("NuclearInteraction")
78  )
79  theMaterialEffects = new MaterialEffects(matEff);
80 
81  // Save SimHits according to Optiom
82  // Only the hits from first half loop is saved
83  firstLoop = simHits.getUntrackedParameter<bool>("firstLoop",true);
84  // Only if pT>pTmin are the hits saved
85  pTmin = simHits.getUntrackedParameter<double>("pTmin",0.5);
86 
87  /*
88  // Get the Famos Histos pointer
89  myHistos = Histos::instance();
90 
91  // Initialize a few histograms
92 
93  myHistos->book("h302",1210,-121.,121.,1210,-121.,121.);
94  myHistos->book("h300",1210,-121.,121.,1210,-121.,121.);
95  myHistos->book("h301",1200,-300.,300.,1210,-121.,121.);
96  myHistos->book("h303",1200,-300.,300.,1210,-121.,121.);
97  */
98 }
T getParameter(std::string const &) const
T getUntrackedParameter(std::string const &, T const &) const
PythiaDecays * myDecayEngine
const MagneticFieldMap * _theFieldMap
const TrackerGeometry * theGeomTracker
const GeometricSearchTracker * theGeomSearchTracker
const TrackerInteractionGeometry * _theGeometry
MaterialEffects * theMaterialEffects
std::vector< const DetLayer * > theLayerMap
TrajectoryManager::~TrajectoryManager ( )

Default Destructor.

Definition at line 131 of file TrajectoryManager.cc.

References myDecayEngine, and theMaterialEffects.

131  {
132 
133  if ( myDecayEngine ) delete myDecayEngine;
135 
136  //Write the histograms
137  /*
138  myHistos->put("histos.root");
139  if ( myHistos ) delete myHistos;
140  */
141 }
PythiaDecays * myDecayEngine
MaterialEffects * theMaterialEffects

Member Function Documentation

void TrajectoryManager::createPSimHits ( const TrackerLayer layer,
const ParticlePropagator P_before,
std::map< double, PSimHit > &  theHitMap,
int  trackID,
int  partID,
const TrackerTopology tTopo 
)

Create a vector of PSimHits.

Definition at line 549 of file TrajectoryManager.cc.

References anyDirection, GeometricSearchDet::compatibleDets(), detLayer(), MaterialEffects::energyLoss(), BaseParticlePropagator::getMagneticField(), mps_fire::i, makePSimHits(), makeTrajectoryState(), theMaterialEffects, MaterialEffects::thickness(), and RawParticle::Z().

Referenced by reconstruct().

552  {
553 
554  // Propagate the particle coordinates to the closest tracker detector(s)
555  // in this layer and create the PSimHit(s)
556 
557  // const MagneticField& mf = MagneticFieldMap::instance()->magneticField();
558  // This solution is actually much faster !
559  LocalMagneticField mf(PP.getMagneticField());
560  AnalyticalPropagator alongProp(&mf, anyDirection);
562 
563  // std::cout << "PP.X() = " << PP.X() << std::endl;
564  // std::cout << "PP.Y() = " << PP.Y() << std::endl;
565  // std::cout << "PP.Z() = " << PP.Z() << std::endl;
566 
568  const DetLayer* tkLayer = detLayer(layer,PP.Z());
569 
570  TrajectoryStateOnSurface trajState = makeTrajectoryState( tkLayer, PP, &mf);
571  float thickness = theMaterialEffects ? theMaterialEffects->thickness() : 0.;
572  float eloss = theMaterialEffects ? theMaterialEffects->energyLoss() : 0.;
573 
574  // Find, in the corresponding layers, the detectors compatible
575  // with the current track
576  std::vector<DetWithState> compat
577  = tkLayer->compatibleDets( trajState, alongProp, est);
578 
579  // And create the corresponding PSimHits
580  std::map<double,PSimHit> theTrackHits;
581  for (std::vector<DetWithState>::const_iterator i=compat.begin(); i!=compat.end(); i++) {
582  // Correct Eloss for last 3 rings of TEC (thick sensors, 0.05 cm)
583  // Disgusting fudge factor !
584  makePSimHits( i->first, i->second, theHitMap, trackID, eloss, thickness, partID,tTopo);
585  }
586 
587 }
const DetLayer * detLayer(const TrackerLayer &layer, float zpos) const
Returns the DetLayer pointer corresponding to the FAMOS layer.
void makePSimHits(const GeomDet *det, const TrajectoryStateOnSurface &ts, std::map< double, PSimHit > &theHitMap, int tkID, float el, float thick, int pID, const TrackerTopology *tTopo)
and there
TrajectoryStateOnSurface makeTrajectoryState(const DetLayer *layer, const ParticlePropagator &pp, const MagneticField *field) const
Teddy, you must put comments there.
virtual std::vector< DetWithState > compatibleDets(const TrajectoryStateOnSurface &startingState, const Propagator &prop, const MeasurementEstimator &est) const
MaterialEffects * theMaterialEffects
std::pair< const GeomDet *, TrajectoryStateOnSurface > DetWithState
double energyLoss() const
Return the energy loss by ionization in the current layer.
double thickness() const
Return the thickness of the current layer.
std::pair< const GeomDet *, TrajectoryStateOnSurface > DetWithState
const DetLayer * TrajectoryManager::detLayer ( const TrackerLayer layer,
float  zpos 
) const
private

Returns the DetLayer pointer corresponding to the FAMOS layer.

Definition at line 922 of file TrajectoryManager.cc.

References TrackerLayer::forward(), TrackerLayer::layerNumber(), theLayerMap, and theNegLayerOffset.

Referenced by createPSimHits().

923 {
924  if (zpos > 0 || !layer.forward() ) return theLayerMap[layer.layerNumber()];
925  else return theLayerMap[layer.layerNumber()+theNegLayerOffset];
926 }
unsigned int layerNumber() const
Returns the layer number.
Definition: TrackerLayer.h:82
bool forward() const
Is the layer forward ?
Definition: TrackerLayer.h:70
std::vector< const DetLayer * > theLayerMap
void TrajectoryManager::initializeLayerMap ( )
private

Initialize correspondence map between Famos interaction geometry and tracker reco geometry.

ATTENTION: HARD CODED LOGIC! If Famos layer numbering changes this logic needs to be adapted to the new numbering!

Definition at line 814 of file TrajectoryManager.cc.

References _theGeometry, GeometricSearchTracker::barrelLayers(), TrackerInteractionGeometry::cylinderBegin(), TrackerInteractionGeometry::cylinderEnd(), runEdmFileComparison::found, mps_fire::i, LogDebug, GeometricSearchTracker::negForwardLayers(), GeometricSearchTracker::posForwardLayers(), theGeomSearchTracker, theLayerMap, and theNegLayerOffset.

Referenced by initializeRecoGeometry().

815 {
816 
817  // These are the BoundSurface&, the BoundDisk* and the BoundCylinder* for that layer
818  // const BoundSurface& theSurface = layer.surface();
819  // BoundDisk* theDisk = layer.disk(); // non zero for endcaps
820  // BoundCylinder* theCylinder = layer.cylinder(); // non zero for barrel
821  // int theLayer = layer.layerNumber(); // 1->3 PixB, 4->5 PixD,
822  // // 6->9 TIB, 10->12 TID,
823  // // 13->18 TOB, 19->27 TEC
824 
827 
828  const std::vector< const BarrelDetLayer*>& barrelLayers =
830  LogDebug("FastTracking") << "Barrel DetLayer dump: ";
831  for (auto bl=barrelLayers.begin();
832  bl != barrelLayers.end(); ++bl) {
833  LogDebug("FastTracking")<< "radius " << (**bl).specificSurface().radius();
834  }
835 
836  const std::vector< const ForwardDetLayer*>& posForwardLayers =
838  LogDebug("FastTracking") << "Positive Forward DetLayer dump: ";
839  for (auto fl=posForwardLayers.begin();
840  fl != posForwardLayers.end(); ++fl) {
841  LogDebug("FastTracking") << "Z pos "
842  << (**fl).surface().position().z()
843  << " radii "
844  << (**fl).specificSurface().innerRadius()
845  << ", "
846  << (**fl).specificSurface().outerRadius();
847  }
848 
849  const float rTolerance = 1.5;
850  const float zTolerance = 3.;
851 
852  LogDebug("FastTracking")<< "Dump of TrackerInteractionGeometry cylinders:";
853  for( std::list<TrackerLayer>::const_iterator i=_theGeometry->cylinderBegin();
854  i!=_theGeometry->cylinderEnd(); ++i) {
855  const BoundCylinder* cyl = i->cylinder();
856  const BoundDisk* disk = i->disk();
857 
858  LogDebug("FastTracking") << "Famos Layer no " << i->layerNumber()
859  << " is sensitive? " << i->sensitive()
860  << " pos " << i->surface().position();
861  if (!i->sensitive()) continue;
862 
863  if (cyl != nullptr) {
864  LogDebug("FastTracking") << " cylinder radius " << cyl->radius();
865  bool found = false;
866  for (auto
867  bl=barrelLayers.begin(); bl != barrelLayers.end(); ++bl) {
868 
869  if (fabs( cyl->radius() - (**bl).specificSurface().radius()) < rTolerance) {
870  theLayerMap[i->layerNumber()] = *bl;
871  found = true;
872  LogDebug("FastTracking")<< "Corresponding DetLayer found with radius "
873  << (**bl).specificSurface().radius();
874  break;
875  }
876  }
877  if (!found) {
878  edm::LogWarning("FastTracking") << " Trajectory manager FAILED to find a corresponding DetLayer!";
879  }
880  }
881  else {
882  LogDebug("FastTracking") << " disk radii " << disk->innerRadius()
883  << ", " << disk->outerRadius();
884  bool found = false;
885  for (auto fl=posForwardLayers.begin();
886  fl != posForwardLayers.end(); ++fl) {
887 
888  if (fabs( disk->position().z() - (**fl).surface().position().z()) < zTolerance) {
889  theLayerMap[i->layerNumber()] = *fl;
890  found = true;
891  LogDebug("FastTracking") << "Corresponding DetLayer found with Z pos "
892  << (**fl).surface().position().z()
893  << " and radii "
894  << (**fl).specificSurface().innerRadius()
895  << ", "
896  << (**fl).specificSurface().outerRadius();
897  break;
898  }
899  }
900  if (!found) {
901  edm::LogWarning("FastTracking") << "FAILED to find a corresponding DetLayer!";
902  }
903  }
904  }
905 
906  // Put the negative layers in the same map but with an offset
907  const std::vector< const ForwardDetLayer*>& negForwardLayers = theGeomSearchTracker->negForwardLayers();
908  for (auto nl=negForwardLayers.begin();
909  nl != negForwardLayers.end(); ++nl) {
910  for (int i=0; i<=theNegLayerOffset; i++) {
911  if (theLayerMap[i] == nullptr) continue;
912  if ( fabs( (**nl).surface().position().z() +theLayerMap[i]-> surface().position().z()) < zTolerance) {
914  break;
915  }
916  }
917  }
918 
919 }
#define LogDebug(id)
std::vector< ForwardDetLayer const * > const & posForwardLayers() const
const GeometricSearchTracker * theGeomSearchTracker
std::list< TrackerLayer >::const_iterator cylinderEnd() const
Returns the last pointer in the cylinder list.
const TrackerInteractionGeometry * _theGeometry
std::vector< ForwardDetLayer const * > const & negForwardLayers() const
std::list< TrackerLayer >::const_iterator cylinderBegin() const
Returns the first pointer in the cylinder list.
std::vector< const DetLayer * > theLayerMap
std::vector< BarrelDetLayer const * > const & barrelLayers() const
void TrajectoryManager::initializeRecoGeometry ( const GeometricSearchTracker geomSearchTracker,
const TrackerInteractionGeometry interactionGeometry,
const MagneticFieldMap aFieldMap 
)

Initialize the Reconstruction Geometry.

Definition at line 101 of file TrajectoryManager.cc.

References _theFieldMap, _theGeometry, initializeLayerMap(), and theGeomSearchTracker.

Referenced by FamosManager::setupGeometryAndField().

104 {
105 
106  // Initialize the reco tracker geometry
107  theGeomSearchTracker = geomSearchTracker;
108 
109  // Initialize the simplified tracker geometry
110  _theGeometry = interactionGeometry;
111 
113 
114  // Initialize the magnetic field
115  _theFieldMap = aFieldMap;
116 
117 }
void initializeLayerMap()
Initialize correspondence map between Famos interaction geometry and tracker reco geometry...
const MagneticFieldMap * _theFieldMap
const GeometricSearchTracker * theGeomSearchTracker
const TrackerInteractionGeometry * _theGeometry
void TrajectoryManager::initializeTrackerGeometry ( const TrackerGeometry geomTracker)

Initialize the full Tracker Geometry.

Definition at line 120 of file TrajectoryManager.cc.

References theGeomTracker.

Referenced by FamosManager::setupGeometryAndField().

120  {
121 
122  theGeomTracker = geomTracker;
123 
124 }
const TrackerGeometry * theGeomTracker
void TrajectoryManager::loadSimHits ( edm::PSimHitContainer c) const

Definition at line 929 of file TrajectoryManager.cc.

References begin, end, and thePSimHits.

Referenced by FamosProducer::produce().

930 {
931 
932  std::map<unsigned,std::map<double,PSimHit> >::const_iterator itrack = thePSimHits.begin();
933  std::map<unsigned,std::map<double,PSimHit> >::const_iterator itrackEnd = thePSimHits.end();
934  for ( ; itrack != itrackEnd; ++itrack ) {
935  std::map<double,PSimHit>::const_iterator it = (itrack->second).begin();
936  std::map<double,PSimHit>::const_iterator itEnd = (itrack->second).end();
937  for( ; it!= itEnd; ++it) {
938  /*
939  DetId theDetUnitId((it->second).detUnitId());
940  const GeomDet* theDet = theGeomTracker->idToDet(theDetUnitId);
941  std::cout << "Track/z/r after : "
942  << (it->second).trackId() << " "
943  << theDet->surface().toGlobal((it->second).localPosition()).z() << " "
944  << theDet->surface().toGlobal((it->second).localPosition()).perp() << std::endl;
945  */
946  // Keep only those hits that are on the physical volume of a module
947  // (The other hits have been assigned a negative <double> value.
948  if ( it->first > 0. ) c.push_back(it->second);
949  }
950  }
951 
952 }
#define end
Definition: vmac.h:39
std::map< unsigned, std::map< double, PSimHit > > thePSimHits
#define begin
Definition: vmac.h:32
void TrajectoryManager::makePSimHits ( const GeomDet det,
const TrajectoryStateOnSurface ts,
std::map< double, PSimHit > &  theHitMap,
int  tkID,
float  el,
float  thick,
int  pID,
const TrackerTopology tTopo 
)
private

and there

Definition at line 602 of file TrajectoryManager.cc.

References AlCaHLTBitMon_QueryRunRegistry::comp, GeomDet::components(), mps_fire::i, and makeSinglePSimHit().

Referenced by createPSimHits().

607 {
608 
609  std::vector< const GeomDet*> comp = det->components();
610  if (!comp.empty()) {
611  for (std::vector< const GeomDet*>::const_iterator i = comp.begin();
612  i != comp.end(); i++) {
613  auto du = (*i);
614  if (du->isLeaf()) // not even needed (or it should iterate if really not leaf)
615  theHitMap.insert(theHitMap.end(),makeSinglePSimHit( *du, ts, tkID, el, thick, pID,tTopo));
616  }
617  }
618  else {
619  auto du = (det);
620  theHitMap.insert(theHitMap.end(),makeSinglePSimHit( *du, ts, tkID, el, thick, pID,tTopo));
621  }
622 
623 }
std::pair< double, PSimHit > makeSinglePSimHit(const GeomDetUnit &det, const TrajectoryStateOnSurface &ts, int tkID, float el, float thick, int pID, const TrackerTopology *tTopo) const
and there
virtual std::vector< const GeomDet * > components() const
Returns direct components, if any.
Definition: GeomDet.h:88
std::pair< double, PSimHit > TrajectoryManager::makeSinglePSimHit ( const GeomDetUnit det,
const TrajectoryStateOnSurface ts,
int  tkID,
float  el,
float  thick,
int  pID,
const TrackerTopology tTopo 
) const
private

and there

Definition at line 626 of file TrajectoryManager.cc.

References anyDirection, PV3DBase< T, PVType, FrameType >::basicVector(), Surface::bounds(), FSimTrack::closestDaughterId(), gather_cfg::cout, mps_splice::entry, cmsRelvalreport::exit, GeomDet::geographicalId(), TrajectoryStateOnSurface::globalMomentum(), TrajectoryStateOnSurface::globalPosition(), FSimTrack::id(), listHistos::IP, Bounds::length(), TrajectoryStateOnSurface::localMomentum(), TrajectoryStateOnSurface::localPosition(), PV3DBase< T, PVType, FrameType >::mag(), FSimTrack::mother(), mySimEvent, FSimTrack::noMother(), callgraph::path, FSimVertex::position(), TrackerTopology::pxbLayer(), TrackerTopology::pxfDisk(), DetId::rawId(), GeomDet::surface(), TrackerTopology::tecRing(), TrackerTopology::tecWheel(), TrackerTopology::tibLayer(), TrackerTopology::tidRing(), TrackerTopology::tidWheel(), TrackerTopology::tobLayer(), TrackerTopology::tobStereo(), Surface::toGlobal(), GeomDet::toLocal(), FBaseSimEvent::track(), TrajectoryStateOnSurface::transverseCurvature(), Vector3DBase< T, FrameTag >::unit(), FSimTrack::vertex(), Bounds::width(), hit::x, hit::y, z, PV3DBase< T, PVType, FrameType >::z(), and hit::z.

Referenced by makePSimHits().

630 {
631 
632  const float onSurfaceTolarance = 0.01; // 10 microns
633 
634  LocalPoint lpos;
635  LocalVector lmom;
636  if ( fabs( det.toLocal(ts.globalPosition()).z()) < onSurfaceTolarance) {
637  lpos = ts.localPosition();
638  lmom = ts.localMomentum();
639  }
640  else {
643  ts.transverseCurvature(),
644  anyDirection);
645  std::pair<bool,double> path = crossing.pathLength(det.surface());
646  if (!path.first) {
647  // edm::LogWarning("FastTracking") << "TrajectoryManager ERROR: crossing with det failed, skipping PSimHit";
648  return std::pair<double,PSimHit>(0.,PSimHit());
649  }
650  lpos = det.toLocal( GlobalPoint( crossing.position(path.second)));
651  lmom = det.toLocal( GlobalVector( crossing.direction(path.second)));
652  lmom = lmom.unit() * ts.localMomentum().mag();
653  }
654 
655  // The module (half) thickness
656  const BoundPlane& theDetPlane = det.surface();
657  float halfThick = 0.5*theDetPlane.bounds().thickness();
658  // The Energy loss rescaled to the module thickness
659  float eloss = el;
660  if ( thick > 0. ) {
661  // Total thickness is in radiation lengths, 1 radlen = 9.36 cm
662  // Sensitive module thickness is about 30 microns larger than
663  // the module thickness itself
664  eloss *= (2.* halfThick - 0.003) / (9.36 * thick);
665  }
666  // The entry and exit points, and the time of flight
667  float pZ = lmom.z();
668  LocalPoint entry = lpos + (-halfThick/pZ) * lmom;
669  LocalPoint exit = lpos + halfThick/pZ * lmom;
670  float tof = ts.globalPosition().mag() / 30. ; // in nanoseconds, FIXME: very approximate
671 
672  // If a hadron suffered a nuclear interaction, just assign the hits of the closest
673  // daughter to the mother's track. The same applies to a charged particle decay into
674  // another charged particle.
675  int localTkID = tkID;
676  if ( !mySimEvent->track(tkID).noMother() && mySimEvent->track(tkID).mother().closestDaughterId() == tkID )
677  localTkID = mySimEvent->track(tkID).mother().id();
678 
679  // FIXME: fix the track ID and the particle ID
680  PSimHit hit( entry, exit, lmom.mag(), tof, eloss, pID,
681  det.geographicalId().rawId(), localTkID,
682  lmom.theta(),
683  lmom.phi());
684 
685  // Check that the PSimHit is physically on the module!
686  unsigned subdet = DetId(hit.detUnitId()).subdetId();
687  double boundX = theDetPlane.bounds().width()/2.;
688  double boundY = theDetPlane.bounds().length()/2.;
689 
690  // Special treatment for TID and TEC trapeziodal modules
691  if ( subdet == 4 || subdet == 6 )
692  boundX *= 1. - hit.localPosition().y()/theDetPlane.position().perp();
693 
694 #ifdef FAMOS_DEBUG
695  unsigned detid = DetId(hit.detUnitId()).rawId();
696  unsigned stereo = 0;
697  unsigned theLayer = 0;
698  unsigned theRing = 0;
699  switch (subdet) {
700  case 1:
701  {
702 
703  theLayer = tTopo->pxbLayer(detid);
704  std::cout << "\tPixel Barrel Layer " << theLayer << std::endl;
705  stereo = 1;
706  break;
707  }
708  case 2:
709  {
710 
711  theLayer = tTopo->pxfDisk(detid);
712  std::cout << "\tPixel Forward Disk " << theLayer << std::endl;
713  stereo = 1;
714  break;
715  }
716  case 3:
717  {
718 
719  theLayer = tTopo->tibLayer(detid);
720  std::cout << "\tTIB Layer " << theLayer << std::endl;
721  stereo = module.stereo();
722  break;
723  }
724  case 4:
725  {
726 
727  theLayer = tTopo->tidWheel(detid);
728  theRing = tTopo->tidRing(detid);
729  unsigned int theSide = module.side();
730  if ( theSide == 1 )
731  std::cout << "\tTID Petal Back " << std::endl;
732  else
733  std::cout << "\tTID Petal Front" << std::endl;
734  std::cout << "\tTID Layer " << theLayer << std::endl;
735  std::cout << "\tTID Ring " << theRing << std::endl;
736  stereo = module.stereo();
737  break;
738  }
739  case 5:
740  {
741 
742  theLayer = tTopo->tobLayer(detid);
743  stereo = tTopo->tobStereo(detid);
744  std::cout << "\tTOB Layer " << theLayer << std::endl;
745  break;
746  }
747  case 6:
748  {
749 
750  theLayer = tTopo->tecWheel(detid);
751  theRing = tTopo->tecRing(detid);
752  unsigned int theSide = module.petal()[0];
753  if ( theSide == 1 )
754  std::cout << "\tTEC Petal Back " << std::endl;
755  else
756  std::cout << "\tTEC Petal Front" << std::endl;
757  std::cout << "\tTEC Layer " << theLayer << std::endl;
758  std::cout << "\tTEC Ring " << theRing << std::endl;
759  stereo = module.stereo();
760  break;
761  }
762  default:
763  {
764  stereo = 0;
765  break;
766  }
767  }
768 
769  std::cout << "Thickness = " << 2.*halfThick-0.003 << "; " << thick * 9.36 << std::endl
770  << "Length = " << det.surface().bounds().length() << std::endl
771  << "Width = " << det.surface().bounds().width() << std::endl;
772 
773  std::cout << "Hit position = "
774  << hit.localPosition().x() << " "
775  << hit.localPosition().y() << " "
776  << hit.localPosition().z() << std::endl;
777 #endif
778 
779  // Check if the hit is on the physical volume of the module
780  // (It happens that it is not, in the case of double sided modules,
781  // because the envelope of the gluedDet is larger than each of
782  // the mono and the stereo modules)
783 
784  double dist = 0.;
785  GlobalPoint IP (mySimEvent->track(localTkID).vertex().position().x(),
786  mySimEvent->track(localTkID).vertex().position().y(),
787  mySimEvent->track(localTkID).vertex().position().z());
788 
789  dist = ( fabs(hit.localPosition().x()) > boundX ||
790  fabs(hit.localPosition().y()) > boundY ) ?
791  // Will be used later as a flag to reject the PSimHit!
792  -( det.surface().toGlobal(hit.localPosition()) - IP ).mag2()
793  :
794  // These hits are kept!
795  ( det.surface().toGlobal(hit.localPosition()) - IP ).mag2();
796 
797  // Fill Histos (~poor man event display)
798  /*
799  GlobalPoint gpos( det.toGlobal(hit.localPosition()));
800  // std::cout << "gpos.x() = " << gpos.x() << std::endl;
801  // std::cout << "gpos.y() = " << gpos.y() << std::endl;
802 
803  myHistos->fill("h300",gpos.x(),gpos.y());
804  if ( sin(gpos.phi()) > 0. )
805  myHistos->fill("h301",gpos.z(),gpos.perp());
806  else
807  myHistos->fill("h301",gpos.z(),-gpos.perp());
808  */
809  return std::pair<double,PSimHit>(dist,hit);
810 
811 }
GlobalPoint toGlobal(const Point2DBase< Scalar, LocalTag > lp) const
Definition: Surface.h:106
virtual float length() const =0
unsigned int tibLayer(const DetId &id) const
unsigned int tidRing(const DetId &id) const
unsigned int pxfDisk(const DetId &id) const
unsigned int tecRing(const DetId &id) const
ring id
uint32_t tobStereo(const DetId &id) const
Global3DPoint GlobalPoint
Definition: GlobalPoint.h:10
constexpr uint32_t rawId() const
get the raw id
Definition: DetId.h:47
GlobalPoint globalPosition() const
LocalPoint toLocal(const GlobalPoint &gp) const
Conversion to the R.F. of the GeomDet.
Definition: GeomDet.h:69
const Bounds & bounds() const
Definition: Surface.h:120
unsigned int tidWheel(const DetId &id) const
const Plane & surface() const
The nominal surface of the GeomDet.
Definition: GeomDet.h:42
LocalVector localMomentum() const
virtual float width() const =0
T mag() const
Definition: PV3DBase.h:67
const math::XYZTLorentzVector & position() const
Temporary (until CMSSW moves to Mathcore) - No ! Actually very useful.
Definition: FSimVertex.h:49
T z() const
Definition: PV3DBase.h:64
int closestDaughterId() const
Get the index of the closest charged daughter.
Definition: FSimTrack.h:201
DetId geographicalId() const
The label of this GeomDet.
Definition: GeomDet.h:79
unsigned int pxbLayer(const DetId &id) const
Vector3DBase unit() const
Definition: Vector3DBase.h:57
Definition: DetId.h:18
GlobalVector globalMomentum() const
int id() const
the index in FBaseSimEvent and other vectors
Definition: FSimTrack.h:91
bool noMother() const
no mother particle
const FSimVertex vertex() const
Origin vertex.
const BasicVectorType & basicVector() const
Definition: PV3DBase.h:56
unsigned int tecWheel(const DetId &id) const
Definition: vlib.h:208
const FSimTrack & mother() const
mother
unsigned int tobLayer(const DetId &id) const
Global3DVector GlobalVector
Definition: GlobalVector.h:10
FSimTrack & track(int id) const
Return track with given Id.
TrajectoryStateOnSurface TrajectoryManager::makeTrajectoryState ( const DetLayer layer,
const ParticlePropagator pp,
const MagneticField field 
) const
private

Teddy, you must put comments there.

Definition at line 590 of file TrajectoryManager.cc.

References RawParticle::charge(), GeometricSearchDet::surface(), Surface::tangentPlane(), RawParticle::X(), RawParticle::Y(), and RawParticle::Z().

Referenced by createPSimHits().

593 {
594  GlobalPoint pos( pp.X(), pp.Y(), pp.Z());
595  GlobalVector mom( pp.Px(), pp.Py(), pp.Pz());
596  auto plane = layer->surface().tangentPlane(pos);
598  (GlobalTrajectoryParameters( pos, mom, TrackCharge( pp.charge()), field), *plane);
599 }
virtual ConstReferenceCountingPointer< TangentPlane > tangentPlane(const GlobalPoint &) const =0
int TrackCharge
Definition: TrackCharge.h:4
double Y() const
y of vertex
Definition: RawParticle.h:275
double Z() const
z of vertex
Definition: RawParticle.h:276
virtual const BoundSurface & surface() const =0
The surface of the GeometricSearchDet.
double charge() const
get the MEASURED charge
Definition: RawParticle.h:282
double X() const
x of vertex
Definition: RawParticle.h:274
void TrajectoryManager::moveAllDaughters ( int  fsimi,
const Rotation r,
double  rescale 
)
private

Move, rescale and rotate all daughters after propagation, material effects and decay of the mother.

Definition at line 530 of file TrajectoryManager.cc.

References FSimTrack::daughter(), FSimTrack::id(), FSimTrack::momentum(), mySimEvent, FSimTrack::nDaughters(), MuonErrorMatrixAdjuster_cfi::rescale, FSimTrack::setMomentum(), mathSSE::sqrt(), and FBaseSimEvent::track().

Referenced by updateWithDaughters().

530  {
531 
532  //
533  for ( unsigned idaugh=0; idaugh < (unsigned)(mySimEvent->track(fsimi).nDaughters()); ++idaugh) {
534  // Initial momentum of the daughter
535  XYZTLorentzVector daughMomentum (mySimEvent->track(fsimi).daughter(idaugh).momentum());
536  // Rotate and rescale
537  XYZVector newMomentum (r * daughMomentum.Vect());
538  newMomentum *= rescale;
539  double newEnergy = std::sqrt(newMomentum.mag2() + daughMomentum.mag2());
540  // Set the new momentum
541  mySimEvent->track(fsimi).setMomentum(XYZTLorentzVector(newMomentum.X(),newMomentum.Y(),newMomentum.Z(),newEnergy));
542  // Watch out : recursive call to get all grand-daughters
543  int fsimDaug = mySimEvent->track(fsimi).daughter(idaugh).id();
544  moveAllDaughters(fsimDaug,r,rescale);
545  }
546 }
const XYZTLorentzVector & momentum() const
Temporary (until move of SimTrack to Mathcore) - No! Actually very useful.
Definition: FSimTrack.h:204
void moveAllDaughters(int fsimi, const Rotation &r, double rescale)
Move, rescale and rotate all daughters after propagation, material effects and decay of the mother...
const FSimTrack & daughter(int i) const
Ith daughter.
int nDaughters() const
Number of daughters.
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:29
math::XYZVector XYZVector
T sqrt(T t)
Definition: SSEVec.h:18
int id() const
the index in FBaseSimEvent and other vectors
Definition: FSimTrack.h:91
void setMomentum(const math::XYZTLorentzVector &newMomentum)
Reset the momentum (to be used with care)
Definition: FSimTrack.h:207
math::XYZTLorentzVector XYZTLorentzVector
Definition: RawParticle.h:15
FSimTrack & track(int id) const
Return track with given Id.
void TrajectoryManager::propagateToCalorimeters ( ParticlePropagator PP,
int  fsimi,
RandomEngineAndDistribution const *  random 
)

Propagate the particle through the calorimeters.

Definition at line 376 of file TrajectoryManager.cc.

References BaseParticlePropagator::getSuccess(), BaseParticlePropagator::hasDecayed(), RawParticle::momentum(), mySimEvent, FSimTrack::notYetToEndVertex(), BaseParticlePropagator::propagateToEcalEntrance(), BaseParticlePropagator::propagateToHcalEntrance(), BaseParticlePropagator::propagateToPreshowerLayer1(), BaseParticlePropagator::propagateToPreshowerLayer2(), BaseParticlePropagator::propagateToVFcalEntrance(), FSimTrack::setEcal(), FSimTrack::setHcal(), FSimTrack::setLayer1(), FSimTrack::setLayer2(), SimTrack::setTkMomentum(), SimTrack::setTkPosition(), FSimTrack::setVFcal(), FBaseSimEvent::track(), updateWithDaughters(), and RawParticle::vertex().

Referenced by reconstruct().

376  {
377 
378  FSimTrack& myTrack = mySimEvent->track(fsimi);
379 
380  // Set the position and momentum at the end of the tracker volume
381  myTrack.setTkPosition(PP.vertex().Vect());
382  myTrack.setTkMomentum(PP.momentum());
383 
384  // Propagate to Preshower Layer 1
385  PP.propagateToPreshowerLayer1(false);
386  if ( PP.hasDecayed() ) {
387  updateWithDaughters(PP, fsimi, random);
388  return;
389  }
390  if ( myTrack.notYetToEndVertex(PP.vertex()) && PP.getSuccess() > 0 )
391  myTrack.setLayer1(PP,PP.getSuccess());
392 
393  // Propagate to Preshower Layer 2
394  PP.propagateToPreshowerLayer2(false);
395  if ( PP.hasDecayed() ) {
396  updateWithDaughters(PP, fsimi, random);
397  return;
398  }
399  if ( myTrack.notYetToEndVertex(PP.vertex()) && PP.getSuccess() > 0 )
400  myTrack.setLayer2(PP,PP.getSuccess());
401 
402  // Propagate to Ecal Endcap
403  PP.propagateToEcalEntrance(false);
404  if ( PP.hasDecayed() ) {
405  updateWithDaughters(PP, fsimi, random);
406  return;
407  }
408  if ( myTrack.notYetToEndVertex(PP.vertex()) )
409  myTrack.setEcal(PP,PP.getSuccess());
410 
411  // Propagate to HCAL entrance
412  PP.propagateToHcalEntrance(false);
413  if ( PP.hasDecayed() ) {
414  updateWithDaughters(PP,fsimi, random);
415  return;
416  }
417  if ( myTrack.notYetToEndVertex(PP.vertex()) )
418  myTrack.setHcal(PP,PP.getSuccess());
419 
420  // Propagate to VFCAL entrance
421  PP.propagateToVFcalEntrance(false);
422  if ( PP.hasDecayed() ) {
423  updateWithDaughters(PP,fsimi, random);
424  return;
425  }
426  if ( myTrack.notYetToEndVertex(PP.vertex()) )
427  myTrack.setVFcal(PP,PP.getSuccess());
428 
429 }
bool hasDecayed() const
Has the particle decayed while propagated ?
bool propagateToPreshowerLayer1(bool first=true)
void setEcal(const RawParticle &pp, int success)
Set the ecal variables.
Definition: FSimTrack.cc:81
int getSuccess() const
Has propagation been performed and was barrel or endcap reached ?
void setLayer2(const RawParticle &pp, int success)
Set the preshower layer2 variables.
Definition: FSimTrack.cc:74
TRandom random
Definition: MVATrainer.cc:138
bool notYetToEndVertex(const XYZTLorentzVector &pos) const
Compare the end vertex position with another position.
Definition: FSimTrack.cc:45
bool propagateToVFcalEntrance(bool first=true)
void setLayer1(const RawParticle &pp, int success)
Set the preshower layer1 variables.
Definition: FSimTrack.cc:67
const XYZTLorentzVector & momentum() const
the momentum fourvector
Definition: RawParticle.h:286
bool propagateToEcalEntrance(bool first=true)
const XYZTLorentzVector & vertex() const
the vertex fourvector
Definition: RawParticle.h:285
void setTkPosition(const math::XYZVectorD &pos)
Definition: SimTrack.h:40
bool propagateToHcalEntrance(bool first=true)
void setTkMomentum(const math::XYZTLorentzVectorD &mom)
Definition: SimTrack.h:42
void setVFcal(const RawParticle &pp, int success)
Set the hcal variables.
Definition: FSimTrack.cc:95
void setHcal(const RawParticle &pp, int success)
Set the hcal variables.
Definition: FSimTrack.cc:88
void updateWithDaughters(ParticlePropagator &PP, int fsimi, RandomEngineAndDistribution const *)
Decay the particle and update the SimEvent with daughters.
bool propagateToPreshowerLayer2(bool first=true)
FSimTrack & track(int id) const
Return track with given Id.
bool TrajectoryManager::propagateToLayer ( ParticlePropagator PP,
unsigned  layer 
)

Propagate a particle to a given tracker layer (for electron pixel matching mostly)

Definition at line 432 of file TrajectoryManager.cc.

References _theGeometry, TrackerInteractionGeometry::cylinderBegin(), TrackerInteractionGeometry::cylinderEnd(), BaseParticlePropagator::getSuccess(), BaseParticlePropagator::onFiducial(), ParticlePropagator::propagateToBoundSurface(), and ParticlePropagator::setPropagationConditions().

432  {
433 
434  std::list<TrackerLayer>::const_iterator cyliter;
435  bool done = false;
436 
437  // Get the geometry elements
438  cyliter = _theGeometry->cylinderBegin();
439 
440  // Find the layer to propagate to.
441  for ( ; cyliter != _theGeometry->cylinderEnd() ; ++cyliter ) {
442 
443  if ( layer != cyliter->layerNumber() ) continue;
444 
445  PP.setPropagationConditions(*cyliter);
446 
447  done =
448  PP.propagateToBoundSurface(*cyliter) &&
449  PP.getSuccess() > 0 &&
450  PP.onFiducial();
451 
452  break;
453 
454  }
455 
456  return done;
457 
458 }
std::list< TrackerLayer >::const_iterator cylinderEnd() const
Returns the last pointer in the cylinder list.
int getSuccess() const
Has propagation been performed and was barrel or endcap reached ?
bool propagateToBoundSurface(const TrackerLayer &)
const TrackerInteractionGeometry * _theGeometry
void setPropagationConditions(const TrackerLayer &, bool firstLoop=true)
std::list< TrackerLayer >::const_iterator cylinderBegin() const
Returns the first pointer in the cylinder list.
bool onFiducial() const
Is the vertex on some material ?
void TrajectoryManager::reconstruct ( const TrackerTopology tTopo,
RandomEngineAndDistribution const *  random 
)

Does the real job.

Definition at line 144 of file TrajectoryManager.cc.

References _theFieldMap, _theGeometry, KineParticleFilter::acceptParticle(), FBaseSimEvent::addSimVertex(), createPSimHits(), TrackerInteractionGeometry::cylinderBegin(), TrackerInteractionGeometry::cylinderEnd(), FSimVertexType::END_VERTEX, FBaseSimEvent::filter(), firstLoop, createfilelist::int, MaterialEffects::interact(), heppy_loop::loop, mySimEvent, FSimTrack::nDaughters(), FSimTrack::notYetToEndVertex(), FSimEvent::nTracks(), propagateToCalorimeters(), pTmin, random, MaterialEffects::save(), FSimTrack::setPropagate(), Validation_hcalonly_cfi::sign, summarizeEdmComparisonLogfiles::success, theGeomTracker, theMaterialEffects, thePSimHits, FBaseSimEvent::track(), CoreSimTrack::type(), updateWithDaughters(), and use_hardcoded.

Referenced by FamosManager::reconstruct().

145 {
146 
147  // Clear the hits of the previous event
148  // thePSimHits->clear();
149  thePSimHits.clear();
150 
151  // The new event
152  XYZTLorentzVector myBeamPipe = XYZTLorentzVector(0.,2.5, 9999999.,0.);
153 
154  std::list<TrackerLayer>::const_iterator cyliter;
155 
156  // bool debug = mySimEvent->id().event() == 8;
157 
158  // Loop over the particles (watch out: increasing upper limit!)
159  for( int fsimi=0; fsimi < (int) mySimEvent->nTracks(); ++fsimi) {
160  // If the particle has decayed inside the beampipe, or decays
161  // immediately, there is nothing to do
162  //if ( debug ) std::cout << mySimEvent->track(fsimi) << std::endl;
163  //if ( debug ) std::cout << "Not yet at end vertex ? " << mySimEvent->track(fsimi).notYetToEndVertex(myBeamPipe) << std::endl;
164  if( !mySimEvent->track(fsimi).notYetToEndVertex(myBeamPipe) ) continue;
165  mySimEvent->track(fsimi).setPropagate();
166 
167  // Get the geometry elements
168  cyliter = _theGeometry->cylinderBegin();
169  // Prepare the propagation
171  //The real work starts here
172  int success = 1;
173  int sign = +1;
174  int loop = 0;
175  int cyl = 0;
176 
177  // Find the initial cylinder to propagate to.
178  for ( ; cyliter != _theGeometry->cylinderEnd() ; ++cyliter ) {
179 
180  PP.setPropagationConditions(*cyliter);
181  if ( PP.inside() && !PP.onSurface() ) break;
182  ++cyl;
183 
184  }
185 
186  // The particle has a pseudo-rapidity (position or momentum direction)
187  // in excess of 3.0. Just simply go to the last tracker layer
188  // without bothering with all the details of the propagation and
189  // material effects.
190  // 08/02/06 - pv: increase protection from 0.99 (eta=2.9932) to 0.9998 (eta=4.9517)
191  // to simulate material effects at large eta
192  // if above 0.99: propagate to the last tracker cylinder where the material is concentrated!
193  double ppcos2T = PP.cos2Theta();
194  double ppcos2V = PP.cos2ThetaV();
195 
196  if(use_hardcoded){
197  if ( ( ppcos2T > 0.99 && ppcos2T < 0.9998 ) && ( cyl == 0 || ( ppcos2V > 0.99 && ppcos2V < 0.9998 ) ) ){
198  if ( cyliter != _theGeometry->cylinderEnd() ) {
199  cyliter = _theGeometry->cylinderEnd();
200  --cyliter;
201  }
202  // if above 0.9998: don't propagate at all (only to the calorimeters directly)
203  } else if ( ppcos2T > 0.9998 && ( cyl == 0 || ppcos2V > 0.9998 ) ) {
204  cyliter = _theGeometry->cylinderEnd();
205  }
206  }
207  else {
208  if ( ppcos2T > 0.9998 && ( cyl == 0 || ppcos2V > 0.9998 ) ) {
209  cyliter = _theGeometry->cylinderEnd();
210  }
211  }
212 
213  // Loop over the cylinders
214  while ( cyliter != _theGeometry->cylinderEnd() &&
215  loop<100 && // No more than 100 loops
216  mySimEvent->track(fsimi).notYetToEndVertex(PP.vertex())) { // The particle decayed
217 
218  // Skip layers with no material (kept just for historical reasons)
219  if ( cyliter->surface().mediumProperties().radLen() < 1E-10 ) {
220  ++cyliter; ++cyl;
221  continue;
222  }
223 
224  // Pathological cases:
225  // To prevent from interacting twice in a row with the same layer
226  // bool escapeBarrel = (PP.getSuccess() == -1 && success == 1);
227  bool escapeBarrel = PP.getSuccess() == -1;
228  bool escapeEndcap = (PP.getSuccess() == -2 && success == 1);
229  // To break the loop
230  bool fullPropagation =
231  (PP.getSuccess() <= 0 && success==0) || escapeEndcap;
232 
233  if ( escapeBarrel ) {
234  ++cyliter; ++cyl;
235  while (cyliter != _theGeometry->cylinderEnd() && cyliter->forward() ) {
236  sign=1; ++cyliter; ++cyl;
237  }
238 
239  if ( cyliter == _theGeometry->cylinderEnd() ) {
240  --cyliter; --cyl; fullPropagation=true;
241  }
242 
243  }
244 
245  // Define the propagation conditions
246  PP.setPropagationConditions(*cyliter,!fullPropagation);
247  if ( escapeEndcap ) PP.increaseRCyl(0.0005);
248 
249  // Remember last propagation outcome
250  success = PP.getSuccess();
251 
252  // Propagation was not successful :
253  // Change the sign of the cylinder increment and count the loops
254  if ( !PP.propagateToBoundSurface(*cyliter) ||
255  PP.getSuccess()<=0) {
256  sign = -sign;
257  ++loop;
258  }
259 
260  // The particle may have decayed on its way... in which the daughters
261  // have to be added to the event record
262  if ( PP.hasDecayed() || (!mySimEvent->track(fsimi).nDaughters() && PP.PDGcTau()<1E-3 ) ) {
263  updateWithDaughters(PP, fsimi, random);
264  break;
265  }
266 
267  // Exit by the endcaps or innermost cylinder :
268  // Positive cylinder increment
269  if ( PP.getSuccess()==2 || cyliter==_theGeometry->cylinderBegin() )
270  sign = +1;
271 
272  // Successful propagation to a cylinder, with some Material :
273  if( PP.getSuccess() > 0 && PP.onFiducial() ) {
274 
275  bool saveHit =
276  ( (loop==0 && sign>0) || !firstLoop ) && // Save only first half loop
277  PP.charge()!=0. && // Consider only charged particles
278  cyliter->sensitive() && // Consider only sensitive layers
279  PP.Perp2()>pTmin*pTmin; // Consider only pT > pTmin
280 
281  // Material effects are simulated there
282  if ( theMaterialEffects )
283  theMaterialEffects->interact(*mySimEvent,*cyliter,PP,fsimi, random);
284 
285  // There is a PP.setXYZT=(0,0,0,0) if bremss fails
286  saveHit &= PP.E()>1E-6;
287 
288  if ( saveHit ) {
289  // Consider only active layers
290  if ( cyliter->sensitive() ) {
291  // Add information to the FSimTrack (not yet available)
292  // myTrack.addSimHit(PP,layer);
293 
294  // Return one or two (for overlap regions) PSimHits in the full
295  // tracker geometry
296  if ( theGeomTracker )
297  createPSimHits(*cyliter, PP, thePSimHits[fsimi], fsimi,mySimEvent->track(fsimi).type(), tTopo);
298 
299  /*
300  myHistos->fill("h302",PP.X() ,PP.Y());
301  if ( sin(PP.vertex().Phi()) > 0. )
302  myHistos->fill("h303",PP.Z(),PP.R());
303  else
304  myHistos->fill("h303",PP.Z(),-PP.R());
305  */
306 
307  }
308  }
309 
310  // Fill Histos (~poor man event display)
311  /*
312  myHistos->fill("h300",PP.x(),PP.y());
313  if ( sin(PP.vertex().phi()) > 0. )
314  myHistos->fill("h301",PP.z(),sqrt(PP.vertex().Perp2()));
315  else
316  myHistos->fill("h301",PP.z(),-sqrt(PP.vertex().Perp2()));
317  */
318 
319  //The particle may have lost its energy in the material
320  if ( mySimEvent->track(fsimi).notYetToEndVertex(PP.vertex()) &&
321  !mySimEvent->filter().acceptParticle(PP) )
323 
324  }
325 
326  // Stop here if the particle has reached an end
327  if ( mySimEvent->track(fsimi).notYetToEndVertex(PP.vertex()) ) {
328 
329  // Otherwise increment the cylinder iterator
330  // do {
331  if (sign==1) {++cyliter;++cyl;}
332  else {--cyliter;--cyl;}
333 
334  // Check if the last surface has been reached
335  if( cyliter==_theGeometry->cylinderEnd()) {
336 
337  // Try to propagate to the ECAL in half a loop
338  // Note: Layer1 = ECAL Barrel entrance, or Preshower
339  // entrance, or ECAL Endcap entrance (in the corner)
340  PP.propagateToEcal();
341  // PP.propagateToPreshowerLayer1();
342 
343  // If it is not possible, try go back to the last cylinder
344  if(PP.getSuccess()==0) {
345  --cyliter; --cyl; sign = -sign;
346  PP.setPropagationConditions(*cyliter);
347  PP.propagateToBoundSurface(*cyliter);
348 
349  // If there is definitely no way, leave it here.
350  if(PP.getSuccess()<0) {++cyliter; ++cyl;}
351 
352  }
353 
354  // Check if the particle has decayed on the way to ECAL
355  if ( PP.hasDecayed() )
356  updateWithDaughters(PP, fsimi, random);
357 
358  }
359  }
360 
361  }
362 
363  // Propagate all particles without a end vertex to the Preshower,
364  // theECAL and the HCAL.
365  if ( mySimEvent->track(fsimi).notYetToEndVertex(PP.vertex()) )
366  propagateToCalorimeters(PP, fsimi, random);
367 
368  }
369 
370  // Save the information from Nuclear Interaction Generation
372 
373 }
int addSimVertex(const XYZTLorentzVector &decayVertex, int im=-1, FSimVertexType::VertexType type=FSimVertexType::ANY)
Add a new vertex to the Event and to the various lists.
void propagateToCalorimeters(ParticlePropagator &PP, int fsimi, RandomEngineAndDistribution const *)
Propagate the particle through the calorimeters.
bool acceptParticle(const RawParticle &p) const
void createPSimHits(const TrackerLayer &layer, const ParticlePropagator &P_before, std::map< double, PSimHit > &theHitMap, int trackID, int partID, const TrackerTopology *tTopo)
Create a vector of PSimHits.
const MagneticFieldMap * _theFieldMap
const TrackerGeometry * theGeomTracker
std::list< TrackerLayer >::const_iterator cylinderEnd() const
Returns the last pointer in the cylinder list.
void setPropagate()
The particle has been propgated through the tracker.
Definition: FSimTrack.cc:61
int nDaughters() const
Number of daughters.
TRandom random
Definition: MVATrainer.cc:138
bool notYetToEndVertex(const XYZTLorentzVector &pos) const
Compare the end vertex position with another position.
Definition: FSimTrack.cc:45
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:29
const TrackerInteractionGeometry * _theGeometry
MaterialEffects * theMaterialEffects
void save()
Save nuclear interaction information.
unsigned int nTracks() const
Number of tracks.
Definition: FSimEvent.cc:36
std::map< unsigned, std::map< double, PSimHit > > thePSimHits
void interact(FSimEvent &simEvent, const TrackerLayer &layer, ParticlePropagator &PP, unsigned i, RandomEngineAndDistribution const *)
std::list< TrackerLayer >::const_iterator cylinderBegin() const
Returns the first pointer in the cylinder list.
int type() const
particle type (HEP PDT convension)
Definition: CoreSimTrack.h:25
const KineParticleFilter & filter() const
void updateWithDaughters(ParticlePropagator &PP, int fsimi, RandomEngineAndDistribution const *)
Decay the particle and update the SimEvent with daughters.
math::XYZTLorentzVector XYZTLorentzVector
Definition: RawParticle.h:15
FSimTrack & track(int id) const
Return track with given Id.
const TrackerInteractionGeometry * TrajectoryManager::theGeometry ( )

Returns the pointer to geometry.

Definition at line 127 of file TrajectoryManager.cc.

References _theGeometry.

127  {
128  return _theGeometry;
129 }
const TrackerInteractionGeometry * _theGeometry
void TrajectoryManager::updateWithDaughters ( ParticlePropagator PP,
int  fsimi,
RandomEngineAndDistribution const *  random 
)
private

Decay the particle and update the SimEvent with daughters.

Definition at line 461 of file TrajectoryManager.cc.

References FBaseSimEvent::addSimTrack(), FBaseSimEvent::addSimVertex(), angle(), RawParticle::charge(), BPhysicsValidation_cfi::daughters, FSimVertexType::DECAY_VERTEX, distCut, FSimTrack::endVertex(), FSimVertex::id(), FSimTrack::momentum(), RawParticle::momentum(), moveAllDaughters(), myDecayEngine, mySimEvent, FSimTrack::nDaughters(), PythiaDecays::particleDaughters(), alignCSCRings::r, MuonErrorMatrixAdjuster_cfi::rescale, FSimTrack::setClosestDaughterId(), FSimVertex::setPosition(), mathSSE::sqrt(), RandomEngineAndDistribution::theEngine(), FBaseSimEvent::track(), FBaseSimEvent::vertex(), and RawParticle::vertex().

Referenced by propagateToCalorimeters(), and reconstruct().

461  {
462 
463  // The particle was already decayed in the GenEvent, but still the particle was
464  // allowed to propagate (for magnetic field bending, for material effects, etc...)
465  // Just modify the momentum of the daughters in that case
466  unsigned nDaugh = mySimEvent->track(fsimi).nDaughters();
467  if ( nDaugh ) {
468 
469  // Move the vertex
470  unsigned vertexId = mySimEvent->track(fsimi).endVertex().id();
471  mySimEvent->vertex(vertexId).setPosition(PP.vertex());
472 
473  // Before-propagation and after-propagation momentum and vertex position
474  XYZTLorentzVector momentumBefore = mySimEvent->track(fsimi).momentum();
475  const XYZTLorentzVector& momentumAfter = PP.momentum();
476  double magBefore = std::sqrt(momentumBefore.Vect().mag2());
477  double magAfter = std::sqrt(momentumAfter.Vect().mag2());
478  // Rotation to be applied
479  XYZVector axis = momentumBefore.Vect().Cross(momentumAfter.Vect());
480  double angle = std::acos(momentumBefore.Vect().Dot(momentumAfter.Vect())/(magAfter*magBefore));
481  Rotation r(axis,angle);
482  // Rescaling to be applied
483  double rescale = magAfter/magBefore;
484 
485  // Move, rescale and rotate daugthers, grand-daughters, etc.
486  moveAllDaughters(fsimi,r,rescale);
487 
488  // The particle is not decayed in the GenEvent, decay it with PYTHIA
489  } else {
490 
491  // Decays are not activated : do nothing
492  if ( !myDecayEngine ) return;
493 
494  // Invoke PYDECY (Pythia6) or Pythia8 to decay the particle and get the daughters
496 
497  // Update the FSimEvent with an end vertex and with the daughters
498  if ( !daughters.empty() ) {
499  double distMin = 1E99;
500  int theClosestChargedDaughterId = -1;
501  DaughterParticleIterator daughter = daughters.begin();
502 
503  int ivertex = mySimEvent->addSimVertex(daughter->vertex(),fsimi,
505 
506  if ( ivertex != -1 ) {
507  for ( ; daughter != daughters.end(); ++daughter) {
508  int theDaughterId = mySimEvent->addSimTrack(&(*daughter), ivertex);
509  // Find the closest charged daughter (if charged mother)
510  if ( PP.charge() * daughter->charge() > 1E-10 ) {
511  double dist = (daughter->Vect().Unit().Cross(PP.Vect().Unit())).R();
512  if ( dist < distCut && dist < distMin ) {
513  distMin = dist;
514  theClosestChargedDaughterId = theDaughterId;
515  }
516  }
517  }
518  }
519  // Attach mother and closest daughter sp as to cheat tracking ;-)
520  if ( theClosestChargedDaughterId >=0 )
521  mySimEvent->track(fsimi).setClosestDaughterId(theClosestChargedDaughterId);
522  }
523 
524  }
525 
526 }
int id() const
the index in FBaseSimEvent
Definition: FSimVertex.h:44
int addSimVertex(const XYZTLorentzVector &decayVertex, int im=-1, FSimVertexType::VertexType type=FSimVertexType::ANY)
Add a new vertex to the Event and to the various lists.
PythiaDecays * myDecayEngine
int addSimTrack(const RawParticle *p, int iv, int ig=-1, const HepMC::GenVertex *ev=0)
Add a new track to the Event and to the various lists.
const FSimVertex & endVertex() const
end vertex
void setPosition(const math::XYZTLorentzVector &newPosition)
Reset the position (to be used with care)
Definition: FSimVertex.h:52
const XYZTLorentzVector & momentum() const
Temporary (until move of SimTrack to Mathcore) - No! Actually very useful.
Definition: FSimTrack.h:204
void moveAllDaughters(int fsimi, const Rotation &r, double rescale)
Move, rescale and rotate all daughters after propagation, material effects and decay of the mother...
const DaughterParticleList & particleDaughters(ParticlePropagator &particle, CLHEP::HepRandomEngine *)
Definition: PythiaDecays.cc:34
int nDaughters() const
Number of daughters.
DaughterParticleList::const_iterator DaughterParticleIterator
Definition: PythiaDecays.h:26
void setClosestDaughterId(int id)
Set the index of the closest charged daughter.
Definition: FSimTrack.h:198
TRandom random
Definition: MVATrainer.cc:138
ROOT::Math::AxisAngle Rotation
FSimVertex & vertex(int id) const
Return vertex with given Id.
const XYZTLorentzVector & momentum() const
the momentum fourvector
Definition: RawParticle.h:286
math::XYZVector XYZVector
T sqrt(T t)
Definition: SSEVec.h:18
double charge() const
get the MEASURED charge
Definition: RawParticle.h:282
const XYZTLorentzVector & vertex() const
the vertex fourvector
Definition: RawParticle.h:285
math::XYZTLorentzVector XYZTLorentzVector
Definition: RawParticle.h:15
std::vector< RawParticle > DaughterParticleList
Definition: PythiaDecays.h:25
FSimTrack & track(int id) const
Return track with given Id.
T angle(T x1, T y1, T z1, T x2, T y2, T z2)
Definition: angle.h:11

Member Data Documentation

const MagneticFieldMap* TrajectoryManager::_theFieldMap
private

Definition at line 143 of file TrajectoryManager.h.

Referenced by initializeRecoGeometry(), and reconstruct().

const TrackerInteractionGeometry* TrajectoryManager::_theGeometry
private
std::string TrajectoryManager::decayer
private

Definition at line 148 of file TrajectoryManager.h.

double TrajectoryManager::distCut
private

Definition at line 149 of file TrajectoryManager.h.

Referenced by TrajectoryManager(), and updateWithDaughters().

bool TrajectoryManager::firstLoop
private

Definition at line 152 of file TrajectoryManager.h.

Referenced by reconstruct(), and TrajectoryManager().

PythiaDecays* TrajectoryManager::myDecayEngine
private

Definition at line 147 of file TrajectoryManager.h.

Referenced by TrajectoryManager(), updateWithDaughters(), and ~TrajectoryManager().

FSimEvent* TrajectoryManager::mySimEvent
private
double TrajectoryManager::pTmin
private

Definition at line 151 of file TrajectoryManager.h.

Referenced by reconstruct(), and TrajectoryManager().

const GeometricSearchTracker* TrajectoryManager::theGeomSearchTracker
private

Definition at line 156 of file TrajectoryManager.h.

Referenced by initializeLayerMap(), and initializeRecoGeometry().

const TrackerGeometry* TrajectoryManager::theGeomTracker
private

Definition at line 155 of file TrajectoryManager.h.

Referenced by initializeTrackerGeometry(), and reconstruct().

std::vector<const DetLayer*> TrajectoryManager::theLayerMap
private

Definition at line 157 of file TrajectoryManager.h.

Referenced by detLayer(), and initializeLayerMap().

MaterialEffects* TrajectoryManager::theMaterialEffects
private
int TrajectoryManager::theNegLayerOffset
private

Definition at line 158 of file TrajectoryManager.h.

Referenced by detLayer(), and initializeLayerMap().

std::map<unsigned,std::map<double,PSimHit> > TrajectoryManager::thePSimHits
private

Definition at line 153 of file TrajectoryManager.h.

Referenced by loadSimHits(), and reconstruct().

bool TrajectoryManager::use_hardcoded
private

Definition at line 162 of file TrajectoryManager.h.

Referenced by reconstruct(), and TrajectoryManager().