CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
GoodSeedProducer.cc
Go to the documentation of this file.
1 // -*- C++ -*-
2 //
3 // Package: PFTracking
4 // Class: GoodSeedProducer
5 //
6 // Original Author: Michele Pioppi
7 // March 2010. F. Beaudette. Produce PreId information
8 
12 
29 
31 
32 #include <fstream>
33 #include <string>
34 #include "TMath.h"
35 #include "Math/VectorUtil.h"
36 
37 using namespace edm;
38 using namespace std;
39 using namespace reco;
40 
42  pfTransformer_(nullptr),
43  conf_(iConfig),
44  resMapEtaECAL_(nullptr),
45  resMapPhiECAL_(nullptr)
46 {
47  LogInfo("GoodSeedProducer")<<"Electron PreIdentification started ";
48 
49  //now do what ever initialization is needed
50  std::vector<edm::InputTag> tags = iConfig.getParameter< vector < InputTag > >("TkColList");
51  for(unsigned int i=0;i<tags.size();++i) {
52  trajContainers_.push_back(consumes<vector<Trajectory> >(tags[i]));
53  tracksContainers_.push_back(consumes<reco::TrackCollection>(tags[i]));
54  }
55 
56  minPt_=iConfig.getParameter<double>("MinPt");
57  maxPt_=iConfig.getParameter<double>("MaxPt");
58  maxEta_=iConfig.getParameter<double>("MaxEta");
59 
60  HcalIsolWindow_ =iConfig.getParameter<double>("HcalWindow");
61  EcalStripSumE_minClusEnergy_ = iConfig.getParameter<double>("EcalStripSumE_minClusEnergy");
62  EcalStripSumE_deltaEta_ = iConfig.getParameter<double>("EcalStripSumE_deltaEta");
63  EcalStripSumE_deltaPhiOverQ_minValue_ = iConfig.getParameter<double>("EcalStripSumE_deltaPhiOverQ_minValue");
64  EcalStripSumE_deltaPhiOverQ_maxValue_ = iConfig.getParameter<double>("EcalStripSumE_deltaPhiOverQ_maxValue");
65  minEoverP_= iConfig.getParameter<double>("EOverPLead_minValue");
66  maxHoverP_= iConfig.getParameter<double>("HOverPLead_maxValue");
67 
68  pfCLusTagECLabel_=consumes<reco::PFClusterCollection>(iConfig.getParameter<InputTag>("PFEcalClusterLabel"));
69 
70  pfCLusTagHCLabel_=consumes<reco::PFClusterCollection>(iConfig.getParameter<InputTag>("PFHcalClusterLabel"));
71 
72  pfCLusTagPSLabel_=consumes<reco::PFClusterCollection>(iConfig.getParameter<InputTag>("PFPSClusterLabel"));
73 
74  preidgsf_ = iConfig.getParameter<string>("PreGsfLabel");
75  preidckf_ = iConfig.getParameter<string>("PreCkfLabel");
76  preidname_= iConfig.getParameter<string>("PreIdLabel");
77 
78 
79  fitterName_ = iConfig.getParameter<string>("Fitter");
80  smootherName_ = iConfig.getParameter<string>("Smoother");
81 
82 
83  nHitsInSeed_=iConfig.getParameter<int>("NHitsInSeed");
84 
85  clusThreshold_=iConfig.getParameter<double>("ClusterThreshold");
86 
87  minEp_=iConfig.getParameter<double>("MinEOverP");
88  maxEp_=iConfig.getParameter<double>("MaxEOverP");
89 
90  //collection to produce
91  produceCkfseed_ = iConfig.getUntrackedParameter<bool>("ProduceCkfSeed",false);
92 
93  // to disable the electron part (for HI collisions for examples)
94  disablePreId_ = iConfig.getUntrackedParameter<bool>("DisablePreId",false);
95 
96  producePreId_ = iConfig.getUntrackedParameter<bool>("ProducePreId",true);
97  // if no electron, cannot produce the preid
98  if(disablePreId_)
99  producePreId_=false;
100  PtThresholdSavePredId_ = iConfig.getUntrackedParameter<double>("PtThresholdSavePreId",1.);
101 
102  LogDebug("GoodSeedProducer")<<"Seeds for GSF will be produced ";
103 
104  // no disablePreId_ switch here. The collection will be empty if it is true
105  produces<ElectronSeedCollection>(preidgsf_);
106 
107  if(produceCkfseed_){
108  LogDebug("GoodSeedProducer")<<"Seeds for CKF will be produced ";
109  produces<TrajectorySeedCollection>(preidckf_);
110  }
111 
112  if(producePreId_){
113  LogDebug("GoodSeedProducer")<<"PreId debugging information will be produced ";
114 
115  produces<PreIdCollection>(preidname_);
116  if(tracksContainers_.size()==1) // do not make a value map if more than one input track collection
118  }
119 
120  useQuality_ = iConfig.getParameter<bool>("UseQuality");
121  trackQuality_=TrackBase::qualityByName(iConfig.getParameter<std::string>("TrackQuality"));
122 
123  useTmva_= iConfig.getUntrackedParameter<bool>("UseTMVA",false);
124 
125  Min_dr_ = iConfig.getParameter<double>("Min_dr");
126 
127  trackerRecHitBuilderName_ = iConfig.getParameter<std::string>("TTRHBuilder");
128 
129 }
130 
131 
132 //
133 // member functions
134 //
135 
136 // ------------ method called to produce the data ------------
137 void
139 {
140 
141  LogDebug("GoodSeedProducer")<<"START event: "<<iEvent.id().event()
142  <<" in run "<<iEvent.id().run();
143  //Create empty output collections
144  auto_ptr<ElectronSeedCollection> output_preid(new ElectronSeedCollection);
145  auto_ptr<TrajectorySeedCollection> output_nopre(new TrajectorySeedCollection);
146  auto_ptr<PreIdCollection> output_preidinfo(new PreIdCollection);
147  auto_ptr<edm::ValueMap<reco::PreIdRef> > preIdMap_p(new edm::ValueMap<reco::PreIdRef>);
148  edm::ValueMap<reco::PreIdRef>::Filler mapFiller(*preIdMap_p);
149 
150  //Tracking Tools
151  if(!disablePreId_)
152  {
155  iSetup.get<TrajectoryFitter::Record>().get(fitterName_, aFitter);
156  iSetup.get<TrajectoryFitter::Record>().get(smootherName_, aSmoother);
157  smoother_.reset(aSmoother->clone());
158  fitter_ = aFitter->clone();
159  edm::ESHandle<TransientTrackingRecHitBuilder> theTrackerRecHitBuilder;
160  iSetup.get<TransientRecHitRecord>().get(trackerRecHitBuilderName_,theTrackerRecHitBuilder);
161  hitCloner = static_cast<TkTransientTrackingRecHitBuilder const *>(theTrackerRecHitBuilder.product())->cloner();
162  fitter_->setHitCloner(&hitCloner);
163  smoother_->setHitCloner(&hitCloner);
164  }
165 
166  // clear temporary maps
167  refMap_.clear();
168 
169  //Handle input collections
170  //ECAL clusters
171  Handle<PFClusterCollection> theECPfClustCollection;
172  iEvent.getByToken(pfCLusTagECLabel_,theECPfClustCollection);
173 
174 
175  vector<PFCluster const *> basClus;
176  for ( auto const & klus : *theECPfClustCollection.product() ) {
177  if(klus.correctedEnergy()>clusThreshold_) basClus.push_back(&klus);
178  }
179 
180  //HCAL clusters
181  Handle<PFClusterCollection> theHCPfClustCollection;
182  iEvent.getByToken(pfCLusTagHCLabel_,theHCPfClustCollection);
183 
184  //PS clusters
185  Handle<PFClusterCollection> thePSPfClustCollection;
186  iEvent.getByToken(pfCLusTagPSLabel_,thePSPfClustCollection);
187 
188  //Vector of track collections
189  for (unsigned int istr=0; istr<tracksContainers_.size();++istr){
190 
191  //Track collection
192  Handle<TrackCollection> tkRefCollection;
193  iEvent.getByToken(tracksContainers_[istr], tkRefCollection);
194  const TrackCollection& Tk=*(tkRefCollection.product());
195 
196  //Trajectory collection
197  Handle<vector<Trajectory> > tjCollection;
198  iEvent.getByToken(trajContainers_[istr], tjCollection);
199  auto const & Tj=*(tjCollection.product());
200 
201  LogDebug("GoodSeedProducer")<<"Number of tracks in collection "
202  <<tracksContainers_[istr] <<" to be analyzed "
203  <<Tj.size();
204 
205  //loop over the track collection
206  for(unsigned int i=0;i<Tk.size();++i){
207  if (useQuality_ &&
208  (!(Tk[i].quality(trackQuality_)))) continue;
209 
210  reco::PreId myPreId;
211  bool GoodPreId=false;
212 
213  TrackRef trackRef(tkRefCollection, i);
214  // TrajectorySeed Seed=Tj[i].seed();
215  math::XYZVectorF tkmom(Tk[i].momentum());
216  auto tketa= tkmom.eta();
217  auto tkpt = std::sqrt(tkmom.perp2());
218  auto const & Seed=(*trackRef->seedRef());
219  if(!disablePreId_)
220  {
221  int ipteta=getBin(Tk[i].eta(),Tk[i].pt());
222  int ibin=ipteta*9;
223 
224  float oPTOB=1.f/Tj[i].lastMeasurement().updatedState().globalMomentum().mag();
225  // float chikfred=Tk[i].normalizedChi2();
226  float nchi=Tk[i].normalizedChi2();
227 
228  int nhitpi=Tj[i].foundHits();
229  float EP=0;
230 
231  // set track info
232  myPreId.setTrack(trackRef);
233  //CLUSTERS - TRACK matching
234 
235  auto pfmass= 0.0005;
236  auto pfoutenergy=sqrt((pfmass*pfmass)+Tk[i].outerMomentum().Mag2());
237 
238  XYZTLorentzVector mom =XYZTLorentzVector(Tk[i].outerMomentum().x(),
239  Tk[i].outerMomentum().y(),
240  Tk[i].outerMomentum().z(),
241  pfoutenergy);
242  XYZTLorentzVector pos = XYZTLorentzVector(Tk[i].outerPosition().x(),
243  Tk[i].outerPosition().y(),
244  Tk[i].outerPosition().z(),
245  0.);
246 
247  BaseParticlePropagator theOutParticle( RawParticle(mom,pos),
248  0,0,B_.z());
249  theOutParticle.setCharge(Tk[i].charge());
250 
251  theOutParticle.propagateToEcalEntrance(false);
252 
253 
254 
255  float toteta=1000.f;
256  float totphi=1000.f;
257  float dr=1000.f;
258  float EE=0.f;
259  float feta=0.f;
260  GlobalPoint ElecTrkEcalPos(0,0,0);
261 
262  PFClusterRef clusterRef;
263  math::XYZPoint meanShowerSaved;
264  if(theOutParticle.getSuccess()!=0){
265  ElecTrkEcalPos=GlobalPoint(theOutParticle.vertex().x(),
266  theOutParticle.vertex().y(),
267  theOutParticle.vertex().z()
268  );
269 
270  constexpr float psLim = 2.50746495928f; // std::sinh(1.65f);
271  bool isBelowPS= (ElecTrkEcalPos.z()*ElecTrkEcalPos.z()) > (psLim*psLim)*ElecTrkEcalPos.perp2();
272  // bool isBelowPS=(std::abs(ElecTrkEcalPos.eta())>1.65f);
273 
274  unsigned clusCounter=0;
275  float max_ee = 0;
276  for(auto aClus : basClus) {
277 
278  float tmp_ep=float(aClus->correctedEnergy())*oPTOB;
279  if ((tmp_ep<minEp_)|(tmp_ep>maxEp_)) { ++clusCounter; continue;}
280 
281  double ecalShowerDepth
282  = PFCluster::getDepthCorrection(aClus->correctedEnergy(),
283  isBelowPS,
284  false);
285  auto mom = theOutParticle.momentum().Vect();
286  auto meanShower = ElecTrkEcalPos +
287  GlobalVector(mom.x(),mom.y(),mom.z()).unit()*ecalShowerDepth;
288 
289  float etarec=meanShower.eta();
290  float phirec=meanShower.phi();
291 
292 
293  float tmp_phi=std::abs(aClus->positionREP().phi()-phirec);
294  if (tmp_phi>float(TMath::Pi())) tmp_phi-= float(TMath::TwoPi());
295 
296  float tmp_dr=std::sqrt(std::pow(tmp_phi,2.f)+
297  std::pow(aClus->positionREP().eta()-etarec,2.f));
298 
299  if (tmp_dr<dr){
300  dr=tmp_dr;
301  if(dr < Min_dr_){ // find the most closest and energetic ECAL cluster
302  if(aClus->correctedEnergy() > max_ee){
303 
304  toteta=aClus->positionREP().eta()-etarec;
305  totphi=tmp_phi;
306  EP=tmp_ep;
307  EE=aClus->correctedEnergy();
308  feta= aClus->positionREP().eta();
309  clusterRef = PFClusterRef(theECPfClustCollection,clusCounter);
310  meanShowerSaved = meanShower;
311 
312  }
313  }
314  }
315  ++clusCounter;
316  }
317  }
318  float trk_ecalDeta_ = fabs(toteta);
319  float trk_ecalDphi_ = fabs(totphi);
320 
321  //Resolution maps
322  auto ecaletares
323  = resMapEtaECAL_->GetBinContent(resMapEtaECAL_->FindBin(feta,EE));
324  auto ecalphires
325  = resMapPhiECAL_->GetBinContent(resMapPhiECAL_->FindBin(feta,EE));
326 
327  //geomatrical compatibility
328  float chieta=(toteta!=1000.f)? toteta/ecaletares : toteta;
329  float chiphi=(totphi!=1000.f)? totphi/ecalphires : totphi;
330  float chichi= sqrt(chieta*chieta + chiphi*chiphi);
331 
332  //Matching criteria
333  float eta_cut = thr[ibin+0];
334  float phi_cut = thr[ibin+1];
335  float ep_cutmin=thr[ibin+2];
336  bool GoodMatching= ((trk_ecalDeta_<eta_cut) && (trk_ecalDphi_<phi_cut) && (EP>ep_cutmin) && (nhitpi>10));
337 
338  bool EcalMatching=GoodMatching;
339 
340  if (tkpt>maxPt_) GoodMatching=true;
341  if (tkpt<minPt_) GoodMatching=false;
342 
343 
344 
345  math::XYZPoint myPoint(ElecTrkEcalPos.x(),ElecTrkEcalPos.y(),ElecTrkEcalPos.z());
346  myPreId.setECALMatchingProperties(clusterRef,myPoint,meanShowerSaved,std::abs(toteta),std::abs(totphi),chieta,
347  chiphi,chichi,EP);
348  myPreId.setECALMatching(EcalMatching);
349 
350 
351  bool GoodRange= ((std::abs(tketa)<maxEta_) &
352  (tkpt>minPt_));
353  //KF FILTERING FOR UNMATCHED EVENTS
354  int hit1max=int(thr[ibin+3]);
355  float chiredmin=thr[ibin+4];
356  bool GoodKFFiltering =
357  ((nchi>chiredmin) | (nhitpi<hit1max));
358 
359 
360  myPreId.setTrackFiltering(GoodKFFiltering);
361 
362  bool GoodTkId= false;
363 
364  if((!GoodMatching) &&(GoodKFFiltering) &&(GoodRange)){
365  chired=1000;
366  chiRatio=1000;
367  dpt=0;
368  nhit=nhitpi;
369  chikfred = nchi;
370  trk_ecalDeta = trk_ecalDeta_;
371  trk_ecalDphi = trk_ecalDphi_;
372 
374  Trajectory::ConstRecHitContainer && hits=Tj[i].recHits();
375  for (int ih=hits.size()-1; ih>=0; ih--) tmp.push_back(hits[ih]);
376  Trajectory && FitTjs= fitter_->fitOne(Seed,tmp,Tj[i].lastMeasurement().updatedState());
377 
378  if(FitTjs.isValid()){
379  Trajectory && SmooTjs= smoother_->trajectory(FitTjs);
380  if(SmooTjs.isValid()){
381 
382  //Track refitted with electron hypothesis
383 
384  float pt_out=SmooTjs.firstMeasurement().
385  updatedState().globalMomentum().perp();
386  float pt_in=SmooTjs.lastMeasurement().
387  updatedState().globalMomentum().perp();
388  dpt=(pt_in>0) ? fabs(pt_out-pt_in)/pt_in : 0.;
389  // the following is simply the number of degrees of freedom
390  chiRatio=SmooTjs.chiSquared()/Tj[i].chiSquared();
392 
393  }
394  }
395 
396 
397  //TMVA Analysis
398  if(useTmva_){
399 
400  eta=tketa;
401  pt=tkpt;
402  eP=EP;
403 
404  float Ytmva=reader[ipteta]->EvaluateMVA( method_ );
405 
406  float BDTcut=thr[ibin+5];
407  if ( Ytmva>BDTcut) GoodTkId=true;
408  myPreId.setMVA(GoodTkId,Ytmva);
410  }else{
411 
412  float chiratiocut=thr[ibin+6];
413  float gschicut=thr[ibin+7];
414  float gsptmin=thr[ibin+8];
415 
416  GoodTkId=((dpt>gsptmin)&(chired<gschicut)&(chiRatio<chiratiocut));
417 
418  }
419  }
420 
421  GoodPreId= GoodTkId | GoodMatching;
422 
423  myPreId.setFinalDecision(GoodPreId);
424 
425  if(GoodPreId)
426  LogDebug("GoodSeedProducer")<<"Track (pt= "<<Tk[i].pt()<<
427  "GeV/c, eta= "<<Tk[i].eta() <<
428  ") preidentified for agreement between track and ECAL cluster";
429  if(GoodPreId &&(!GoodMatching))
430  LogDebug("GoodSeedProducer")<<"Track (pt= "<<Tk[i].pt()<<
431  "GeV/c, eta= "<<Tk[i].eta() <<
432  ") preidentified only for track properties";
433 
434  } // end of !disablePreId_
435 
436  if (GoodPreId){
437  //NEW SEED with n hits
438  ElectronSeed NewSeed(Seed);
439  NewSeed.setCtfTrack(trackRef);
440  output_preid->push_back(NewSeed);
441  }else{
442  if (produceCkfseed_){
443  output_nopre->push_back(Seed);
444  }
445  }
446  if(producePreId_ && myPreId.pt()>PtThresholdSavePredId_)
447  {
448  // save the index of the PreId object as to be able to create a Ref later
449  refMap_[trackRef] = output_preidinfo->size();
450  output_preidinfo->push_back(myPreId);
451  }
452  } //end loop on track collection
453  } //end loop on the vector of track collections
454 
455  // no disablePreId_ switch, it is simpler to have an empty collection rather than no collection
456  iEvent.put(output_preid,preidgsf_);
457  if (produceCkfseed_)
458  iEvent.put(output_nopre,preidckf_);
459  if(producePreId_)
460  {
461  const edm::OrphanHandle<reco::PreIdCollection> preIdRefProd = iEvent.put(output_preidinfo,preidname_);
462  // now make the Value Map, but only if one input collection
463  if(tracksContainers_.size()==1)
464  {
465  Handle<TrackCollection> tkRefCollection ;
466  iEvent.getByToken(tracksContainers_[0],tkRefCollection);
467  fillPreIdRefValueMap(tkRefCollection,preIdRefProd,mapFiller);
468  mapFiller.fill();
469  iEvent.put(preIdMap_p,preidname_);
470  }
471  }
472  // clear temporary maps
473  refMap_.clear();
474 }
475 // ------------ method called once each job just before starting event loop ------------
476 void
478  const EventSetup& es)
479 {
480  //Magnetic Field
482  es.get<IdealMagneticFieldRecord>().get(magneticField);
483  B_=magneticField->inTesla(GlobalPoint(0,0,0));
484 
485  pfTransformer_.reset( new PFTrackTransformer(B_) );
486  pfTransformer_->OnlyProp();
487 
488  //Resolution maps
489  FileInPath ecalEtaMap(conf_.getParameter<string>("EtaMap"));
490  FileInPath ecalPhiMap(conf_.getParameter<string>("PhiMap"));
491  resMapEtaECAL_.reset( new PFResolutionMap("ECAL_eta",ecalEtaMap.fullPath().c_str()) );
492  resMapPhiECAL_.reset( new PFResolutionMap("ECAL_phi",ecalPhiMap.fullPath().c_str()) );
493 
494  if(useTmva_){
495  method_ = conf_.getParameter<string>("TMVAMethod");
496  FileInPath Weigths1(conf_.getParameter<string>("Weights1"));
497  FileInPath Weigths2(conf_.getParameter<string>("Weights2"));
498  FileInPath Weigths3(conf_.getParameter<string>("Weights3"));
499  FileInPath Weigths4(conf_.getParameter<string>("Weights4"));
500  FileInPath Weigths5(conf_.getParameter<string>("Weights5"));
501  FileInPath Weigths6(conf_.getParameter<string>("Weights6"));
502  FileInPath Weigths7(conf_.getParameter<string>("Weights7"));
503  FileInPath Weigths8(conf_.getParameter<string>("Weights8"));
504  FileInPath Weigths9(conf_.getParameter<string>("Weights9"));
505 
506  for(UInt_t j = 0; j < 9; ++j){
507  reader[j].reset( new TMVA::Reader("!Color:Silent"));
508 
509  reader[j]->AddVariable("NHits", &nhit);
510  reader[j]->AddVariable("NormChi", &chikfred);
511  reader[j]->AddVariable("dPtGSF", &dpt);
512  reader[j]->AddVariable("EoP", &eP);
513  reader[j]->AddVariable("ChiRatio", &chiRatio);
514  reader[j]->AddVariable("RedChi", &chired);
515  reader[j]->AddVariable("EcalDEta", &trk_ecalDeta);
516  reader[j]->AddVariable("EcalDPhi", &trk_ecalDphi);
517  reader[j]->AddVariable("pt", &pt);
518  reader[j]->AddVariable("eta", &eta);
519 
520  if(j==0) reader[j]->BookMVA(method_, Weigths1.fullPath().c_str());
521  if(j==1) reader[j]->BookMVA(method_, Weigths2.fullPath().c_str());
522  if(j==2) reader[j]->BookMVA(method_, Weigths3.fullPath().c_str());
523  if(j==3) reader[j]->BookMVA(method_, Weigths4.fullPath().c_str());
524  if(j==4) reader[j]->BookMVA(method_, Weigths5.fullPath().c_str());
525  if(j==5) reader[j]->BookMVA(method_, Weigths6.fullPath().c_str());
526  if(j==6) reader[j]->BookMVA(method_, Weigths7.fullPath().c_str());
527  if(j==7) reader[j]->BookMVA(method_, Weigths8.fullPath().c_str());
528  if(j==8) reader[j]->BookMVA(method_, Weigths9.fullPath().c_str());
529  }
530  }
531  //read threshold
532  FileInPath parFile(conf_.getParameter<string>("ThresholdFile"));
533  ifstream ifs(parFile.fullPath().c_str());
534  for (int iy=0;iy<81;++iy) ifs >> thr[iy];
535 }
536 
537 int
539  int ie=0;
540  int ip=0;
541  if (fabs(eta)<0.8) ie=0;
542  else{ if (fabs(eta)<1.479) ie=1;
543  else ie=2;
544  }
545  if (pt<6) ip=0;
546  else { if (pt<12) ip=1;
547  else ip=2;
548  }
549  int iep= ie*3+ip;
550  LogDebug("GoodSeedProducer")<<"Track pt ="<<pt<<" eta="<<eta<<" bin="<<iep;
551  return iep;
552 }
553 
555  const edm::OrphanHandle<reco::PreIdCollection>& preidhandle,
557 {
558  std::vector<reco::PreIdRef> values;
559 
560  unsigned ntracks=tracks->size();
561  for(unsigned itrack=0;itrack<ntracks;++itrack)
562  {
563  reco::TrackRef theTrackRef(tracks,itrack);
564  std::map<reco::TrackRef,unsigned>::const_iterator itcheck=refMap_.find(theTrackRef);
565  if(itcheck==refMap_.end())
566  {
567  // the track has been early discarded
568  values.push_back(reco::PreIdRef());
569  }
570  else
571  {
572  edm::Ref<reco::PreIdCollection> preIdRef(preidhandle,itcheck->second);
573  values.push_back(preIdRef);
574  // std::cout << " Checking Refs " << (theTrackRef==preIdRef->trackRef()) << std::endl;
575  }
576  }
577  filler.insert(tracks,values.begin(),values.end());
578 }
579 
#define LogDebug(id)
int nHitsInSeed_
Number of hits in the seed;.
RunNumber_t run() const
Definition: EventID.h:39
const double TwoPi
const double Pi
void setCharge(float q)
set the MEASURED charge
Definition: RawParticle.cc:139
T getParameter(std::string const &) const
EventNumber_t event() const
Definition: EventID.h:41
T getUntrackedParameter(std::string const &, T const &) const
int i
Definition: DBlmapReader.cc:9
void setECALMatchingProperties(PFClusterRef clusterRef, const math::XYZPoint &ecalpos, const math::XYZPoint &meanShower, float deta, float dphi, float chieta, float chiphi, float chi2, float eop)
Definition: PreId.h:38
std::vector< reco::PreId > PreIdCollection
Definition: PreIdFwd.h:6
std::string preidckf_
Name of the Seed(Ckf) Collection.
edm::EDGetTokenT< reco::PFClusterCollection > pfCLusTagPSLabel_
bool getByToken(EDGetToken token, Handle< PROD > &result) const
Definition: Event.h:449
std::array< std::unique_ptr< TMVA::Reader >, 9 > reader
READER FOR TMVA.
#define DEFINE_FWK_MODULE(type)
Definition: MakerMacros.h:17
float eP
VARIABLES NEEDED FOR TMVA.
std::unique_ptr< TrajectorySmoother > smoother_
Smoother.
void insert(const H &h, I begin, I end)
Definition: ValueMap.h:52
Global3DPoint GlobalPoint
Definition: GlobalPoint.h:10
std::unique_ptr< PFResolutionMap > resMapEtaECAL_
std::vector< Track > TrackCollection
collection of Tracks
Definition: TrackFwd.h:13
T y() const
Definition: PV3DBase.h:63
double EcalStripSumE_minClusEnergy_
float thr[150]
vector of thresholds for different bins of eta and pt
T perp2() const
Definition: PV3DBase.h:71
T eta() const
#define nullptr
#define constexpr
float float float z
TkClonerImpl hitCloner
void setCtfTrack(const CtfTrackRef &)
Set additional info.
Definition: ElectronSeed.cc:64
EDGetTokenT< ProductType > consumes(edm::InputTag const &tag)
void setTrack(reco::TrackRef trackref)
Definition: PreId.h:34
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:29
int getBin(float, float)
Find the bin in pt and eta.
int iEvent
Definition: GenABIO.cc:230
std::unique_ptr< TrajectoryFitter > fitter_
Fitter.
edm::ParameterSet conf_
void setMVA(bool accepted, float mva, unsigned n=0)
Definition: PreId.h:72
std::string method_
TMVA method.
double EcalStripSumE_deltaEta_
double EcalStripSumE_deltaPhiOverQ_minValue_
std::vector< TrajectorySeed > TrajectorySeedCollection
double EcalStripSumE_deltaPhiOverQ_maxValue_
void setTrackFiltering(bool accepted, unsigned n=0)
Definition: PreId.h:68
virtual void produce(edm::Event &, const edm::EventSetup &) override
OrphanHandle< PROD > put(std::auto_ptr< PROD > product)
Put a new product.
Definition: Event.h:113
string unit
Definition: csvLumiCalc.py:46
T sqrt(T t)
Definition: SSEVec.h:48
edm::Ref< PFClusterCollection > PFClusterRef
persistent reference to PFCluster objects
Definition: PFClusterFwd.h:15
math::XYZVector B_
B field.
std::string preidname_
Name of the preid Collection (FB)
TrajectoryMeasurement const & lastMeasurement() const
Definition: Trajectory.h:181
T z() const
Definition: PV3DBase.h:64
TypeLabelItem const & produces()
declare what type of product will make and with which optional label
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
int j
Definition: DBlmapReader.cc:9
bool useQuality_
TRACK QUALITY.
void fillPreIdRefValueMap(edm::Handle< reco::TrackCollection > tkhandle, const edm::OrphanHandle< reco::PreIdCollection > &, edm::ValueMap< reco::PreIdRef >::Filler &filler)
double f[11][100]
double minPt_
Minimum transverse momentum and maximum pseudorapidity.
std::string fitterName_
std::vector< ElectronSeed > ElectronSeedCollection
collection of ElectronSeed objects
bool disablePreId_
switch to disable the pre-id
ROOT::Math::DisplacementVector3D< ROOT::Math::Cartesian3D< float > > XYZVectorF
spatial vector with cartesian internal representation
Definition: Vector3D.h:17
virtual void beginRun(const edm::Run &run, const edm::EventSetup &) override
reco::TrackBase::TrackQuality trackQuality_
double clusThreshold_
Cut on the energy of the clusters.
TrackingRecHit::ConstRecHitContainer ConstRecHitContainer
Definition: Trajectory.h:47
tuple tags
Definition: o2o.py:248
bool produceCkfseed_
Produce the Seed for Ckf tracks?
bool isValid() const
Definition: Trajectory.h:269
TrajectoryMeasurement const & firstMeasurement() const
Definition: Trajectory.h:194
float pt() const
Definition: PreId.h:92
T const * product() const
Definition: Handle.h:81
bool useTmva_
USE OF TMVA.
tuple tracks
Definition: testEve_cfg.py:39
std::unique_ptr< PFResolutionMap > resMapPhiECAL_
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12
const T & get() const
Definition: EventSetup.h:55
T const * product() const
Definition: ESHandle.h:86
float chiSquared() const
Definition: Trajectory.h:252
std::vector< edm::EDGetTokenT< reco::TrackCollection > > tracksContainers_
std::vector< std::vector< double > > tmp
Definition: MVATrainer.cc:100
void setTrackProperties(float newchi2, float chi2ratio, float dpt)
Definition: PreId.h:50
edm::EventID id() const
Definition: EventBase.h:60
void setECALMatching(bool accepted, unsigned n=0)
Definition: PreId.h:60
std::map< reco::TrackRef, unsigned > refMap_
Map used to create the TrackRef, PreIdRef value map.
bool producePreId_
Produce the pre-id debugging collection.
std::unique_ptr< PFTrackTransformer > pfTransformer_
PFTrackTransformer.
GoodSeedProducer(const edm::ParameterSet &)
std::string trackerRecHitBuilderName_
std::string smootherName_
edm::EDGetTokenT< reco::PFClusterCollection > pfCLusTagHCLabel_
std::string fullPath() const
Definition: FileInPath.cc:165
Definition: DDAxes.h:10
Resolution Map (resolution as a function of eta and E)
T x() const
Definition: PV3DBase.h:62
std::string preidgsf_
Name of the Seed(Gsf) Collection.
edm::EDGetTokenT< reco::PFClusterCollection > pfCLusTagECLabel_
double minEp_
Min and MAx allowed values forEoverP.
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:40
std::vector< edm::EDGetTokenT< std::vector< Trajectory > > > trajContainers_
Definition: Run.h:41
double PtThresholdSavePredId_
Threshold to save Pre Idinfo.
Global3DVector GlobalVector
Definition: GlobalVector.h:10
void setFinalDecision(bool accepted, unsigned n=0)
Definition: PreId.h:56
math::XYZTLorentzVector XYZTLorentzVector
Definition: RawParticle.h:15