CMS 3D CMS Logo

 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Properties Friends Macros Pages
List of all members | Public Types | Public Member Functions | Private Member Functions | Private Attributes
TCTauAlgorithm Class Reference

#include <TCTauAlgorithm.h>

Public Types

enum  {
  TCAlgoUndetermined, TCAlgoMomentum, TCAlgoTrackProblem, TCAlgoMomentumECAL,
  TCAlgoCaloJet, TCAlgoHadronicJet
}
 

Public Member Functions

int algoComponent ()
 
int allTauCandidates ()
 
double efficiency ()
 
void eventSetup (const edm::Event &, const edm::EventSetup &)
 
void inputConfig (const edm::ParameterSet &iConfig)
 
math::XYZTLorentzVector recalculateEnergy (const reco::CaloTau &)
 
math::XYZTLorentzVector recalculateEnergy (const reco::CaloJet &, const reco::TrackRef &, const reco::TrackRefVector &)
 
int statistics ()
 
 TCTauAlgorithm ()
 
 TCTauAlgorithm (const edm::ParameterSet &)
 
 ~TCTauAlgorithm ()
 

Private Member Functions

math::XYZVector getCellMomentum (const CaloCellGeometry *, double &)
 
std::pair< math::XYZVector,
math::XYZVector
getClusterEnergy (const reco::CaloJet &, math::XYZVector &, double)
 
void init ()
 
math::XYZVector trackEcalHitPoint (const reco::TransientTrack &, const reco::CaloJet &)
 
math::XYZVector trackEcalHitPoint (const reco::Track &)
 

Private Attributes

int algoComponentUsed
 
int all
 
bool dropCaloJets
 
bool dropRejected
 
const CaloSubdetectorGeometryEB
 
edm::Handle< EBRecHitCollectionEBRecHits
 
double ecalCone
 
edm::InputTag EcalRecHitsEB_input
 
edm::InputTag EcalRecHitsEE_input
 
const CaloSubdetectorGeometryEE
 
edm::Handle< EERecHitCollectionEERecHits
 
double etCaloOverTrackMax
 
double etCaloOverTrackMin
 
double etHcalOverTrackMax
 
double etHcalOverTrackMin
 
const edm::Eventevent
 
const CaloSubdetectorGeometryHB
 
edm::Handle< HBHERecHitCollectionHBHERecHits
 
edm::InputTag HBHERecHits_input
 
const CaloSubdetectorGeometryHE
 
const CaloSubdetectorGeometryHF
 
edm::Handle< HFRecHitCollectionHFRecHits
 
edm::InputTag HFRecHits_input
 
const CaloSubdetectorGeometryHO
 
edm::Handle< HORecHitCollectionHORecHits
 
edm::InputTag HORecHits_input
 
int passed
 
int prongs
 
const edm::EventSetupsetup
 
double signalCone
 
TrackDetectorAssociatortrackAssociator
 
TrackAssociatorParameters trackAssociatorParameters
 
const TransientTrackBuildertransientTrackBuilder
 

Detailed Description

Definition at line 45 of file TCTauAlgorithm.h.

Member Enumeration Documentation

anonymous enum

Constructor & Destructor Documentation

TCTauAlgorithm::TCTauAlgorithm ( )

Definition at line 15 of file TCTauAlgorithm.cc.

References init.

15  {
16  init();
17 }
TCTauAlgorithm::TCTauAlgorithm ( const edm::ParameterSet iConfig)

Definition at line 19 of file TCTauAlgorithm.cc.

References init.

19  {
20  init();
21  inputConfig(iConfig);
22 }
void inputConfig(const edm::ParameterSet &iConfig)
TCTauAlgorithm::~TCTauAlgorithm ( )

Definition at line 24 of file TCTauAlgorithm.cc.

24 {}

Member Function Documentation

int TCTauAlgorithm::algoComponent ( )

Definition at line 76 of file TCTauAlgorithm.cc.

Referenced by TCTauCorrector::algoComponent().

76  {
77  return algoComponentUsed;
78 }
int TCTauAlgorithm::allTauCandidates ( )

Definition at line 72 of file TCTauAlgorithm.cc.

References cond::ecalcond::all.

Referenced by TCTauCorrector::allTauCandidates().

72  {
73  return all;
74 }
double TCTauAlgorithm::efficiency ( )

Definition at line 64 of file TCTauAlgorithm.cc.

References cond::ecalcond::all.

Referenced by TCTauCorrector::efficiency().

64  {
65  return double(passed)/all;
66 }
void TCTauAlgorithm::eventSetup ( const edm::Event iEvent,
const edm::EventSetup iSetup 
)

Definition at line 80 of file TCTauAlgorithm.cc.

References egHLT::errCodes::EBRecHits, DetId::Ecal, EcalBarrel, EcalEndcap, egHLT::errCodes::EERecHits, geometry, edm::EventSetup::get(), edm::Event::getByLabel(), egHLT::errCodes::HBHERecHits, DetId::Hcal, HcalBarrel, HcalEndcap, HcalForward, HcalOuter, egHLT::errCodes::HFRecHits, iEvent, and edm::ESHandle< class >::product().

Referenced by TCTauCorrector::eventSetup().

80  {
81 
82  event = &iEvent;
83  setup = &iSetup;
84 
86  iSetup.get<TransientTrackRecord>().get("TransientTrackBuilder",builder);
87  transientTrackBuilder = builder.product();
88 
89  // geometry initialization
91  iSetup.get<CaloGeometryRecord>().get(geometry);
92 
93 
94  EB = geometry->getSubdetectorGeometry(DetId::Ecal,EcalBarrel);
95  EE = geometry->getSubdetectorGeometry(DetId::Ecal,EcalEndcap);
96  HB = geometry->getSubdetectorGeometry(DetId::Hcal,HcalBarrel);
97  HE = geometry->getSubdetectorGeometry(DetId::Hcal,HcalEndcap);
98  HO = geometry->getSubdetectorGeometry(DetId::Hcal,HcalOuter);
99  HF = geometry->getSubdetectorGeometry(DetId::Hcal,HcalForward);
100 
101  //hits
104 
108 }
edm::Handle< HORecHitCollection > HORecHits
const edm::EventSetup * setup
const CaloSubdetectorGeometry * HO
const CaloSubdetectorGeometry * HE
const CaloSubdetectorGeometry * EB
int iEvent
Definition: GenABIO.cc:243
edm::InputTag EcalRecHitsEB_input
edm::Handle< HBHERecHitCollection > HBHERecHits
const CaloSubdetectorGeometry * HF
const CaloSubdetectorGeometry * EE
bool getByLabel(InputTag const &tag, Handle< PROD > &result) const
Definition: Event.h:359
edm::InputTag HBHERecHits_input
edm::Handle< EERecHitCollection > EERecHits
const T & get() const
Definition: EventSetup.h:55
T const * product() const
Definition: ESHandle.h:62
const TransientTrackBuilder * transientTrackBuilder
edm::InputTag HORecHits_input
ESHandle< TrackerGeometry > geometry
edm::Handle< HFRecHitCollection > HFRecHits
edm::InputTag EcalRecHitsEE_input
edm::InputTag HFRecHits_input
edm::Handle< EBRecHitCollection > EBRecHits
const CaloSubdetectorGeometry * HB
XYZVector TCTauAlgorithm::getCellMomentum ( const CaloCellGeometry cell,
double &  energy 
)
private

Definition at line 354 of file TCTauAlgorithm.cc.

References funct::cos(), CaloCellGeometry::getPosition(), phi, PV3DBase< T, PVType, FrameType >::phi(), funct::sin(), PV3DBase< T, PVType, FrameType >::theta(), and theta().

354  {
355  XYZVector momentum(0,0,0);
356  if(cell){
357  GlobalPoint hitPosition = cell->getPosition();
358 
359  double phi = hitPosition.phi();
360  double theta = hitPosition.theta();
361  if(theta > 3.14159) theta = 2*3.14159 - theta;
362  double px = energy * sin(theta)*cos(phi);
363  double py = energy * sin(theta)*sin(phi);
364  double pz = energy * cos(theta);
365 
366  momentum = XYZVector(px,py,pz);
367  }
368  return momentum;
369 }
Sin< T >::type sin(const T &t)
Definition: Sin.h:22
Geom::Phi< T > phi() const
Definition: PV3DBase.h:63
Geom::Theta< T > theta() const
Geom::Theta< T > theta() const
Definition: PV3DBase.h:69
Cos< T >::type cos(const T &t)
Definition: Cos.h:22
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:31
const GlobalPoint & getPosition() const
Definition: DDAxes.h:10
std::pair< XYZVector, XYZVector > TCTauAlgorithm::getClusterEnergy ( const reco::CaloJet ,
math::XYZVector ,
double   
)
private

Definition at line 254 of file TCTauAlgorithm.cc.

References DetId::det(), egHLT::errCodes::EBRecHits, DetId::Ecal, egHLT::errCodes::EERecHits, relval_parameters_module::energy, reco::CaloJet::getCaloConstituents(), egHLT::errCodes::HBHERecHits, DetId::Hcal, HcalBarrel, HcalEndcap, HcalForward, HcalOuter, egHLT::errCodes::HFRecHits, i, j, and DetId::subdetId().

254  {
255 
256  XYZVector ecalCluster(0,0,0);
257  XYZVector hcalCluster(0,0,0);
258 
259  std::vector<CaloTowerPtr> towers = caloJet.getCaloConstituents();
260 
261  for(std::vector<CaloTowerPtr>::const_iterator iTower = towers.begin();
262  iTower!= towers.end(); ++iTower){
263  std::vector<XYZVector> ECALCells;
264  std::vector<XYZVector> HCALCells;
265 
266  size_t numRecHits = (**iTower).constituentsSize();
267 
268  // access CaloRecHits
269  for(size_t j = 0; j < numRecHits; j++) {
270  DetId recHitDetID = (**iTower).constituent(j);
271  //DetId::Detector detNum=recHitDetID.det();
272  if( recHitDetID.det() == DetId::Ecal ){
273  if( recHitDetID.subdetId() == 1 ){ // Ecal Barrel
274  EBDetId ecalID = recHitDetID;
275  EBRecHitCollection::const_iterator theRecHit = EBRecHits->find(ecalID);
276  if(theRecHit != EBRecHits->end()){
277  DetId id = theRecHit->detid();
278  const CaloCellGeometry* this_cell = EB->getGeometry(id);
279  double energy = theRecHit->energy();
280  ECALCells.push_back(getCellMomentum(this_cell,energy));
281  }
282  }
283  if( recHitDetID.subdetId() == 2 ){ // Ecal Endcap
284  EEDetId ecalID = recHitDetID;
285  EERecHitCollection::const_iterator theRecHit = EERecHits->find(ecalID);
286  if(theRecHit != EERecHits->end()){
287  DetId id = theRecHit->detid();
288  const CaloCellGeometry* this_cell = EE->getGeometry(id);
289  double energy = theRecHit->energy();
290  ECALCells.push_back(getCellMomentum(this_cell,energy));
291  }
292  }
293  }
294  if( recHitDetID.det() == DetId::Hcal ){
295  HcalDetId hcalID = recHitDetID;
296  if( recHitDetID.subdetId() == HcalBarrel ){
297  //int depth = hcalID.depth();
298  //if (depth==1){
299  HBHERecHitCollection::const_iterator theRecHit=HBHERecHits->find(hcalID);
300  if(theRecHit != HBHERecHits->end()){
301  DetId id = theRecHit->detid();
302  const CaloCellGeometry* this_cell = HB->getGeometry(id);
303  double energy = theRecHit->energy();
304  HCALCells.push_back(getCellMomentum(this_cell,energy));
305  }
306  //}
307  }
308  if( recHitDetID.subdetId() == HcalEndcap ){
309  //int depth = hcalID.depth();
310  //if (depth==1){
311  HBHERecHitCollection::const_iterator theRecHit=HBHERecHits->find(hcalID);
312  if(theRecHit != HBHERecHits->end()){
313  DetId id = theRecHit->detid();
314  const CaloCellGeometry* this_cell = HE->getGeometry(id);
315  double energy = theRecHit->energy();
316  HCALCells.push_back(getCellMomentum(this_cell,energy));
317  }
318  //}
319  }
320  if( recHitDetID.subdetId() == HcalOuter ){
321  HORecHitCollection::const_iterator theRecHit=HORecHits->find(hcalID);
322  if(theRecHit != HORecHits->end()){
323  DetId id = theRecHit->detid();
324  const CaloCellGeometry* this_cell = HO->getGeometry(id);
325  double energy = theRecHit->energy();
326  HCALCells.push_back(getCellMomentum(this_cell,energy));
327  }
328  }
329  if( recHitDetID.subdetId() == HcalForward ){
330  HFRecHitCollection::const_iterator theRecHit=HFRecHits->find(hcalID);
331  if(theRecHit != HFRecHits->end()){
332  DetId id = theRecHit->detid();
333  const CaloCellGeometry* this_cell = HF->getGeometry(id);
334  double energy = theRecHit->energy();
335  HCALCells.push_back(getCellMomentum(this_cell,energy));
336  }
337  }
338  }
339  }
340 
341  std::vector<XYZVector>::const_iterator i;
342  for(i = ECALCells.begin(); i != ECALCells.end(); ++i) {
343  double DR = ROOT::Math::VectorUtil::DeltaR(trackEcalHitPoint,*i);
344  if( DR < cone ) ecalCluster += *i;
345  }
346  for(i = HCALCells.begin(); i != HCALCells.end(); ++i) {
347  double DR = ROOT::Math::VectorUtil::DeltaR(trackEcalHitPoint,*i);
348  if( DR < cone ) hcalCluster += *i;
349  }
350  }
351  return std::pair<XYZVector,XYZVector> (ecalCluster,hcalCluster);
352 }
int i
Definition: DBlmapReader.cc:9
edm::Handle< HORecHitCollection > HORecHits
std::vector< T >::const_iterator const_iterator
const CaloSubdetectorGeometry * HO
virtual const CaloCellGeometry * getGeometry(const DetId &id) const
Get the cell geometry of a given detector id. Should return false if not found.
math::XYZVector trackEcalHitPoint(const reco::TransientTrack &, const reco::CaloJet &)
const CaloSubdetectorGeometry * HE
const CaloSubdetectorGeometry * EB
edm::Handle< HBHERecHitCollection > HBHERecHits
int j
Definition: DBlmapReader.cc:9
const CaloSubdetectorGeometry * HF
const CaloSubdetectorGeometry * EE
int subdetId() const
get the contents of the subdetector field (not cast into any detector&#39;s numbering enum) ...
Definition: DetId.h:39
math::XYZVector getCellMomentum(const CaloCellGeometry *, double &)
Definition: DetId.h:20
edm::Handle< EERecHitCollection > EERecHits
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:31
edm::Handle< HFRecHitCollection > HFRecHits
Detector det() const
get the detector field from this detid
Definition: DetId.h:37
edm::Handle< EBRecHitCollection > EBRecHits
const CaloSubdetectorGeometry * HB
void TCTauAlgorithm::init ( void  )
private

Definition at line 26 of file TCTauAlgorithm.cc.

References cond::ecalcond::all.

26  {
27 
28  event = 0;
29  setup = 0;
30 
33 
34  all = 0;
35  passed = 0;
36  prongs = -1;
38 }
const edm::EventSetup * setup
void useDefaultPropagator()
use the default propagator
TrackDetectorAssociator * trackAssociator
void TCTauAlgorithm::inputConfig ( const edm::ParameterSet iConfig)

Definition at line 40 of file TCTauAlgorithm.cc.

References edm::ParameterSet::getParameter(), edm::ParameterSet::getUntrackedParameter(), and CrabTask::pset.

Referenced by TCTauCorrector::inputConfig().

40  {
41 
42  etCaloOverTrackMin = iConfig.getParameter<double>("EtCaloOverTrackMin");
43  etCaloOverTrackMax = iConfig.getParameter<double>("EtCaloOverTrackMax");
44  etHcalOverTrackMin = iConfig.getParameter<double>("EtHcalOverTrackMin");
45  etHcalOverTrackMax = iConfig.getParameter<double>("EtHcalOverTrackMax");
46 
47  signalCone = iConfig.getParameter<double>("SignalConeSize");
48  ecalCone = iConfig.getParameter<double>("EcalConeSize");
49 
50  EcalRecHitsEB_input= iConfig.getParameter<edm::InputTag>("EBRecHitCollection");
51  EcalRecHitsEE_input= iConfig.getParameter<edm::InputTag>("EERecHitCollection");
52  HBHERecHits_input = iConfig.getParameter<edm::InputTag>("HBHERecHitCollection");
53  HORecHits_input = iConfig.getParameter<edm::InputTag>("HORecHitCollection");
54  HFRecHits_input = iConfig.getParameter<edm::InputTag>("HFRecHitCollection");
55 
56  edm::ParameterSet pset = iConfig.getParameter<edm::ParameterSet>("TrackAssociatorParameters");
58 
59  dropCaloJets = iConfig.getUntrackedParameter<bool>("DropCaloJets",false);
60  dropRejected = iConfig.getUntrackedParameter<bool>("DropRejectedJets",true);
61 }
double etCaloOverTrackMax
T getParameter(std::string const &) const
T getUntrackedParameter(std::string const &, T const &) const
double etHcalOverTrackMin
double etHcalOverTrackMax
double etCaloOverTrackMin
edm::InputTag EcalRecHitsEB_input
tuple pset
Definition: CrabTask.py:85
edm::InputTag HBHERecHits_input
edm::InputTag HORecHits_input
edm::InputTag EcalRecHitsEE_input
edm::InputTag HFRecHits_input
void loadParameters(const edm::ParameterSet &)
TrackAssociatorParameters trackAssociatorParameters
math::XYZTLorentzVector TCTauAlgorithm::recalculateEnergy ( const reco::CaloTau jet)

Definition at line 111 of file TCTauAlgorithm.cc.

References reco::CaloTau::caloTauTagInfoRef(), edm::Ref< C, T, F >::get(), reco::BaseTau::leadTrack(), reco::LeafCandidate::p4(), and reco::LeafCandidate::setP4().

Referenced by TCTauCorrector::correctedP4(), and TCTauCorrector::correction().

111  {
112 
113  const TrackRef& leadTk = jet.leadTrack();
114 
115  const TrackRefVector associatedTracks = jet.caloTauTagInfoRef()->Tracks();
116 
117  const CaloJet* cJet = jet.caloTauTagInfoRef()->calojetRef().get();
118  CaloJet caloJet = *cJet;
119  caloJet.setP4(jet.p4());
120 
121  return recalculateEnergy(caloJet,leadTk,associatedTracks);
122 }
virtual reco::TrackRef leadTrack() const
Definition: BaseTau.cc:26
Jets made from CaloTowers.
Definition: CaloJet.h:30
virtual void setP4(const LorentzVector &p4)
set 4-momentum
math::XYZTLorentzVector recalculateEnergy(const reco::CaloTau &)
const CaloTauTagInfoRef & caloTauTagInfoRef() const
Definition: CaloTau.cc:29
T const * get() const
Returns C++ pointer to the item.
Definition: Ref.h:239
virtual const LorentzVector & p4() const
four-momentum Lorentz vector
math::XYZTLorentzVector TCTauAlgorithm::recalculateEnergy ( const reco::CaloJet caloJet,
const reco::TrackRef leadTk,
const reco::TrackRefVector associatedTracks 
)

Definition at line 124 of file TCTauAlgorithm.cc.

References cond::ecalcond::all, edm::RefVector< C, T, F >::begin(), edm::RefVector< C, T, F >::end(), reco::LeafCandidate::energy(), edm::Ref< C, T, F >::isNull(), p4, reco::LeafCandidate::p4(), reco::LeafCandidate::px(), reco::LeafCandidate::py(), and reco::LeafCandidate::pz().

124  {
125 
126  all++;
127 
128  math::XYZTLorentzVector p4(0,0,0,0);
130 
131  //if(!dropRejected)
132  p4 = caloJet.p4();
133 
134  if(leadTk.isNull()) return p4;
135 
136  XYZVector momentum(0,0,0);
137  int prongCounter = 0;
139  for(iTrack = associatedTracks.begin(); iTrack!= associatedTracks.end(); ++iTrack){
140  double DR = ROOT::Math::VectorUtil::DeltaR(leadTk->momentum(),(*iTrack)->momentum());
141  if(DR < signalCone) {
142  momentum+=(*iTrack)->momentum();
143  prongCounter++;
144  }
145  }
146  if(momentum.Rho() == 0) return p4;
147 
148  XYZVector ltrackEcalHitPoint = trackEcalHitPoint(*leadTk);
149 
150  if(! (ltrackEcalHitPoint.Rho() > 0 && ltrackEcalHitPoint.Rho() < 9999) ) return p4;
151 
152  std::pair<XYZVector,XYZVector> caloClusters = getClusterEnergy(caloJet,ltrackEcalHitPoint,signalCone);
153  XYZVector EcalCluster = caloClusters.first;
154  XYZVector HcalCluster = caloClusters.second;
155 
156  double eCaloOverTrack = (EcalCluster.R()+HcalCluster.R()-momentum.R())/momentum.R();
157 
158  std::pair<XYZVector,XYZVector> caloClustersPhoton = getClusterEnergy(caloJet,ltrackEcalHitPoint,ecalCone);
159  XYZVector EcalClusterPhoton = caloClustersPhoton.first;
160 
161  math::XYZTLorentzVector p4photons(0,0,0,EcalClusterPhoton.R() - EcalCluster.R());
162 
163  if( eCaloOverTrack > etCaloOverTrackMin && eCaloOverTrack < etCaloOverTrackMax ) {
164 
165  double eHcalOverTrack = (HcalCluster.R()-momentum.R())/momentum.R();
166 
167  if ( eHcalOverTrack > etHcalOverTrackMin && eHcalOverTrack < etHcalOverTrackMax ) {
168  p4.SetXYZT(EcalCluster.X() + momentum.X(),
169  EcalCluster.Y() + momentum.Y(),
170  EcalCluster.Z() + momentum.Z(),
171  EcalCluster.R() + momentum.R());
172  p4 += p4photons;
174  }else{
175  p4.SetXYZT(momentum.X(),
176  momentum.Y(),
177  momentum.Z(),
178  momentum.R());
180  }
181  }
182  if( eCaloOverTrack > etCaloOverTrackMax ) {
183  double eHcalOverTrack = (HcalCluster.R()-momentum.R())/momentum.R();
184 
185  if ( eHcalOverTrack > etHcalOverTrackMin && eHcalOverTrack < etHcalOverTrackMax ) {
186  p4.SetXYZT(EcalCluster.X() + momentum.X(),
187  EcalCluster.Y() + momentum.Y(),
188  EcalCluster.Z() + momentum.Z(),
189  EcalCluster.R() + momentum.R());
190  p4 += p4photons;
192  }
193  if ( eHcalOverTrack < etHcalOverTrackMin ) {
194  if(!dropCaloJets) p4.SetXYZT(caloJet.px(),caloJet.py(),caloJet.pz(),caloJet.energy());
195  else p4.SetXYZT(0,0,0,0);
197  }
198  if ( eHcalOverTrack > etHcalOverTrackMax ) {
200  if(!dropRejected) p4.SetXYZT(caloJet.px(),caloJet.py(),caloJet.pz(),caloJet.energy());
201  else p4.SetXYZT(0,0,0,0);
202  }
203  }
204  if( eCaloOverTrack < etCaloOverTrackMin ) {
206  if(!dropRejected) p4.SetXYZT(caloJet.px(),caloJet.py(),caloJet.pz(),caloJet.energy());
207  }
208 
209  if(p4.Et() > 0) passed++;
210 
211  return p4;
212 }
double etCaloOverTrackMax
double etHcalOverTrackMin
const_iterator end() const
Termination of iteration.
Definition: RefVector.h:242
double etHcalOverTrackMax
const_iterator begin() const
Initialize an iterator over the RefVector.
Definition: RefVector.h:237
math::XYZVector trackEcalHitPoint(const reco::TransientTrack &, const reco::CaloJet &)
double etCaloOverTrackMin
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:30
std::pair< math::XYZVector, math::XYZVector > getClusterEnergy(const reco::CaloJet &, math::XYZVector &, double)
virtual double energy() const
energy
bool isNull() const
Checks for null.
Definition: Ref.h:244
double p4[4]
Definition: TauolaWrapper.h:92
virtual double px() const
x coordinate of momentum vector
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:31
virtual double pz() const
z coordinate of momentum vector
virtual const LorentzVector & p4() const
four-momentum Lorentz vector
virtual double py() const
y coordinate of momentum vector
int TCTauAlgorithm::statistics ( )

Definition at line 68 of file TCTauAlgorithm.cc.

Referenced by TCTauCorrector::statistics().

68  {
69  return passed;
70 }
XYZVector TCTauAlgorithm::trackEcalHitPoint ( const reco::TransientTrack transientTrack,
const reco::CaloJet caloJet 
)
private

Definition at line 215 of file TCTauAlgorithm.cc.

References reco::CaloJet::getCaloConstituents(), TrajectoryStateOnSurface::globalPosition(), reco::TransientTrack::stateOnSurface(), PV3DBase< T, PVType, FrameType >::x(), PV3DBase< T, PVType, FrameType >::y(), and PV3DBase< T, PVType, FrameType >::z().

215  {
216 
217 
218  GlobalPoint ecalHitPosition(0,0,0);
219 
220  double maxTowerEt = 0;
221  std::vector<CaloTowerPtr> towers = caloJet.getCaloConstituents();
222  for(std::vector<CaloTowerPtr>::const_iterator iTower = towers.begin();
223  iTower!= towers.end(); ++iTower){
224  if((*iTower)->et() > maxTowerEt){
225  maxTowerEt = (*iTower)->et();
226  ecalHitPosition = (*iTower)->emPosition();
227  }
228  }
229 
230 
231  XYZVector ecalHitPoint(0,0,0);
232 
233  try{
234  GlobalPoint trackEcalHitPoint = transientTrack.stateOnSurface(ecalHitPosition).globalPosition();
235 
236  ecalHitPoint.SetXYZ(trackEcalHitPoint.x(),
237  trackEcalHitPoint.y(),
238  trackEcalHitPoint.z());
239  }catch(...) {;}
240 
241  return ecalHitPoint;
242 }
T y() const
Definition: PV3DBase.h:57
GlobalPoint globalPosition() const
virtual std::vector< CaloTowerPtr > getCaloConstituents() const
get all constituents
Definition: CaloJet.cc:94
math::XYZVector trackEcalHitPoint(const reco::TransientTrack &, const reco::CaloJet &)
T z() const
Definition: PV3DBase.h:58
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:31
TrajectoryStateOnSurface stateOnSurface(const GlobalPoint &point) const
T x() const
Definition: PV3DBase.h:56
XYZVector TCTauAlgorithm::trackEcalHitPoint ( const reco::Track track)
private

Definition at line 244 of file TCTauAlgorithm.cc.

References event(), info, TrackDetMatchInfo::isGoodEcal, and TrackDetMatchInfo::trkGlobPosAtEcal.

244  {
245 
248  if( info.isGoodEcal != 0 ) {
249  return XYZVector(info.trkGlobPosAtEcal.x(),info.trkGlobPosAtEcal.y(),info.trkGlobPosAtEcal.z());
250  }
251  return XYZVector(0,0,0);
252 }
const edm::EventSetup * setup
static FreeTrajectoryState getFreeTrajectoryState(const edm::EventSetup &, const reco::Track &)
get FreeTrajectoryState from different track representations
const edm::Event * event
TrackDetectorAssociator * trackAssociator
XYZVectorD XYZVector
spatial vector with cartesian internal representation
Definition: Vector3D.h:31
TrackDetMatchInfo associate(const edm::Event &, const edm::EventSetup &, const FreeTrajectoryState &, const AssociatorParameters &)
math::XYZPoint trkGlobPosAtEcal
Track position at different parts of the calorimeter.
TrackAssociatorParameters trackAssociatorParameters

Member Data Documentation

int TCTauAlgorithm::algoComponentUsed
private

Definition at line 89 of file TCTauAlgorithm.h.

int TCTauAlgorithm::all
private

Definition at line 86 of file TCTauAlgorithm.h.

bool TCTauAlgorithm::dropCaloJets
private

Definition at line 93 of file TCTauAlgorithm.h.

bool TCTauAlgorithm::dropRejected
private

Definition at line 94 of file TCTauAlgorithm.h.

const CaloSubdetectorGeometry* TCTauAlgorithm::EB
private

Definition at line 112 of file TCTauAlgorithm.h.

edm::Handle<EBRecHitCollection> TCTauAlgorithm::EBRecHits
private

Definition at line 119 of file TCTauAlgorithm.h.

double TCTauAlgorithm::ecalCone
private

Definition at line 99 of file TCTauAlgorithm.h.

edm::InputTag TCTauAlgorithm::EcalRecHitsEB_input
private

Definition at line 106 of file TCTauAlgorithm.h.

edm::InputTag TCTauAlgorithm::EcalRecHitsEE_input
private

Definition at line 107 of file TCTauAlgorithm.h.

const CaloSubdetectorGeometry* TCTauAlgorithm::EE
private

Definition at line 113 of file TCTauAlgorithm.h.

edm::Handle<EERecHitCollection> TCTauAlgorithm::EERecHits
private

Definition at line 120 of file TCTauAlgorithm.h.

double TCTauAlgorithm::etCaloOverTrackMax
private

Definition at line 101 of file TCTauAlgorithm.h.

double TCTauAlgorithm::etCaloOverTrackMin
private

Definition at line 101 of file TCTauAlgorithm.h.

double TCTauAlgorithm::etHcalOverTrackMax
private

Definition at line 101 of file TCTauAlgorithm.h.

double TCTauAlgorithm::etHcalOverTrackMin
private

Definition at line 101 of file TCTauAlgorithm.h.

const edm::Event* TCTauAlgorithm::event
private

Definition at line 72 of file TCTauAlgorithm.h.

const CaloSubdetectorGeometry* TCTauAlgorithm::HB
private

Definition at line 114 of file TCTauAlgorithm.h.

edm::Handle<HBHERecHitCollection> TCTauAlgorithm::HBHERecHits
private

Definition at line 122 of file TCTauAlgorithm.h.

edm::InputTag TCTauAlgorithm::HBHERecHits_input
private

Definition at line 108 of file TCTauAlgorithm.h.

const CaloSubdetectorGeometry* TCTauAlgorithm::HE
private

Definition at line 115 of file TCTauAlgorithm.h.

const CaloSubdetectorGeometry* TCTauAlgorithm::HF
private

Definition at line 117 of file TCTauAlgorithm.h.

edm::Handle<HFRecHitCollection> TCTauAlgorithm::HFRecHits
private

Definition at line 124 of file TCTauAlgorithm.h.

edm::InputTag TCTauAlgorithm::HFRecHits_input
private

Definition at line 110 of file TCTauAlgorithm.h.

const CaloSubdetectorGeometry* TCTauAlgorithm::HO
private

Definition at line 116 of file TCTauAlgorithm.h.

edm::Handle<HORecHitCollection> TCTauAlgorithm::HORecHits
private

Definition at line 123 of file TCTauAlgorithm.h.

edm::InputTag TCTauAlgorithm::HORecHits_input
private

Definition at line 109 of file TCTauAlgorithm.h.

int TCTauAlgorithm::passed
private

Definition at line 86 of file TCTauAlgorithm.h.

int TCTauAlgorithm::prongs
private

Definition at line 91 of file TCTauAlgorithm.h.

const edm::EventSetup* TCTauAlgorithm::setup
private

Definition at line 73 of file TCTauAlgorithm.h.

Referenced by BeautifulSoup.Tag::_invert().

double TCTauAlgorithm::signalCone
private

Definition at line 98 of file TCTauAlgorithm.h.

TrackDetectorAssociator* TCTauAlgorithm::trackAssociator
private

Definition at line 75 of file TCTauAlgorithm.h.

TrackAssociatorParameters TCTauAlgorithm::trackAssociatorParameters
private

Definition at line 74 of file TCTauAlgorithm.h.

const TransientTrackBuilder* TCTauAlgorithm::transientTrackBuilder
private

Definition at line 96 of file TCTauAlgorithm.h.