6 #include "HepPDT/ParticleID.hh"
10 #define update(a, b) do { (a) = (a) | (b); } while(0)
14 hepMCLabel_( config.getUntrackedParameter<edm::
InputTag>(
"hepMC") ),
15 beamSpotLabel_( config.getUntrackedParameter<edm::
InputTag>(
"beamSpot") ),
16 tracer_(config,std::move(collector)),
17 quality_(config, collector)
166 const SimTrack * assocTrack = &(*tpr->g4Track_begin());
196 double dxySim = -v.
x()*
sin(p.phi()) + v.
y()*
cos(p.phi());
199 double dzSim = v.
z() - (v.
x()*p.x() + v.
y()*p.y())*p.z()/p.perp2();
243 for (
unsigned int i = 0;
i < maxLayers;
i++)
248 for (
unsigned int j = 0;
j < layer.
hits.size();
j++)
274 flags_[
Light] = !
pid.hasCharm() && !
pid.hasBottom();
288 for (TrackHistory::GenParticleTrail::const_iterator iparticle = genParticleTrail.begin(); iparticle != genParticleTrail.end(); ++iparticle)
291 HepMC::GenVertex * productionVertex = (*iparticle)->production_vertex();
297 if (productionVertex)
300 if ( productionVertex->particles_in_size() == 1 )
303 pdgid =
std::abs((*productionVertex->particles_in_const_begin())->pdg_id());
308 if (particleID.isValid())
322 int daughterId =
abs((*iparticle)->pdg_id());
353 TrackHistory::SimParticleTrail::const_iterator iparticle = simParticleTrail.begin();
354 iparticle != simParticleTrail.end();
371 for (its = parentVertex->sourceTracks_begin(); its != parentVertex->sourceTracks_end(); ++its)
373 for (itd = parentVertex->daughterTracks_begin(); itd != parentVertex->daughterTracks_end(); ++itd)
384 if ( its != parentVertex->sourceTracks_end() )
390 unsigned int processG4 = 0;
393 if(parentVertex->nG4Vertices() > 0) {
394 processG4 = (*(parentVertex->g4Vertices_begin())).processType();
429 if (particleID.isValid())
448 int daughtId =
abs((*iparticle)->pdgId());
485 double const mm = 0.1;
487 double oldX = genpv.
x;
488 double oldY = genpv.
y;
489 double oldZ = genpv.
z;
493 TrackHistory::GenParticleTrail::const_reverse_iterator iparticle = genParticleTrail.rbegin();
494 iparticle != genParticleTrail.rend();
499 HepMC::GenVertex *
parent = (*iparticle)->production_vertex();
502 HepMC::ThreeVector
p = parent->point3d();
504 double distance2 =
pow(p.x() * mm - genpv.
x, 2) +
pow(p.y() * mm - genpv.
y, 2) +
pow(p.z() * mm - genpv.
z, 2);
505 double difference2 =
pow(p.x() * mm - oldX, 2) +
pow(p.y() * mm - oldY, 2) +
pow(p.z() * mm - oldZ, 2);
524 TrackHistory::SimParticleTrail::const_reverse_iterator iparticle = simParticleTrail.rbegin();
525 iparticle != simParticleTrail.rend();
532 double distance2 =
pow(p.x() - genpv.
x, 2) +
pow(p.y() - genpv.
y, 2) +
pow(p.z() - genpv.
z, 2);
533 double difference2 =
pow(p.x() - oldX, 2) +
pow(p.y() - oldY, 2) +
pow(p.z() - oldZ, 2);
549 else if ( counter == 1 )
558 return !p->end_vertex() && p->status() == 1;
566 return part->charge()!=0;
586 for ( HepMC::GenEvent::vertex_const_iterator ivertex =
event->vertices_begin(); ivertex !=
event->vertices_end(); ++ivertex )
588 bool hasParentVertex =
false;
592 HepMC::GenVertex::particle_iterator iparent = (*ivertex)->particles_begin(
HepMC::parents);
596 if ( (*iparent)->production_vertex() )
598 hasParentVertex =
true;
603 if (hasParentVertex)
continue;
606 HepMC::FourVector pos = (*ivertex)->position();
608 double const mm = 0.1;
612 std::vector<GeneratedPrimaryVertex>::iterator ientry =
genpvs_.begin();
615 for (; ientry !=
genpvs_.end(); ++ientry)
617 double distance2 =
pow(
pv.x - ientry->x, 2) +
pow(
pv.y - ientry->y, 2) +
pow(
pv.z - ientry->z, 2);
627 ientry->genVertex.push_back((*ivertex)->barcode());
631 HepMC::GenVertex::particle_iterator idecendants = (*ivertex)->particles_begin(HepMC::descendants);
632 idecendants != (*ivertex)->particles_end(HepMC::descendants);
637 if (
find(ientry->finalstateParticles.begin(), ientry->finalstateParticles.end(), (*idecendants)->barcode()) == ientry->finalstateParticles.end() )
639 ientry->finalstateParticles.push_back((*idecendants)->barcode());
640 HepMC::FourVector
m = (*idecendants)->momentum();
642 ientry->ptot.setPx(ientry->ptot.px() + m.px());
643 ientry->ptot.setPy(ientry->ptot.py() + m.py());
644 ientry->ptot.setPz(ientry->ptot.pz() + m.pz());
645 ientry->ptot.setE(ientry->ptot.e() + m.e());
646 ientry->ptsq += m.perp() * m.perp();
648 if ( m.perp() > 0.8 &&
std::abs(m.pseudoRapidity()) < 2.5 &&
isCharged(*idecendants) ) ientry->nGenTrk++;
unsigned int numberOfLayers() const
Return the number of layers with simulated and/or reconstructed hits.
T getUntrackedParameter(std::string const &, T const &) const
const edm::InputTag beamSpotLabel_
const edm::InputTag hepMCLabel_
void newEvent(const edm::Event &, const edm::EventSetup &)
Pre-process event information (for accessing reconstruction information)
bool isNonnull() const
Checks for non-null.
int event() const
get the contents of the subdetector field (should be protected?)
const FreeTrajectoryState & theState() const
double dxyError() const
error on dxy
const G4toCMSLegacyProcTypeMap g4toCMSProcMap_
const TrackingParticleRef & simParticle() const
Return the initial tracking particle from the history.
Sin< T >::type sin(const T &t)
Global3DPoint GlobalPoint
edm::Handle< edm::HepMCProduct > mcInformation_
const TrackerTopology * tTopo_
unsigned int numberOfInnerLayers_
bool isNonnull() const
Checks for non-null.
void find(edm::Handle< EcalRecHitCollection > &hits, DetId thisDet, std::vector< EcalRecHitCollection::const_iterator > &hit, bool debug=false)
unsigned int minTrackerSimHits_
std::vector< GeneratedPrimaryVertex > genpvs_
void processesAtSimulation()
Get information about conversion and other interactions.
void getData(T &iHolder) const
std::vector< const HepMC::GenParticle * > GenParticleTrail
GenParticle trail type.
math::XYZPointD Point
point in the space
void simulationInformation()
Get all the information related to the simulation details.
void qualityInformation(reco::TrackBaseRef const &)
Classify all the tracks by their reconstruction quality.
void reconstructionInformation(reco::TrackBaseRef const &)
Classify all the tracks by their association and reconstruction information.
TrackClassifier const & evaluate(reco::TrackBaseRef const &)
Classify the RecoTrack in categories.
TrackClassifier(edm::ParameterSet const &, edm::ConsumesCollector &&)
Constructor by ParameterSet.
bool isCharged(const HepMC::GenParticle *)
edm::ESHandle< TransientTrackBuilder > transientTrackBuilder_
void evaluate(SimParticleTrail const &, reco::TrackBaseRef const &, const TrackerTopology *tTopo)
Compute information about the track reconstruction quality.
Auxiliary class holding simulated primary vertices.
int bunchCrossing() const
get the detector field from this detid
Cos< T >::type cos(const T &t)
Abs< T >::type abs(const T &t)
math::XYZPoint Point
point in the space
void hadronFlavor()
Get hadron flavor of the initial hadron.
How EventSelector::AcceptEvent() decides whether to accept an event for output otherwise it is excluding the probing of A single or multiple positive and the trigger will pass if any such matching triggers are PASS or EXCEPTION[A criterion thatmatches no triggers at all is detected and causes a throw.] A single negative with an expectation of appropriate bit checking in the decision and the trigger will pass if any such matching triggers are FAIL or EXCEPTION A wildcarded negative criterion that matches more than one trigger in the trigger but the state exists so we define the behavior If all triggers are the negative crieriion will lead to accepting the event(this again matches the behavior of"!*"before the partial wildcard feature was incorporated).The per-event"cost"of each negative criterion with multiple relevant triggers is about the same as!*was in the past
void newEvent(edm::Event const &, edm::EventSetup const &)
Pre-process event information (for accessing reconstraction information)
const unsigned int processId(unsigned int g4ProcessId) const
const Layer & layer(unsigned int index) const
Return information about the given layer by index.
edm::Handle< reco::BeamSpot > beamSpot_
HepPDT::ParticleData ParticleData
GlobalVector momentum() const
double dz() const
dz parameter (= dsz/cos(lambda)). This is the track z0 w.r.t (0,0,0) only if the refPoint is close to...
double dzError() const
error on dz
GlobalPoint position() const
Get track history and classify it in function of their .
tuple idx
DEBUGGING if hasattr(process,"trackMonIterativeTracking2012"): print "trackMonIterativeTracking2012 D...
T const * product() const
bool isFinalstateParticle(const HepMC::GenParticle *)
SimParticleTrail const & simParticleTrail() const
Return all the simulated particle in the history.
void vertexInformation()
Get geometrical information about the vertices.
void processesAtGenerator()
Get all the information related to decay process.
bool evaluate(TrackingParticleRef tpr)
Evaluate track history using a TrackingParticleRef.
void depth(int d)
Set the depth of the history.
edm::ESHandle< MagneticField > magneticField_
const math::XYZTLorentzVectorD & momentum() const
static std::atomic< unsigned int > counter
Flags flags_
Flag containers.
int charge() const
track electric charge
const reco::TrackBaseRef & recoTrack() const
Return a reference to the reconstructed track.
void newEvent(const edm::Event &, const edm::EventSetup &)
Pre-process event information (for accessing reconstruction information)
double longLivedDecayLength_
void reset()
Reset the categories flags.
double vertexClusteringSqDistance_
double dxy() const
dxy parameter. (This is the transverse impact parameter w.r.t. to (0,0,0) ONLY if refPoint is close t...
edm::ESHandle< ParticleDataTable > particleDataTable_
void setup(std::vector< TH2F > &depth, std::string name, std::string units="")
Power< A, B >::type pow(const A &a, const B &b)
void genPrimaryVertices()
GenParticleTrail const & genParticleTrail() const
Return all generated particle in the history.
const HepMC::GenParticle * genParticle() const
Returns a pointer to most primitive status 1 or 2 particle.
Global3DVector GlobalVector
std::vector< TrackingParticleRef > SimParticleTrail
SimParticle trail type.