CMS 3D CMS Logo

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

#include <EgHLTOffHelper.h>

Public Member Functions

void fillClusShapeData (const reco::GsfElectron &ele, OffEle::ClusShapeData &clusShapeData)
 
void fillClusShapeData (const reco::Photon &pho, OffPho::ClusShapeData &clusShapeData)
 
void fillHLTData (const reco::GsfElectron &ele, OffEle::HLTData &hltData)
 
void fillHLTDataPho (const reco::Photon &pho, OffPho::HLTData &hltData)
 
void fillIsolData (const reco::GsfElectron &ele, OffEle::IsolData &isolData)
 
void fillIsolData (const reco::Photon &pho, OffPho::IsolData &isolData)
 
int fillOffEleVec (std::vector< OffEle > &offEles)
 
int fillOffPhoVec (std::vector< OffPho > &offPhos)
 
int getHandles (const edm::Event &event, const edm::EventSetup &setup)
 
int makeOffEvt (const edm::Event &edmEvent, const edm::EventSetup &setup, egHLT::OffEvt &offEvent)
 
 OffHelper ()
 
int setTrigInfo (const edm::Event &edmEvent, egHLT::OffEvt &offEvent)
 
void setup (const edm::ParameterSet &conf)
 
void setupTriggers (const HLTConfigProvider &config, const std::vector< std::string > &hltFiltersUsed)
 
const std::vector< std::pair
< TrigCodes::TrigBitSet,
OffEgSel > > & 
trigCuts () const
 
const trigger::TriggerEventtrigEvt () const
 
 ~OffHelper ()
 

Static Public Member Functions

template<class T >
static bool getHandle (const edm::Event &event, const edm::InputTag &tag, edm::Handle< T > &handle)
 

Private Member Functions

 OffHelper (const OffHelper &rhs)
 
OffHelperoperator= (const OffHelper &rhs)
 

Private Attributes

edm::Handle< reco::BeamSpotbeamSpot_
 
edm::InputTag beamSpotTag_
 
bool calHLTEleTrkIsol_
 
bool calHLTEmIsol_
 
bool calHLTHcalIsol_
 
bool calHLTPhoTrkIsol_
 
edm::ESHandle< CaloGeometrycaloGeom_
 
edm::InputTag caloJetsTag_
 
edm::ESHandle< CaloTopologycaloTopology_
 
edm::Handle< CaloTowerCollectioncaloTowers_
 
edm::InputTag caloTowersTag_
 
edm::Handle< EcalRecHitCollectionebRecHits_
 
edm::InputTag ecalRecHitsEBTag_
 
edm::InputTag ecalRecHitsEETag_
 
edm::ESHandle
< EcalSeverityLevelAlgo
ecalSeverityLevel_
 
edm::Handle< EcalRecHitCollectioneeRecHits_
 
edm::InputTag electronsTag_
 
OffEgSel eleCuts_
 
OffEgSel eleLooseCuts_
 
edm::Handle< HBHERecHitCollectionhbheHits_
 
edm::InputTag hbheHitsTag_
 
edm::Handle< HFRecHitCollectionhfHits_
 
edm::InputTag hfHitsTag_
 
EgammaHLTTrackIsolationhltEleTrkIsolAlgo_
 
double hltEleTrkIsolInnerCone_
 
double hltEleTrkIsolOuterCone_
 
double hltEleTrkIsolPtMin_
 
double hltEleTrkIsolRSpan_
 
double hltEleTrkIsolZSpan_
 
double hltEMIsolEMinEB_
 
double hltEMIsolEMinEE_
 
double hltEMIsolEtaSliceEB_
 
double hltEMIsolEtaSliceEE_
 
double hltEMIsolEtMinEB_
 
double hltEMIsolEtMinEE_
 
double hltEMIsolInnerConeEB_
 
double hltEMIsolInnerConeEE_
 
double hltEMIsolOuterCone_
 
std::vector< std::string > hltFiltersUsed_
 
std::vector< std::pair
< std::string, int > > 
hltFiltersUsedWithNrCandsCut_
 
int hltHadIsolDepth_
 
double hltHadIsolEtMin_
 
double hltHadIsolInnerCone_
 
double hltHadIsolOuterCone_
 
EgammaHLTTrackIsolationhltPhoTrkIsolAlgo_
 
bool hltPhoTrkIsolCountTrks_
 
double hltPhoTrkIsolInnerCone_
 
double hltPhoTrkIsolOuterCone_
 
double hltPhoTrkIsolPtMin_
 
double hltPhoTrkIsolRSpan_
 
double hltPhoTrkIsolZSpan_
 
std::string hltTag_
 
edm::Handle
< reco::TrackCollection
isolTrks_
 
edm::InputTag isolTrkTag_
 
std::vector< std::pair
< std::string, std::string > > 
l1PreAndSeedFilters_
 
std::vector< std::string > l1PreScaledFilters_
 
std::vector< std::string > l1PreScaledPaths_
 
edm::ESHandle< MagneticFieldmagField_
 
OffEgSel phoCuts_
 
OffEgSel phoLooseCuts_
 
edm::InputTag photonsTag_
 
edm::Handle
< reco::GsfElectronCollection
recoEles_
 
edm::Handle< std::vector
< reco::CaloJet > > 
recoJets_
 
edm::Handle
< reco::PhotonCollection
recoPhos_
 
edm::Handle
< reco::VertexCollection
recoVertices_
 
std::vector< edm::ParameterSettrigCutParams_
 
std::vector< std::pair
< TrigCodes::TrigBitSet,
OffEgSel > > 
trigCuts_
 
edm::Handle
< trigger::TriggerEvent
trigEvt_
 
edm::InputTag triggerSummaryLabel_
 
edm::Handle< edm::TriggerResultstrigResults_
 
edm::InputTag trigResultsTag_
 
edm::InputTag vertexTag_
 

Detailed Description

Definition at line 58 of file EgHLTOffHelper.h.

Constructor & Destructor Documentation

egHLT::OffHelper::OffHelper ( const OffHelper rhs)
inlineprivate

Definition at line 159 of file EgHLTOffHelper.h.

159 {}
egHLT::OffHelper::OffHelper ( )
inline

Definition at line 162 of file EgHLTOffHelper.h.

OffEgSel phoLooseCuts_
OffEgSel eleLooseCuts_
EgammaHLTTrackIsolation * hltPhoTrkIsolAlgo_
#define NULL
Definition: scimark2.h:8
EgammaHLTTrackIsolation * hltEleTrkIsolAlgo_
OffHelper::~OffHelper ( )

Definition at line 30 of file EgHLTOffHelper.cc.

References hltEleTrkIsolAlgo_, and hltPhoTrkIsolAlgo_.

31 {
34 }
EgammaHLTTrackIsolation * hltPhoTrkIsolAlgo_
EgammaHLTTrackIsolation * hltEleTrkIsolAlgo_

Member Function Documentation

void OffHelper::fillClusShapeData ( const reco::GsfElectron ele,
OffEle::ClusShapeData clusShapeData 
)

Definition at line 276 of file EgHLTOffHelper.cc.

References caloGeom_, caloTopology_, EcalClusterTools::covariances(), reco::GsfElectron::e1x5(), egHLT::OffEle::ClusShapeData::e1x5Over5x5, reco::GsfElectron::e2x5Max(), egHLT::OffEle::ClusShapeData::e2x5MaxOver5x5, EcalClusterTools::e3x3(), reco::GsfElectron::e5x5(), ebRecHits_, EcalBarrel, eeRecHits_, EcalClusterTools::localCovariances(), edm::ESHandle< class >::product(), egHLT::OffEle::ClusShapeData::r9, egHLT::OffEle::ClusShapeData::sigmaEtaEta, reco::GsfElectron::sigmaEtaEta(), egHLT::OffEle::ClusShapeData::sigmaIEtaIEta, reco::GsfElectron::sigmaIetaIeta(), egHLT::OffEle::ClusShapeData::sigmaIPhiIPhi, egHLT::OffEle::ClusShapeData::sigmaPhiPhi, mathSSE::sqrt(), DetId::subdetId(), and reco::GsfElectron::superCluster().

Referenced by fillOffEleVec(), and fillOffPhoVec().

277 {
278  clusShapeData.sigmaEtaEta = ele.sigmaEtaEta();
279  clusShapeData.sigmaIEtaIEta = ele.sigmaIetaIeta();
280  double e5x5 = ele.e5x5();
281  if(e5x5!=0.){
282  clusShapeData.e1x5Over5x5 = ele.e1x5()/e5x5;
283  clusShapeData.e2x5MaxOver5x5 = ele.e2x5Max()/e5x5;
284  }else{
285  clusShapeData.e1x5Over5x5 = -1;
286  clusShapeData.e2x5MaxOver5x5 = -1;
287  }
288 
289  //want to calculate r9, sigmaPhiPhi and sigmaIPhiIPhi, have to do old fashioned way
290  const reco::BasicCluster& seedClus = *(ele.superCluster()->seed());
291  const DetId seedDetId = seedClus.hitsAndFractions()[0].first; //note this may not actually be the seed hit but it doesnt matter because all hits will be in the barrel OR endcap
292  if(seedDetId.subdetId()==EcalBarrel){
293  std::vector<float> stdCov = EcalClusterTools::covariances(seedClus,ebRecHits_.product(),caloTopology_.product(),caloGeom_.product());
294  std::vector<float> crysCov = EcalClusterTools::localCovariances(seedClus,ebRecHits_.product(),caloTopology_.product());
295  clusShapeData.sigmaPhiPhi = sqrt(stdCov[2]);
296  clusShapeData.sigmaIPhiIPhi = sqrt(crysCov[2]);
297  if(ele.superCluster()->rawEnergy()!=0.){
298  clusShapeData.r9 = EcalClusterTools::e3x3(seedClus,ebRecHits_.product(),caloTopology_.product()) / ele.superCluster()->rawEnergy();
299  }else clusShapeData.r9 = -1.;
300 
301  }else{
302  std::vector<float> stdCov = EcalClusterTools::covariances(seedClus,eeRecHits_.product(),caloTopology_.product(),caloGeom_.product());
303  std::vector<float> crysCov = EcalClusterTools::localCovariances(seedClus,eeRecHits_.product(),caloTopology_.product());
304  clusShapeData.sigmaPhiPhi = sqrt(stdCov[2]);
305  clusShapeData.sigmaIPhiIPhi = sqrt(crysCov[2]);
306  if(ele.superCluster()->rawEnergy()!=0.){
307  clusShapeData.r9 = EcalClusterTools::e3x3(seedClus,eeRecHits_.product(),caloTopology_.product()) / ele.superCluster()->rawEnergy();
308  }else clusShapeData.r9 = -1.;
309  }
310 }
float e2x5Max() const
Definition: GsfElectron.h:385
static std::vector< float > covariances(const reco::BasicCluster &cluster, const EcalRecHitCollection *recHits, const CaloTopology *topology, const CaloGeometry *geometry, float w0=4.7)
float sigmaIetaIeta() const
Definition: GsfElectron.h:382
static std::vector< float > localCovariances(const reco::BasicCluster &cluster, const EcalRecHitCollection *recHits, const CaloTopology *topology, float w0=4.7)
T sqrt(T t)
Definition: SSEVec.h:48
virtual SuperClusterRef superCluster() const
reference to a SuperCluster
Definition: GsfElectron.h:168
static float e3x3(const reco::BasicCluster &cluster, const EcalRecHitCollection *recHits, const CaloTopology *topology)
int subdetId() const
get the contents of the subdetector field (not cast into any detector&#39;s numbering enum) ...
Definition: DetId.h:39
edm::ESHandle< CaloGeometry > caloGeom_
Definition: DetId.h:20
edm::ESHandle< CaloTopology > caloTopology_
float e1x5() const
Definition: GsfElectron.h:384
T const * product() const
Definition: ESHandle.h:62
edm::Handle< EcalRecHitCollection > eeRecHits_
float e5x5() const
Definition: GsfElectron.h:386
edm::Handle< EcalRecHitCollection > ebRecHits_
float sigmaEtaEta() const
Definition: GsfElectron.h:381
void OffHelper::fillClusShapeData ( const reco::Photon pho,
OffPho::ClusShapeData clusShapeData 
)

Definition at line 417 of file EgHLTOffHelper.cc.

References caloGeom_, caloTopology_, EcalClusterTools::covariances(), reco::Photon::e1x5(), egHLT::OffPho::ClusShapeData::e1x5Over5x5, reco::Photon::e2x5(), egHLT::OffPho::ClusShapeData::e2x5MaxOver5x5, reco::Photon::e5x5(), ebRecHits_, EcalBarrel, eeRecHits_, EcalClusterTools::localCovariances(), edm::ESHandle< class >::product(), egHLT::OffPho::ClusShapeData::r9, reco::Photon::r9(), egHLT::OffPho::ClusShapeData::sigmaEtaEta, reco::Photon::sigmaEtaEta(), egHLT::OffPho::ClusShapeData::sigmaIEtaIEta, reco::Photon::sigmaIetaIeta(), egHLT::OffPho::ClusShapeData::sigmaIPhiIPhi, egHLT::OffPho::ClusShapeData::sigmaPhiPhi, mathSSE::sqrt(), DetId::subdetId(), and reco::Photon::superCluster().

418 {
419  clusShapeData.sigmaEtaEta = pho.sigmaEtaEta();
420  clusShapeData.sigmaIEtaIEta = pho.sigmaIetaIeta();
421  double e5x5 = pho.e5x5();
422  if(e5x5!=0.){ //even though it is almost impossible for this to be 0., this code can never ever crash under any situation
423  clusShapeData.e1x5Over5x5 = pho.e1x5()/e5x5;
424  clusShapeData.e2x5MaxOver5x5 = pho.e2x5()/e5x5;
425  }else{
426  clusShapeData.e1x5Over5x5 = -1;
427  clusShapeData.e2x5MaxOver5x5 = -1;
428  }
429  clusShapeData.r9 = pho.r9();
430 
431  //sigmaPhiPhi and sigmaIPhiIPhi are not in object (and nor should they be) so have to get them old fashioned way
432  //need to figure out if its in the barrel or endcap
433  //get the first hit of the cluster and figure out if its barrel or endcap
434  const reco::BasicCluster& seedClus = *(pho.superCluster()->seed());
435  const DetId seedDetId = seedClus.hitsAndFractions()[0].first; //note this may not actually be the seed hit but it doesnt matter because all hits will be in the barrel OR endcap (it is also incredably inefficient as it getHitsByDetId passes the vector by value not reference
436  if(seedDetId.subdetId()==EcalBarrel){
437  std::vector<float> stdCov = EcalClusterTools::covariances(seedClus,ebRecHits_.product(),caloTopology_.product(),caloGeom_.product());
438  std::vector<float> crysCov = EcalClusterTools::localCovariances(seedClus,ebRecHits_.product(),caloTopology_.product());
439  clusShapeData.sigmaPhiPhi = sqrt(stdCov[2]);
440  clusShapeData.sigmaIPhiIPhi = sqrt(crysCov[2]);
441  }else{
442  std::vector<float> stdCov = EcalClusterTools::covariances(seedClus,eeRecHits_.product(),caloTopology_.product(),caloGeom_.product());
443  std::vector<float> crysCov = EcalClusterTools::localCovariances(seedClus,eeRecHits_.product(),caloTopology_.product());
444 
445  clusShapeData.sigmaPhiPhi = sqrt(stdCov[2]);
446  clusShapeData.sigmaIPhiIPhi = sqrt(crysCov[2]);
447  }
448 }
float e5x5() const
Definition: Photon.h:185
float e1x5() const
Shower shape variables.
Definition: Photon.h:182
reco::SuperClusterRef superCluster() const
Ref to SuperCluster.
Definition: Photon.cc:59
static std::vector< float > covariances(const reco::BasicCluster &cluster, const EcalRecHitCollection *recHits, const CaloTopology *topology, const CaloGeometry *geometry, float w0=4.7)
static std::vector< float > localCovariances(const reco::BasicCluster &cluster, const EcalRecHitCollection *recHits, const CaloTopology *topology, float w0=4.7)
T sqrt(T t)
Definition: SSEVec.h:48
float sigmaIetaIeta() const
Definition: Photon.h:188
float e2x5() const
Definition: Photon.h:183
float sigmaEtaEta() const
Definition: Photon.h:187
int subdetId() const
get the contents of the subdetector field (not cast into any detector&#39;s numbering enum) ...
Definition: DetId.h:39
edm::ESHandle< CaloGeometry > caloGeom_
Definition: DetId.h:20
edm::ESHandle< CaloTopology > caloTopology_
T const * product() const
Definition: ESHandle.h:62
edm::Handle< EcalRecHitCollection > eeRecHits_
edm::Handle< EcalRecHitCollection > ebRecHits_
float r9() const
Definition: Photon.h:191
void OffHelper::fillHLTData ( const reco::GsfElectron ele,
OffEle::HLTData hltData 
)

Definition at line 313 of file EgHLTOffHelper.cc.

References beamSpot_, reco::GsfElectron::closestCtfTrackRef(), SiPixelRawToDigiRegional_cfi::deltaPhi, egHLT::OffEle::HLTData::dEtaIn, egHLT::OffEle::HLTData::dPhiIn, reco::GsfElectron::ecalEnergy(), egHLT::trigTools::fillHLTposition(), hltFiltersUsed_, hltTag_, egHLT::OffEle::HLTData::invEInvP, edm::Ref< C, T, F >::isNonnull(), edm::Handle< T >::product(), reco::GsfElectron::superCluster(), and trigEvt_.

Referenced by fillOffEleVec().

314 {
315  if(ele.closestCtfTrackRef().isNonnull() &&
316  ele.closestCtfTrackRef()->extra().isNonnull()){
317  reco::TrackRef ctfTrack = ele.closestCtfTrackRef();
318  reco::SuperClusterRef scClus = ele.superCluster();
319 
320  //dEta
321  const reco::BeamSpot::Point& bsPos = beamSpot_->position();
322  math::XYZPoint scPosWRTVtx(scClus->x()-bsPos.x(), scClus->y()-bsPos.y() , scClus->z()-ctfTrack->vz());
323  hltData.dEtaIn = fabs(scPosWRTVtx.eta()-ctfTrack->eta());
324 
325  //dPhi: lifted straight from hlt code
326  float deltaPhi=fabs(ctfTrack->outerPosition().phi()-scClus->phi());
327  if(deltaPhi>6.283185308) deltaPhi -= 6.283185308;
328  if(deltaPhi>3.141592654) deltaPhi = 6.283185308-deltaPhi;
329  hltData.dPhiIn = deltaPhi;
330 
331  //invEInvP
332  if(ele.ecalEnergy()!=0 && ctfTrack->p()!=0) hltData.invEInvP= 1/ele.ecalEnergy() - 1/ctfTrack->p();
333  else hltData.invEInvP = 0;
334  }else{
335  hltData.dEtaIn =999;
336  hltData.dPhiIn =999;
337  hltData.invEInvP = 999;
338 
339  }
340 
341  //Now get HLT p4 from triggerobject
343  //trigTools::fillHLTposition(phos(),hltFiltersUsed_,l1PreAndSeedFilters_,evtTrigBits,trigEvt_.product(),hltTag_);
344 }
void fillHLTposition(T &obj, U &hltData, const std::vector< std::string > &filters, const trigger::TriggerEvent *trigEvt, const std::string &hltTag)
math::XYZPoint Point
point in the space
Definition: BeamSpot.h:30
TrackRef closestCtfTrackRef() const
Definition: GsfElectron.h:185
bool isNonnull() const
Checks for non-null.
Definition: Ref.h:250
virtual SuperClusterRef superCluster() const
reference to a SuperCluster
Definition: GsfElectron.h:168
edm::Handle< trigger::TriggerEvent > trigEvt_
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:13
T const * product() const
Definition: Handle.h:74
float ecalEnergy() const
Definition: GsfElectron.h:724
std::vector< std::string > hltFiltersUsed_
edm::Handle< reco::BeamSpot > beamSpot_
std::string hltTag_
void OffHelper::fillHLTDataPho ( const reco::Photon pho,
OffPho::HLTData hltData 
)

Definition at line 347 of file EgHLTOffHelper.cc.

References egHLT::trigTools::fillHLTposition(), hltFiltersUsed_, hltTag_, edm::Handle< T >::product(), and trigEvt_.

Referenced by fillOffPhoVec().

348 {
349  //Now get HLT p4 from triggerobject
351  //trigTools::fillHLTposition(phos(),hltFiltersUsed_,l1PreAndSeedFilters_,evtTrigBits,trigEvt_.product(),hltTag_);
352 }
void fillHLTposition(T &obj, U &hltData, const std::vector< std::string > &filters, const trigger::TriggerEvent *trigEvt, const std::string &hltTag)
edm::Handle< trigger::TriggerEvent > trigEvt_
T const * product() const
Definition: Handle.h:74
std::vector< std::string > hltFiltersUsed_
std::string hltTag_
void OffHelper::fillIsolData ( const reco::GsfElectron ele,
OffEle::IsolData isolData 
)

Definition at line 243 of file EgHLTOffHelper.cc.

References calHLTEleTrkIsol_, calHLTEmIsol_, calHLTHcalIsol_, calHLTPhoTrkIsol_, caloGeom_, caloTowers_, reco::GsfElectron::dr03EcalRecHitSumEt(), reco::GsfElectron::dr03HcalDepth1TowerSumEt(), reco::GsfElectron::dr03HcalDepth2TowerSumEt(), reco::GsfElectron::dr03TkSumPt(), ebRecHits_, DetId::Ecal, ecalSeverityLevel_, eeRecHits_, EgammaHLTTrackIsolation::electronPtSum(), egHLT::OffEle::IsolData::em, reco::GsfElectron::gsfTrack(), egHLT::OffEle::IsolData::hadDepth1, egHLT::OffEle::IsolData::hadDepth2, hltEleTrkIsolAlgo_, egHLT::OffEle::IsolData::hltEm, hltEMIsolEMinEB_, hltEMIsolEMinEE_, hltEMIsolEtaSliceEB_, hltEMIsolEtaSliceEE_, hltEMIsolEtMinEB_, hltEMIsolEtMinEE_, hltEMIsolInnerConeEB_, hltEMIsolInnerConeEE_, hltEMIsolOuterCone_, egHLT::OffEle::IsolData::hltHad, hltHadIsolDepth_, hltHadIsolEtMin_, hltHadIsolInnerCone_, hltHadIsolOuterCone_, hltPhoTrkIsolAlgo_, hltPhoTrkIsolCountTrks_, egHLT::OffEle::IsolData::hltTrksEle, egHLT::OffEle::IsolData::hltTrksPho, isolTrks_, egHLT::OffEle::IsolData::nrTrks, EgammaHLTTrackIsolation::photonPtSum(), EgammaHLTTrackIsolation::photonTrackCount(), edm::Handle< T >::product(), edm::ESHandle< class >::product(), and egHLT::OffEle::IsolData::ptTrks.

Referenced by fillOffEleVec(), and fillOffPhoVec().

244 {
252 
253  isolData.ptTrks=ele.dr03TkSumPt();
254  isolData.nrTrks=999; //no longer supported
255  isolData.em= ele.dr03EcalRecHitSumEt();
256  isolData.hadDepth1 = ele.dr03HcalDepth1TowerSumEt();
257  isolData.hadDepth2 = ele.dr03HcalDepth2TowerSumEt();
258 
259  //now time to do the HLT algos
260  if(calHLTHcalIsol_) isolData.hltHad=hcalIsolAlgo.getTowerESum(&ele);
261  else isolData.hltHad = 0.;
263  else isolData.hltTrksEle = 0.;
264  if(calHLTPhoTrkIsol_){
266  else isolData.hltTrksPho=hltPhoTrkIsolAlgo_->photonPtSum(&ele,isolTrks_.product(),false);
267  }
268  else isolData.hltTrksPho = 0.;
269  if(calHLTEmIsol_) isolData.hltEm = ecalIsolAlgoEB.getEtSum(&ele) +
270  ecalIsolAlgoEE.getEtSum(&ele);
271  else isolData.hltEm = 0.;
272 
273 }
double hltEMIsolEtaSliceEB_
edm::Handle< reco::TrackCollection > isolTrks_
double hltEMIsolOuterCone_
EgammaHLTTrackIsolation * hltPhoTrkIsolAlgo_
int photonTrackCount(const reco::RecoCandidate *const recocand, const reco::TrackCollection *isoTracks, bool useVertex)
float dr03HcalDepth2TowerSumEt() const
Definition: GsfElectron.h:439
double hltEMIsolInnerConeEE_
double hltHadIsolInnerCone_
float electronPtSum(const reco::Track *const tr, const reco::TrackCollection *isoTracks)
Get Pt sum of tracks inside an isolation cone for electrons.
double hltHadIsolOuterCone_
float dr03TkSumPt() const
Definition: GsfElectron.h:436
float dr03HcalDepth1TowerSumEt() const
Definition: GsfElectron.h:438
edm::ESHandle< CaloGeometry > caloGeom_
double hltEMIsolEtaSliceEE_
double hltEMIsolInnerConeEB_
T const * product() const
Definition: ESHandle.h:62
T const * product() const
Definition: Handle.h:74
float dr03EcalRecHitSumEt() const
Definition: GsfElectron.h:437
edm::Handle< EcalRecHitCollection > eeRecHits_
edm::Handle< CaloTowerCollection > caloTowers_
edm::Handle< EcalRecHitCollection > ebRecHits_
edm::ESHandle< EcalSeverityLevelAlgo > ecalSeverityLevel_
EgammaHLTTrackIsolation * hltEleTrkIsolAlgo_
float photonPtSum(const reco::RecoCandidate *const recocand, const reco::TrackCollection *isoTracks, bool useVertex)
virtual GsfTrackRef gsfTrack() const
reference to a GsfTrack
Definition: GsfElectron.h:169
void OffHelper::fillIsolData ( const reco::Photon pho,
OffPho::IsolData isolData 
)

Definition at line 388 of file EgHLTOffHelper.cc.

References calHLTEmIsol_, calHLTHcalIsol_, calHLTPhoTrkIsol_, caloGeom_, caloTowers_, ebRecHits_, DetId::Ecal, reco::Photon::ecalRecHitSumEtConeDR03(), ecalSeverityLevel_, egHLT::OffPho::IsolData::em, egHLT::OffPho::IsolData::had, reco::Photon::hcalTowerSumEtConeDR03(), egHLT::OffPho::IsolData::hltEm, hltEMIsolEMinEB_, hltEMIsolEMinEE_, hltEMIsolEtaSliceEB_, hltEMIsolEtaSliceEE_, hltEMIsolEtMinEB_, hltEMIsolEtMinEE_, hltEMIsolInnerConeEB_, hltEMIsolInnerConeEE_, hltEMIsolOuterCone_, egHLT::OffPho::IsolData::hltHad, hltHadIsolDepth_, hltHadIsolEtMin_, hltHadIsolInnerCone_, hltHadIsolOuterCone_, hltPhoTrkIsolAlgo_, hltPhoTrkIsolCountTrks_, egHLT::OffPho::IsolData::hltTrks, isolTrks_, egHLT::OffPho::IsolData::nrTrks, reco::Photon::nTrkHollowConeDR03(), EgammaHLTTrackIsolation::photonPtSum(), EgammaHLTTrackIsolation::photonTrackCount(), edm::Handle< T >::product(), edm::ESHandle< class >::product(), egHLT::OffPho::IsolData::ptTrks, and reco::Photon::trkSumPtHollowConeDR03().

389 {
397 
398  isolData.nrTrks = pho.nTrkHollowConeDR03();
399  isolData.ptTrks = pho.trkSumPtHollowConeDR03();
400  isolData.em = pho.ecalRecHitSumEtConeDR03();
401  isolData.had = pho.hcalTowerSumEtConeDR03();
402 
403  //now calculate hlt algos
404  if(calHLTHcalIsol_) isolData.hltHad=hcalIsolAlgo.getTowerESum(&pho);
405  else isolData.hltHad = 0.;
406  if(calHLTPhoTrkIsol_){
408  else isolData.hltTrks=hltPhoTrkIsolAlgo_->photonPtSum(&pho,isolTrks_.product(),false);
409  }
410  else isolData.hltTrks = 0.;
411  if(calHLTEmIsol_) isolData.hltEm = ecalIsolAlgoEB.getEtSum(&pho) +
412  ecalIsolAlgoEE.getEtSum(&pho);
413  else isolData.hltEm = 0.;
414 
415 }
double hltEMIsolEtaSliceEB_
edm::Handle< reco::TrackCollection > isolTrks_
float hcalTowerSumEtConeDR03() const
Hcal isolation sum.
Definition: Photon.h:363
double hltEMIsolOuterCone_
EgammaHLTTrackIsolation * hltPhoTrkIsolAlgo_
int photonTrackCount(const reco::RecoCandidate *const recocand, const reco::TrackCollection *isoTracks, bool useVertex)
float trkSumPtHollowConeDR03() const
Definition: Photon.h:377
double hltEMIsolInnerConeEE_
double hltHadIsolInnerCone_
double hltHadIsolOuterCone_
int nTrkHollowConeDR03() const
Definition: Photon.h:381
edm::ESHandle< CaloGeometry > caloGeom_
double hltEMIsolEtaSliceEE_
double hltEMIsolInnerConeEB_
T const * product() const
Definition: ESHandle.h:62
T const * product() const
Definition: Handle.h:74
float ecalRecHitSumEtConeDR03() const
Isolation variables in cone dR=0.3.
Definition: Photon.h:361
edm::Handle< CaloTowerCollection > caloTowers_
edm::Handle< EcalRecHitCollection > ebRecHits_
edm::ESHandle< EcalSeverityLevelAlgo > ecalSeverityLevel_
float photonPtSum(const reco::RecoCandidate *const recocand, const reco::TrackCollection *isoTracks, bool useVertex)
int OffHelper::fillOffEleVec ( std::vector< OffEle > &  offEles)

Definition at line 202 of file EgHLTOffHelper.cc.

References eleCuts_, eleLooseCuts_, fillClusShapeData(), fillHLTData(), fillIsolData(), egHLT::OffEgSel::getCutCode(), i, egHLT::OffEle::EventData::NVertex, egHLT::errCodes::OffEle, recoEles_, recoVertices_, egHLT::OffEle::setCutCode(), egHLT::OffEle::setLooseCutCode(), egHLT::OffEle::setTrigCutsCutCodes(), mathSSE::sqrt(), and trigCuts_.

Referenced by makeOffEvt().

203 {
204  egHLTOffEles.clear();
205  egHLTOffEles.reserve(recoEles_->size());
206  for(reco::GsfElectronCollection::const_iterator gsfIter=recoEles_->begin(); gsfIter!=recoEles_->end();++gsfIter){
207  if(!gsfIter->ecalDrivenSeed()) continue; //avoid PF electrons (this is Eg HLT validation and HLT is ecal driven)
208 
209  int nVertex=0;
210  for(reco::VertexCollection::const_iterator nVit=recoVertices_->begin(); nVit!=recoVertices_->end();++nVit){
211  if( !nVit->isFake()
212  && nVit->ndof()>4
213  && std::fabs( nVit->z()<24.0)
214  && sqrt(nVit->x()*nVit->x() + nVit->y()*nVit->y())<2.0){nVertex++;}
215  }
216  //if(nVertex>20)std::cout<<"nVertex: "<<nVertex<<std::endl;
217  OffEle::EventData eventData;
218  eventData.NVertex=nVertex;
219 
220  OffEle::IsolData isolData;
221  fillIsolData(*gsfIter,isolData);
222 
223  OffEle::ClusShapeData clusShapeData;
224  fillClusShapeData(*gsfIter,clusShapeData);
225 
226  OffEle::HLTData hltData;
227  fillHLTData(*gsfIter,hltData);
228 
229  egHLTOffEles.push_back(OffEle(*gsfIter,clusShapeData,isolData,hltData,eventData));
230 
231  //now we would like to set the cut results
232  OffEle& ele = egHLTOffEles.back();
233  ele.setCutCode(eleCuts_.getCutCode(ele));
235 
236  std::vector<std::pair<TrigCodes::TrigBitSet,int> >trigCutsCutCodes;
237  for(size_t i=0;i<trigCuts_.size();i++) trigCutsCutCodes.push_back(std::make_pair(trigCuts_[i].first,trigCuts_[i].second.getCutCode(ele)));
238  ele.setTrigCutsCutCodes(trigCutsCutCodes);
239  }//end loop over gsf electron collection
240  return 0;
241 }
int i
Definition: DBlmapReader.cc:9
void setTrigCutsCutCodes(const std::vector< std::pair< TrigCodes::TrigBitSet, int > > trigCutsCutCodes)
Definition: EgHLTOffEle.h:111
void setLooseCutCode(int code)
Definition: EgHLTOffEle.h:109
void fillClusShapeData(const reco::GsfElectron &ele, OffEle::ClusShapeData &clusShapeData)
std::vector< std::pair< TrigCodes::TrigBitSet, OffEgSel > > trigCuts_
int getCutCode(const OffEle &ele, int cutMask=~0x0) const
OffEgSel eleLooseCuts_
void fillIsolData(const reco::GsfElectron &ele, OffEle::IsolData &isolData)
void fillHLTData(const reco::GsfElectron &ele, OffEle::HLTData &hltData)
T sqrt(T t)
Definition: SSEVec.h:48
void setCutCode(int code)
Definition: EgHLTOffEle.h:108
edm::Handle< reco::GsfElectronCollection > recoEles_
edm::Handle< reco::VertexCollection > recoVertices_
int OffHelper::fillOffPhoVec ( std::vector< OffPho > &  offPhos)

Definition at line 358 of file EgHLTOffHelper.cc.

References fillClusShapeData(), fillHLTDataPho(), fillIsolData(), egHLT::OffEgSel::getCutCode(), i, egHLT::errCodes::OffPho, phoCuts_, phoLooseCuts_, recoPhos_, egHLT::OffPho::setCutCode(), egHLT::OffPho::setLooseCutCode(), egHLT::OffPho::setTrigCutsCutCodes(), and trigCuts_.

Referenced by makeOffEvt().

359 {
360  egHLTOffPhos.clear();
361  egHLTOffPhos.reserve(recoPhos_->size());
362  for(reco::PhotonCollection::const_iterator phoIter=recoPhos_->begin(); phoIter!=recoPhos_->end();++phoIter){
363 
364  OffPho::IsolData isolData;
365  OffPho::ClusShapeData clusShapeData;
366 
367  fillIsolData(*phoIter,isolData);
368  fillClusShapeData(*phoIter,clusShapeData);
369 
370  OffPho::HLTData hltData;
371  fillHLTDataPho(*phoIter,hltData);
372 
373  egHLTOffPhos.push_back(OffPho(*phoIter,clusShapeData,isolData,hltData));
374  OffPho& pho = egHLTOffPhos.back();
375  pho.setCutCode(phoCuts_.getCutCode(pho));
377 
378  std::vector<std::pair<TrigCodes::TrigBitSet,int> >trigCutsCutCodes;
379  for(size_t i=0;i<trigCuts_.size();i++) trigCutsCutCodes.push_back(std::make_pair(trigCuts_[i].first,trigCuts_[i].second.getCutCode(pho)));
380  pho.setTrigCutsCutCodes(trigCutsCutCodes);
381 
382 
383  }//end loop over photon collection
384  return 0;
385 }
int i
Definition: DBlmapReader.cc:9
void setTrigCutsCutCodes(const std::vector< std::pair< TrigCodes::TrigBitSet, int > > trigCutsCutCodes)
Definition: EgHLTOffPho.h:95
OffEgSel phoLooseCuts_
void fillClusShapeData(const reco::GsfElectron &ele, OffEle::ClusShapeData &clusShapeData)
edm::Handle< reco::PhotonCollection > recoPhos_
std::vector< std::pair< TrigCodes::TrigBitSet, OffEgSel > > trigCuts_
int getCutCode(const OffEle &ele, int cutMask=~0x0) const
void fillIsolData(const reco::GsfElectron &ele, OffEle::IsolData &isolData)
void fillHLTDataPho(const reco::Photon &pho, OffPho::HLTData &hltData)
void setLooseCutCode(int code)
Definition: EgHLTOffPho.h:92
void setCutCode(int code)
Definition: EgHLTOffPho.h:91
template<class T >
bool egHLT::OffHelper::getHandle ( const edm::Event event,
const edm::InputTag tag,
edm::Handle< T > &  handle 
)
static

Definition at line 196 of file EgHLTOffHelper.h.

References edm::Handle< T >::product(), and summarizeEdmComparisonLogfiles::success.

Referenced by getHandles().

197  {
198 
199  bool success=event.getByLabel(tag,handle);
200  return success && handle.product();
201 
202 
203  }
T const * product() const
Definition: Handle.h:74
int OffHelper::getHandles ( const edm::Event event,
const edm::EventSetup setup 
)

Definition at line 165 of file EgHLTOffHelper.cc.

References egHLT::errCodes::BeamSpot, beamSpot_, beamSpotTag_, caloGeom_, caloJetsTag_, caloTopology_, egHLT::errCodes::CaloTowers, caloTowers_, caloTowersTag_, egHLT::errCodes::EBRecHits, ebRecHits_, ecalRecHitsEBTag_, ecalRecHitsEETag_, egHLT::errCodes::EERecHits, eeRecHits_, electronsTag_, egHLT::errCodes::Geom, edm::EventSetup::get(), getHandle(), hbheHits_, hbheHitsTag_, egHLT::errCodes::HBHERecHits, hfHits_, hfHitsTag_, egHLT::errCodes::HFRecHits, egHLT::errCodes::IsolTrks, isolTrks_, isolTrkTag_, egHLT::errCodes::MagField, magField_, egHLT::errCodes::OffEle, egHLT::errCodes::OffJet, egHLT::errCodes::OffPho, egHLT::errCodes::OffVertex, photonsTag_, recoEles_, recoJets_, recoPhos_, recoVertices_, egHLT::errCodes::TrigEvent, trigEvt_, triggerSummaryLabel_, trigResults_, trigResultsTag_, and vertexTag_.

Referenced by makeOffEvt().

166 {
167  try {
168  setup.get<CaloGeometryRecord>().get(caloGeom_);
169  setup.get<CaloTopologyRecord>().get(caloTopology_);
170  //setup.get<EcalSeverityLevelAlgoRcd>().get(ecalSeverityLevel_);
171  }catch(cms::Exception& iException){
172  return errCodes::Geom;
173  }
174  try {
175  setup.get<IdealMagneticFieldRecord>().get(magField_);
176  }catch(cms::Exception& iException){
177  return errCodes::MagField;
178  }
179 
180  //get objects
181  if(!getHandle(event,triggerSummaryLabel_,trigEvt_)) return errCodes::TrigEvent; //must have this, otherwise skip event
182  if(!getHandle(event,trigResultsTag_,trigResults_)) return errCodes::TrigEvent; //re using bit to minimise bug fix code changes
183  if(!getHandle(event,electronsTag_,recoEles_)) return errCodes::OffEle; //need for electrons
184  if(!getHandle(event,photonsTag_, recoPhos_)) return errCodes::OffPho; //need for photons
185  if(!getHandle(event,caloJetsTag_,recoJets_)) return errCodes::OffJet; //need for electrons and photons
186  if(!getHandle(event,vertexTag_,recoVertices_)) return errCodes::OffVertex; //need for eff vs nVertex
187 
188  //need for HLT isolations (rec hits also need for sigmaIPhiIPhi (ele/pho) and r9 pho)
192  if(!getHandle(event,hbheHitsTag_, hbheHits_)) return errCodes::HBHERecHits; //I dont think we need hbhe rec-hits any more
193  if(!getHandle(event,hfHitsTag_, hfHits_)) return errCodes::HFRecHits;//I dont think we need hf rec-hits any more
196 
197 
198  return 0;
199 }
edm::Handle< reco::TrackCollection > isolTrks_
edm::InputTag ecalRecHitsEBTag_
edm::InputTag vertexTag_
edm::Handle< reco::PhotonCollection > recoPhos_
edm::InputTag caloJetsTag_
edm::Handle< HBHERecHitCollection > hbheHits_
edm::InputTag electronsTag_
edm::InputTag hfHitsTag_
edm::InputTag isolTrkTag_
edm::Handle< HFRecHitCollection > hfHits_
edm::Handle< std::vector< reco::CaloJet > > recoJets_
edm::InputTag trigResultsTag_
edm::InputTag triggerSummaryLabel_
edm::ESHandle< MagneticField > magField_
edm::Handle< trigger::TriggerEvent > trigEvt_
edm::ESHandle< CaloGeometry > caloGeom_
edm::Handle< reco::GsfElectronCollection > recoEles_
edm::Handle< edm::TriggerResults > trigResults_
edm::ESHandle< CaloTopology > caloTopology_
const T & get() const
Definition: EventSetup.h:55
edm::InputTag caloTowersTag_
edm::InputTag photonsTag_
edm::Handle< EcalRecHitCollection > eeRecHits_
edm::Handle< CaloTowerCollection > caloTowers_
edm::Handle< EcalRecHitCollection > ebRecHits_
edm::Handle< reco::VertexCollection > recoVertices_
static bool getHandle(const edm::Event &event, const edm::InputTag &tag, edm::Handle< T > &handle)
edm::InputTag ecalRecHitsEETag_
edm::Handle< reco::BeamSpot > beamSpot_
edm::InputTag hbheHitsTag_
edm::InputTag beamSpotTag_
int OffHelper::makeOffEvt ( const edm::Event edmEvent,
const edm::EventSetup setup,
egHLT::OffEvt offEvent 
)

Definition at line 152 of file EgHLTOffHelper.cc.

References egHLT::OffEvt::clear(), egHLT::OffEvt::eles(), fillOffEleVec(), fillOffPhoVec(), getHandles(), egHLT::OffEvt::phos(), recoJets_, egHLT::OffEvt::setJets(), and setTrigInfo().

Referenced by EgHLTOfflineSource::analyze().

153 {
154  offEvent.clear();
155  int errCode=0; //excution stops as soon as an error is flagged
156  if(errCode==0) errCode = getHandles(edmEvent,setup);
157  if(errCode==0) errCode = fillOffEleVec(offEvent.eles());
158  if(errCode==0) errCode = fillOffPhoVec(offEvent.phos());
159  if(errCode==0) errCode = setTrigInfo(edmEvent, offEvent);
160  if(errCode==0) offEvent.setJets(recoJets_);
161  return errCode;
162 }
int setTrigInfo(const edm::Event &edmEvent, egHLT::OffEvt &offEvent)
int fillOffPhoVec(std::vector< OffPho > &offPhos)
void clear()
Definition: EgHLTOffEvt.cc:5
edm::Handle< std::vector< reco::CaloJet > > recoJets_
const std::vector< OffPho > & phos() const
Definition: EgHLTOffEvt.h:48
void setJets(edm::Handle< std::vector< reco::CaloJet > > jets)
Definition: EgHLTOffEvt.h:56
const std::vector< OffEle > & eles() const
Definition: EgHLTOffEvt.h:46
int getHandles(const edm::Event &event, const edm::EventSetup &setup)
int fillOffEleVec(std::vector< OffEle > &offEles)
OffHelper& egHLT::OffHelper::operator= ( const OffHelper rhs)
inlineprivate

Definition at line 158 of file EgHLTOffHelper.h.

158 {return *this;}
int OffHelper::setTrigInfo ( const edm::Event edmEvent,
egHLT::OffEvt offEvent 
)

Definition at line 450 of file EgHLTOffHelper.cc.

References egHLT::OffEvt::eles(), egHLT::TrigCodes::getCode(), egHLT::trigTools::getFiltersPassed(), hltFiltersUsed_, hltFiltersUsedWithNrCandsCut_, hltTag_, l1PreAndSeedFilters_, l1PreScaledFilters_, l1PreScaledPaths_, egHLT::OffEvt::phos(), edm::Handle< T >::product(), egHLT::OffEvt::setEvtTrigBits(), egHLT::trigTools::setFiltersObjPasses(), findQualityFiles::size, trigEvt_, edm::TriggerNames::triggerIndex(), edm::Event::triggerNames(), and trigResults_.

Referenced by makeOffEvt().

451 {
453  //the l1 prescale paths dont have a filter with I can figure out if it passed or failed with so have to use TriggerResults
454  if(l1PreScaledPaths_.size()==l1PreScaledFilters_.size()){ //check to ensure both vectors have same number of events incase of screw ups
455  const edm::TriggerNames & triggerNames = edmEvent.triggerNames(*trigResults_);
456  for(size_t pathNr=0;pathNr<l1PreScaledPaths_.size();pathNr++){ //now we have to check the prescaled l1 trigger paths
457  unsigned int pathIndex = triggerNames.triggerIndex(l1PreScaledPaths_[pathNr]);
458  if(pathIndex<trigResults_->size() && trigResults_->accept(pathIndex)){
459  evtTrigBits |=TrigCodes::getCode(l1PreScaledFilters_[pathNr]);
460  }
461  }
462  }
463 
464  offEvent.setEvtTrigBits(evtTrigBits);
465 
468  return 0;
469 }
virtual edm::TriggerNames const & triggerNames(edm::TriggerResults const &triggerResults) const
Definition: Event.cc:207
static TrigBitSet getCode(const std::string &descript)
TrigCodes::TrigBitSet getFiltersPassed(const std::vector< std::pair< std::string, int > > &filters, const trigger::TriggerEvent *trigEvt, const std::string &hltTag)
std::vector< std::string > l1PreScaledPaths_
std::vector< std::pair< std::string, std::string > > l1PreAndSeedFilters_
void setEvtTrigBits(TrigCodes::TrigBitSet bits)
Definition: EgHLTOffEvt.h:55
unsigned int triggerIndex(std::string const &name) const
Definition: TriggerNames.cc:32
std::vector< std::pair< std::string, int > > hltFiltersUsedWithNrCandsCut_
edm::Handle< trigger::TriggerEvent > trigEvt_
const std::vector< OffPho > & phos() const
Definition: EgHLTOffEvt.h:48
edm::Handle< edm::TriggerResults > trigResults_
T const * product() const
Definition: Handle.h:74
std::vector< std::string > l1PreScaledFilters_
const std::vector< OffEle > & eles() const
Definition: EgHLTOffEvt.h:46
std::vector< std::string > hltFiltersUsed_
std::string hltTag_
void setFiltersObjPasses(std::vector< T > &objs, const std::vector< std::string > &filters, const std::vector< std::pair< std::string, std::string > > &l1PreAndSeedFilters, const TrigCodes::TrigBitSet &evtTrigBits, const trigger::TriggerEvent *trigEvt, const std::string &hltTag)
tuple size
Write out results.
std::bitset< maxNrBits_ > TrigBitSet
void OffHelper::setup ( const edm::ParameterSet conf)

Definition at line 36 of file EgHLTOffHelper.cc.

References beamSpotTag_, calHLTEleTrkIsol_, calHLTEmIsol_, calHLTHcalIsol_, calHLTPhoTrkIsol_, caloJetsTag_, caloTowersTag_, ecalRecHitsEBTag_, ecalRecHitsEETag_, electronsTag_, eleCuts_, eleLooseCuts_, edm::ParameterSet::getParameter(), hbheHitsTag_, hfHitsTag_, hltEleTrkIsolAlgo_, hltEleTrkIsolInnerCone_, hltEleTrkIsolOuterCone_, hltEleTrkIsolPtMin_, hltEleTrkIsolRSpan_, hltEleTrkIsolZSpan_, hltEMIsolEMinEB_, hltEMIsolEMinEE_, hltEMIsolEtaSliceEB_, hltEMIsolEtaSliceEE_, hltEMIsolEtMinEB_, hltEMIsolEtMinEE_, hltEMIsolInnerConeEB_, hltEMIsolInnerConeEE_, hltEMIsolOuterCone_, hltHadIsolDepth_, hltHadIsolEtMin_, hltHadIsolInnerCone_, hltHadIsolOuterCone_, hltPhoTrkIsolAlgo_, hltPhoTrkIsolCountTrks_, hltPhoTrkIsolInnerCone_, hltPhoTrkIsolOuterCone_, hltPhoTrkIsolPtMin_, hltPhoTrkIsolRSpan_, hltPhoTrkIsolZSpan_, hltTag_, isolTrkTag_, phoCuts_, phoLooseCuts_, photonsTag_, egHLT::OffEgSel::setup(), AlCaHLTBitMon_QueryRunRegistry::string, trigCutParams_, triggerSummaryLabel_, trigResultsTag_, and vertexTag_.

Referenced by EgHLTOfflineSource::EgHLTOfflineSource().

37 {
38 
39  ecalRecHitsEBTag_ = conf.getParameter<edm::InputTag>("BarrelRecHitCollection");
40  ecalRecHitsEETag_ = conf.getParameter<edm::InputTag>("EndcapRecHitCollection");
41  caloJetsTag_ = conf.getParameter<edm::InputTag>("CaloJetCollection");
42  isolTrkTag_ = conf.getParameter<edm::InputTag>("IsolTrackCollection");
43  hbheHitsTag_ = conf.getParameter<edm::InputTag>("HBHERecHitCollection");
44  hfHitsTag_ = conf.getParameter<edm::InputTag>("HFRecHitCollection");
45  electronsTag_ = conf.getParameter<edm::InputTag>("ElectronCollection");
46  photonsTag_ = conf.getParameter<edm::InputTag>("PhotonCollection");
47  triggerSummaryLabel_ = conf.getParameter<edm::InputTag>("triggerSummaryLabel");
48  hltTag_ = conf.getParameter<std::string>("hltTag");
49  beamSpotTag_ = conf.getParameter<edm::InputTag>("BeamSpotProducer");
50  caloTowersTag_ = conf.getParameter<edm::InputTag>("CaloTowers");
51  trigResultsTag_ = conf.getParameter<edm::InputTag>("TrigResults");
52  vertexTag_ = conf.getParameter<edm::InputTag>("VertexCollection");
53 
54  eleCuts_.setup(conf.getParameter<edm::ParameterSet>("eleCuts"));
55  eleLooseCuts_.setup(conf.getParameter<edm::ParameterSet>("eleLooseCuts"));
56  phoCuts_.setup(conf.getParameter<edm::ParameterSet>("phoCuts"));
57  phoLooseCuts_.setup(conf.getParameter<edm::ParameterSet>("phoLooseCuts"));
58 
59  //now we have the isolations completely configurable via python
60  hltEMIsolOuterCone_ = conf.getParameter<double>("hltEMIsolOuterCone");
61  hltEMIsolInnerConeEB_ = conf.getParameter<double>("hltEMIsolInnerConeEB");
62  hltEMIsolEtaSliceEB_ = conf.getParameter<double>("hltEMIsolEtaSliceEB");
63  hltEMIsolEtMinEB_ = conf.getParameter<double>("hltEMIsolEtMinEB");
64  hltEMIsolEMinEB_ = conf.getParameter<double>("hltEMIsolEMinEB");
65  hltEMIsolInnerConeEE_ = conf.getParameter<double>("hltEMIsolInnerConeEE");
66  hltEMIsolEtaSliceEE_ = conf.getParameter<double>("hltEMIsolEtaSliceEE");
67  hltEMIsolEtMinEE_ = conf.getParameter<double>("hltEMIsolEtMinEE");
68  hltEMIsolEMinEE_ = conf.getParameter<double>("hltEMIsolEMinEE");
69 
70  hltPhoTrkIsolPtMin_ = conf.getParameter<double>("hltPhoTrkIsolPtMin");
71  hltPhoTrkIsolOuterCone_ = conf.getParameter<double>("hltPhoTrkIsolOuterCone");
72  hltPhoTrkIsolInnerCone_ = conf.getParameter<double>("hltPhoTrkIsolInnerCone");
73  hltPhoTrkIsolZSpan_ = conf.getParameter<double>("hltPhoTrkIsolZSpan");
74  hltPhoTrkIsolRSpan_ = conf.getParameter<double>("hltPhoTrkIsolZSpan");
75  hltPhoTrkIsolCountTrks_ = conf.getParameter<bool>("hltPhoTrkIsolCountTrks");
76 
77  hltEleTrkIsolPtMin_ = conf.getParameter<double>("hltEleTrkIsolPtMin");
78  hltEleTrkIsolOuterCone_ = conf.getParameter<double>("hltEleTrkIsolOuterCone");
79  hltEleTrkIsolInnerCone_ = conf.getParameter<double>("hltEleTrkIsolInnerCone");
80  hltEleTrkIsolZSpan_ = conf.getParameter<double>("hltEleTrkIsolZSpan");
81  hltEleTrkIsolRSpan_ = conf.getParameter<double>("hltEleTrkIsolZSpan");
82 
83  hltHadIsolOuterCone_ = conf.getParameter<double>("hltHadIsolOuterCone");
84  hltHadIsolInnerCone_ = conf.getParameter<double>("hltHadIsolInnerCone");
85  hltHadIsolEtMin_ = conf.getParameter<double>("hltHadIsolEtMin");
86  hltHadIsolDepth_ = conf.getParameter<int>("hltHadIsolDepth");
87 
88  calHLTHcalIsol_ = conf.getParameter<bool>("calHLTHcalIsol");
89  calHLTEmIsol_ = conf.getParameter<bool>("calHLTEmIsol");
90  calHLTEleTrkIsol_ = conf.getParameter<bool>("calHLTEleTrkIsol");
91  calHLTPhoTrkIsol_ = conf.getParameter<bool>("calHLTPhoTrkIsol");
92 
93  trigCutParams_ = conf.getParameter<std::vector<edm::ParameterSet> >("triggerCuts"); //setupTriggers used to be in this function but had to be moved due to HLTConfigChanges (has to be called beginRun) so we have to save this for later.
94 
95  hltEleTrkIsolAlgo_ = new EgammaHLTTrackIsolation(hltEleTrkIsolPtMin_,hltEleTrkIsolOuterCone_,hltEleTrkIsolZSpan_,hltEleTrkIsolRSpan_,hltEleTrkIsolInnerCone_);
96  hltPhoTrkIsolAlgo_ = new EgammaHLTTrackIsolation(hltPhoTrkIsolPtMin_,hltPhoTrkIsolOuterCone_,hltPhoTrkIsolZSpan_,hltPhoTrkIsolRSpan_,hltPhoTrkIsolInnerCone_);
97 
98 
99 }
T getParameter(std::string const &) const
double hltEMIsolEtaSliceEB_
edm::InputTag ecalRecHitsEBTag_
edm::InputTag vertexTag_
double hltPhoTrkIsolRSpan_
OffEgSel phoLooseCuts_
edm::InputTag caloJetsTag_
double hltEMIsolOuterCone_
OffEgSel eleLooseCuts_
EgammaHLTTrackIsolation * hltPhoTrkIsolAlgo_
double hltEleTrkIsolOuterCone_
double hltEMIsolInnerConeEE_
std::vector< edm::ParameterSet > trigCutParams_
double hltEleTrkIsolInnerCone_
double hltPhoTrkIsolPtMin_
double hltEleTrkIsolZSpan_
edm::InputTag electronsTag_
edm::InputTag hfHitsTag_
double hltHadIsolInnerCone_
edm::InputTag isolTrkTag_
void setup(const edm::ParameterSet &)
double hltPhoTrkIsolZSpan_
double hltEleTrkIsolRSpan_
double hltHadIsolOuterCone_
edm::InputTag trigResultsTag_
double hltEleTrkIsolPtMin_
edm::InputTag triggerSummaryLabel_
double hltPhoTrkIsolInnerCone_
double hltEMIsolEtaSliceEE_
double hltEMIsolInnerConeEB_
edm::InputTag caloTowersTag_
edm::InputTag photonsTag_
double hltPhoTrkIsolOuterCone_
EgammaHLTTrackIsolation * hltEleTrkIsolAlgo_
edm::InputTag ecalRecHitsEETag_
std::string hltTag_
edm::InputTag hbheHitsTag_
edm::InputTag beamSpotTag_
void OffHelper::setupTriggers ( const HLTConfigProvider config,
const std::vector< std::string > &  hltFiltersUsed 
)

Definition at line 103 of file EgHLTOffHelper.cc.

References spr::find(), egHLT::TrigCodes::getCode(), egHLT::trigTools::getL1SeedFilterOfPath(), egHLT::trigTools::getMinNrObjsRequiredByFilter(), hltFiltersUsed_, hltFiltersUsedWithNrCandsCut_, l1PreAndSeedFilters_, l1PreScaledFilters_, l1PreScaledPaths_, AlCaHLTBitMon_QueryRunRegistry::string, egHLT::trigTools::translateFiltersToPathNames(), trigCutParams_, and trigCuts_.

Referenced by EgHLTOfflineSource::beginRun().

104 {
105  hltFiltersUsed_ = hltFiltersUsed; //expensive but only do this once and faster ways could make things less clear
106  //now work out how many objects are requires to pass filter for it to accept
108  for(size_t filterNr=0;filterNr<hltFiltersUsed_.size();filterNr++){
110  }
111 
112  //now loading the cuts for every trigger into our vector which stores them
113  //only load cuts for triggers that are in hltFiltersUsed
114 
115  for(size_t trigNr=0;trigNr<trigCutParams_.size();trigNr++) {
116  std::string trigName = trigCutParams_[trigNr].getParameter<std::string>("trigName");
117  if(std::find(hltFiltersUsed_.begin(),hltFiltersUsed_.end(),trigName)!=hltFiltersUsed_.end()){ //perhaps I should sort hltFiltersUsed_....
118  trigCuts_.push_back(std::make_pair(TrigCodes::getCode(trigName),OffEgSel(trigCutParams_[trigNr])));
119  // std::cout<<trigName<<std::endl<<"between"<<std::endl<<trigCutParams_[trigNr]<<std::endl<<"after"<<std::endl;
120  }
121  }
122  trigCutParams_.clear();//dont need it any more, get rid of it
123 
124  //to make my life difficult, the scaled l1 paths are special
125  //and arent stored in trigger event
126  //to I have to figure out the path, see if it passes
127  //and then hunt down the l1 seed filter and use that to match to the pho/ele
128  //matching on l1 seed filter is not enough as that will be passed for normal
129  //electron triggers even if pre-scale hasnt fired
130  l1PreScaledFilters_.clear();
131  l1PreScaledPaths_.clear();
132  l1PreAndSeedFilters_.clear();
133  for(size_t filterNr=0;filterNr<hltFiltersUsed_.size();filterNr++){
134  if(hltFiltersUsed_[filterNr].find("hltPreL1")==0){ //l1 prescaled path
135  l1PreScaledFilters_.push_back(hltFiltersUsed_[filterNr]);
136  }
137  }
138 
140  if(l1PreScaledPaths_.size()==l1PreScaledFilters_.size()){
141  for(size_t pathNr=0;pathNr<l1PreScaledPaths_.size();pathNr++){
142 
144  //---Morse====
145  //std::cout<<l1PreScaledFilters_[pathNr]<<" "<<l1PreScaledPaths_[pathNr]<<" "<<l1SeedFilter<<std::endl;
146  //------------
147  l1PreAndSeedFilters_.push_back(std::make_pair(l1PreScaledFilters_[pathNr],l1SeedFilter));
148  }
149  }
150 }
static TrigBitSet getCode(const std::string &descript)
std::vector< std::pair< TrigCodes::TrigBitSet, OffEgSel > > trigCuts_
int getMinNrObjsRequiredByFilter(const std::string &filterName)
std::vector< std::string > l1PreScaledPaths_
std::vector< std::pair< std::string, std::string > > l1PreAndSeedFilters_
void find(edm::Handle< EcalRecHitCollection > &hits, DetId thisDet, std::vector< EcalRecHitCollection::const_iterator > &hit, bool debug=false)
Definition: FindCaloHit.cc:7
std::vector< edm::ParameterSet > trigCutParams_
std::string getL1SeedFilterOfPath(const HLTConfigProvider &hltConfig, const std::string &path)
std::vector< std::pair< std::string, int > > hltFiltersUsedWithNrCandsCut_
std::vector< std::string > l1PreScaledFilters_
std::vector< std::string > hltFiltersUsed_
void translateFiltersToPathNames(const HLTConfigProvider &hltConfig, const std::vector< std::string > &filters, std::vector< std::string > &paths)
const std::vector<std::pair<TrigCodes::TrigBitSet,OffEgSel> >& egHLT::OffHelper::trigCuts ( ) const
inline

Definition at line 188 of file EgHLTOffHelper.h.

References trigCuts_.

188 {return trigCuts_;}
std::vector< std::pair< TrigCodes::TrigBitSet, OffEgSel > > trigCuts_
const trigger::TriggerEvent* egHLT::OffHelper::trigEvt ( ) const
inline

Definition at line 187 of file EgHLTOffHelper.h.

References edm::Handle< T >::product(), and trigEvt_.

187 {return trigEvt_.product();}
edm::Handle< trigger::TriggerEvent > trigEvt_
T const * product() const
Definition: Handle.h:74

Member Data Documentation

edm::Handle<reco::BeamSpot> egHLT::OffHelper::beamSpot_
private

Definition at line 99 of file EgHLTOffHelper.h.

Referenced by fillHLTData(), and getHandles().

edm::InputTag egHLT::OffHelper::beamSpotTag_
private

Definition at line 78 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

bool egHLT::OffHelper::calHLTEleTrkIsol_
private

Definition at line 151 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

bool egHLT::OffHelper::calHLTEmIsol_
private

Definition at line 150 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

bool egHLT::OffHelper::calHLTHcalIsol_
private

Definition at line 149 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

bool egHLT::OffHelper::calHLTPhoTrkIsol_
private

Definition at line 152 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

edm::ESHandle<CaloGeometry> egHLT::OffHelper::caloGeom_
private

Definition at line 83 of file EgHLTOffHelper.h.

Referenced by fillClusShapeData(), fillIsolData(), and getHandles().

edm::InputTag egHLT::OffHelper::caloJetsTag_
private

Definition at line 71 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::ESHandle<CaloTopology> egHLT::OffHelper::caloTopology_
private

Definition at line 84 of file EgHLTOffHelper.h.

Referenced by fillClusShapeData(), and getHandles().

edm::Handle<CaloTowerCollection> egHLT::OffHelper::caloTowers_
private

Definition at line 100 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and getHandles().

edm::InputTag egHLT::OffHelper::caloTowersTag_
private

Definition at line 79 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::Handle<EcalRecHitCollection> egHLT::OffHelper::ebRecHits_
private

Definition at line 88 of file EgHLTOffHelper.h.

Referenced by fillClusShapeData(), fillIsolData(), and getHandles().

edm::InputTag egHLT::OffHelper::ecalRecHitsEBTag_
private

Definition at line 69 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::InputTag egHLT::OffHelper::ecalRecHitsEETag_
private

Definition at line 70 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::ESHandle<EcalSeverityLevelAlgo> egHLT::OffHelper::ecalSeverityLevel_
private

Definition at line 86 of file EgHLTOffHelper.h.

Referenced by fillIsolData().

edm::Handle<EcalRecHitCollection> egHLT::OffHelper::eeRecHits_
private

Definition at line 89 of file EgHLTOffHelper.h.

Referenced by fillClusShapeData(), fillIsolData(), and getHandles().

edm::InputTag egHLT::OffHelper::electronsTag_
private

Definition at line 76 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

OffEgSel egHLT::OffHelper::eleCuts_
private

Definition at line 62 of file EgHLTOffHelper.h.

Referenced by fillOffEleVec(), and setup().

OffEgSel egHLT::OffHelper::eleLooseCuts_
private

Definition at line 61 of file EgHLTOffHelper.h.

Referenced by fillOffEleVec(), and setup().

edm::Handle<HBHERecHitCollection> egHLT::OffHelper::hbheHits_
private

Definition at line 91 of file EgHLTOffHelper.h.

Referenced by getHandles().

edm::InputTag egHLT::OffHelper::hbheHitsTag_
private

Definition at line 73 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::Handle<HFRecHitCollection> egHLT::OffHelper::hfHits_
private

Definition at line 90 of file EgHLTOffHelper.h.

Referenced by getHandles().

edm::InputTag egHLT::OffHelper::hfHitsTag_
private

Definition at line 74 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

EgammaHLTTrackIsolation* egHLT::OffHelper::hltEleTrkIsolAlgo_
private

Definition at line 117 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), setup(), and ~OffHelper().

double egHLT::OffHelper::hltEleTrkIsolInnerCone_
private

Definition at line 140 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltEleTrkIsolOuterCone_
private

Definition at line 139 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltEleTrkIsolPtMin_
private

Definition at line 138 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltEleTrkIsolRSpan_
private

Definition at line 142 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltEleTrkIsolZSpan_
private

Definition at line 141 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltEMIsolEMinEB_
private

Definition at line 126 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolEMinEE_
private

Definition at line 130 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolEtaSliceEB_
private

Definition at line 124 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolEtaSliceEE_
private

Definition at line 128 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolEtMinEB_
private

Definition at line 125 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolEtMinEE_
private

Definition at line 129 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolInnerConeEB_
private

Definition at line 123 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolInnerConeEE_
private

Definition at line 127 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltEMIsolOuterCone_
private

Definition at line 122 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

std::vector<std::string> egHLT::OffHelper::hltFiltersUsed_
private

Definition at line 109 of file EgHLTOffHelper.h.

Referenced by fillHLTData(), fillHLTDataPho(), setTrigInfo(), and setupTriggers().

std::vector<std::pair<std::string,int> > egHLT::OffHelper::hltFiltersUsedWithNrCandsCut_
private

Definition at line 110 of file EgHLTOffHelper.h.

Referenced by setTrigInfo(), and setupTriggers().

int egHLT::OffHelper::hltHadIsolDepth_
private

Definition at line 147 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltHadIsolEtMin_
private

Definition at line 146 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltHadIsolInnerCone_
private

Definition at line 145 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltHadIsolOuterCone_
private

Definition at line 144 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

EgammaHLTTrackIsolation* egHLT::OffHelper::hltPhoTrkIsolAlgo_
private

Definition at line 118 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), setup(), and ~OffHelper().

bool egHLT::OffHelper::hltPhoTrkIsolCountTrks_
private

Definition at line 137 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and setup().

double egHLT::OffHelper::hltPhoTrkIsolInnerCone_
private

Definition at line 134 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltPhoTrkIsolOuterCone_
private

Definition at line 133 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltPhoTrkIsolPtMin_
private

Definition at line 132 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltPhoTrkIsolRSpan_
private

Definition at line 136 of file EgHLTOffHelper.h.

Referenced by setup().

double egHLT::OffHelper::hltPhoTrkIsolZSpan_
private

Definition at line 135 of file EgHLTOffHelper.h.

Referenced by setup().

std::string egHLT::OffHelper::hltTag_
private

Definition at line 108 of file EgHLTOffHelper.h.

Referenced by fillHLTData(), fillHLTDataPho(), setTrigInfo(), and setup().

edm::Handle<reco::TrackCollection> egHLT::OffHelper::isolTrks_
private

Definition at line 92 of file EgHLTOffHelper.h.

Referenced by fillIsolData(), and getHandles().

edm::InputTag egHLT::OffHelper::isolTrkTag_
private

Definition at line 72 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

std::vector<std::pair<std::string,std::string> > egHLT::OffHelper::l1PreAndSeedFilters_
private

Definition at line 111 of file EgHLTOffHelper.h.

Referenced by setTrigInfo(), and setupTriggers().

std::vector<std::string> egHLT::OffHelper::l1PreScaledFilters_
private

Definition at line 113 of file EgHLTOffHelper.h.

Referenced by setTrigInfo(), and setupTriggers().

std::vector<std::string> egHLT::OffHelper::l1PreScaledPaths_
private

Definition at line 112 of file EgHLTOffHelper.h.

Referenced by setTrigInfo(), and setupTriggers().

edm::ESHandle<MagneticField> egHLT::OffHelper::magField_
private

Definition at line 85 of file EgHLTOffHelper.h.

Referenced by getHandles().

OffEgSel egHLT::OffHelper::phoCuts_
private

Definition at line 64 of file EgHLTOffHelper.h.

Referenced by fillOffPhoVec(), and setup().

OffEgSel egHLT::OffHelper::phoLooseCuts_
private

Definition at line 63 of file EgHLTOffHelper.h.

Referenced by fillOffPhoVec(), and setup().

edm::InputTag egHLT::OffHelper::photonsTag_
private

Definition at line 77 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::Handle<reco::GsfElectronCollection> egHLT::OffHelper::recoEles_
private

Definition at line 96 of file EgHLTOffHelper.h.

Referenced by fillOffEleVec(), and getHandles().

edm::Handle<std::vector<reco::CaloJet> > egHLT::OffHelper::recoJets_
private

Definition at line 97 of file EgHLTOffHelper.h.

Referenced by getHandles(), and makeOffEvt().

edm::Handle<reco::PhotonCollection> egHLT::OffHelper::recoPhos_
private

Definition at line 95 of file EgHLTOffHelper.h.

Referenced by fillOffPhoVec(), and getHandles().

edm::Handle<reco::VertexCollection> egHLT::OffHelper::recoVertices_
private

Definition at line 104 of file EgHLTOffHelper.h.

Referenced by fillOffEleVec(), and getHandles().

std::vector<edm::ParameterSet> egHLT::OffHelper::trigCutParams_
private

Definition at line 155 of file EgHLTOffHelper.h.

Referenced by setup(), and setupTriggers().

std::vector<std::pair<TrigCodes::TrigBitSet,OffEgSel> > egHLT::OffHelper::trigCuts_
private

Definition at line 66 of file EgHLTOffHelper.h.

Referenced by fillOffEleVec(), fillOffPhoVec(), setupTriggers(), and trigCuts().

edm::Handle<trigger::TriggerEvent> egHLT::OffHelper::trigEvt_
private

Definition at line 94 of file EgHLTOffHelper.h.

Referenced by fillHLTData(), fillHLTDataPho(), getHandles(), setTrigInfo(), and trigEvt().

edm::InputTag egHLT::OffHelper::triggerSummaryLabel_
private

Definition at line 75 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::Handle<edm::TriggerResults> egHLT::OffHelper::trigResults_
private

Definition at line 102 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setTrigInfo().

edm::InputTag egHLT::OffHelper::trigResultsTag_
private

Definition at line 80 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().

edm::InputTag egHLT::OffHelper::vertexTag_
private

Definition at line 81 of file EgHLTOffHelper.h.

Referenced by getHandles(), and setup().