CMS 3D CMS Logo

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

\ Algorithm for box particle flow super clustering in the ECAL More...

#include <PFECALSuperClusterAlgo.h>

Classes

class  CalibratedPFCluster
 

Public Types

typedef std::shared_ptr< CalibratedPFClusterCalibratedClusterPtr
 
typedef std::vector< CalibratedClusterPtrCalibratedClusterPtrVector
 
enum  clustering_type { kBOX =1, kMustache =2 }
 
enum  energy_weight { kRaw, kCalibratedNoPS, kCalibratedTotal }
 

Public Member Functions

std::unique_ptr< reco::SuperClusterCollection > & getEBOutputSCCollection ()
 
std::unique_ptr< reco::SuperClusterCollection > & getEEOutputSCCollection ()
 
void loadAndSortPFClusters (const edm::Event &evt)
 
 PFECALSuperClusterAlgo ()
 constructor More...
 
void run ()
 
void setClusteringType (clustering_type thetype)
 
void setCrackCorrections (bool applyCrackCorrections)
 
void setDropUnseedable (const bool d)
 
void setEnergyWeighting (energy_weight thetype)
 
void setEtawidthSuperClusterBarrel (double etawidth)
 
void setEtawidthSuperClusterEndcap (double etawidth)
 
void setIsOOTCollection (bool isOOTCollection)
 
void setMajorityFraction (const double f)
 
void setPFClusterCalibration (const std::shared_ptr< PFEnergyCalibration > &)
 
void setPhiwidthSuperClusterBarrel (double phiwidth)
 
void setPhiwidthSuperClusterEndcap (double phiwidth)
 
void setSatelliteMerging (const bool doit)
 
void setSatelliteThreshold (const double t)
 
void setThreshPFClusterBarrel (double thresh)
 
void setThreshPFClusterEndcap (double thresh)
 
void setThreshPFClusterSeedBarrel (double thresh)
 
void setThreshPFClusterSeedEndcap (double thresh)
 
void setThreshSuperClusterEt (double thresh)
 
void setTokens (const edm::ParameterSet &, edm::ConsumesCollector &&)
 
void setUseDynamicDPhi (bool useit)
 
void setUseETForSeeding (bool useET)
 
void setUseRegression (bool useRegression)
 
void setVerbosityLevel (bool verbose)
 
void update (const edm::EventSetup &)
 

Private Member Functions

void buildAllSuperClusters (CalibratedClusterPtrVector &, double seedthresh)
 
void buildSuperCluster (CalibratedClusterPtr &, CalibratedClusterPtrVector &)
 

Private Attributes

CalibratedClusterPtrVector _clustersEB
 
CalibratedClusterPtrVector _clustersEE
 
clustering_type _clustype
 
energy_weight _eweight
 
std::shared_ptr< PFEnergyCalibration_pfEnergyCalibration
 
bool applyCrackCorrections_
 
const EcalRecHitCollectionbarrelRecHits_
 
const reco::BeamSpotbeamSpot_
 
const ESChannelStatuschannelStatus_
 
bool doSatelliteClusterMerge_
 
bool dropUnseedable_
 
const reco::PFCluster::EEtoPSAssociationEEtoPS_
 
const EcalRecHitCollectionendcapRecHits_
 
double etawidthSuperClusterBarrel_
 
double etawidthSuperClusterEndcap_
 
double fractionForMajority_
 
edm::EDGetTokenT< EcalRecHitCollectioninputTagBarrelRecHits_
 
edm::EDGetTokenT< reco::BeamSpotinputTagBeamSpot_
 
edm::EDGetTokenT< EcalRecHitCollectioninputTagEndcapRecHits_
 
edm::EDGetTokenT< edm::View< reco::PFCluster > > inputTagPFClusters_
 
edm::EDGetTokenT< reco::PFCluster::EEtoPSAssociationinputTagPFClustersES_
 
bool isOOTCollection_
 
double phiwidthSuperClusterBarrel_
 
double phiwidthSuperClusterEndcap_
 
std::unique_ptr< SCEnergyCorrectorSemiParmregr_
 
double satelliteThreshold_
 
std::unique_ptr< reco::SuperClusterCollectionsuperClustersEB_
 
std::unique_ptr< reco::SuperClusterCollectionsuperClustersEE_
 
bool threshIsET_
 
double threshPFClusterBarrel_
 
double threshPFClusterEndcap_
 
double threshPFClusterSeedBarrel_
 
double threshPFClusterSeedEndcap_
 
double threshSuperClusterEt_
 
bool useDynamicDPhi_
 
bool useRegression_
 
bool verbose_
 

Detailed Description

\ Algorithm for box particle flow super clustering in the ECAL

Original Author: Nicolas Chanon Additional Authors (Mustache): Y. Gershtein, R. Patel, L. Gray

Date
July 2012

Definition at line 43 of file PFECALSuperClusterAlgo.h.

Member Typedef Documentation

Definition at line 63 of file PFECALSuperClusterAlgo.h.

Definition at line 64 of file PFECALSuperClusterAlgo.h.

Member Enumeration Documentation

Constructor & Destructor Documentation

PFECALSuperClusterAlgo::PFECALSuperClusterAlgo ( )

constructor

Definition at line 122 of file PFECALSuperClusterAlgo.cc.

References setPFClusterCalibration().

122 : beamSpot_(nullptr) { }
const reco::BeamSpot * beamSpot_

Member Function Documentation

void PFECALSuperClusterAlgo::buildAllSuperClusters ( CalibratedClusterPtrVector ,
double  seedthresh 
)
private

Definition at line 264 of file PFECALSuperClusterAlgo.cc.

References buildSuperCluster(), fastPrimaryVertexProducer_cfi::clusters, and threshIsET_.

Referenced by run().

265  {
266  auto seedable = std::bind(isSeed, _1, seedthresh, threshIsET_);
267  // make sure only seeds appear at the front of the list of clusters
268  std::stable_partition(clusters.begin(),clusters.end(),seedable);
269  // in each iteration we are working on a list that is already sorted
270  // in the cluster energy and remains so through each iteration
271  // NB: since clusters is sorted in loadClusters any_of has O(1)
272  // timing until you run out of seeds!
273  while( std::any_of(clusters.cbegin(), clusters.cend(), seedable) ) {
275  }
276 }
void buildSuperCluster(CalibratedClusterPtr &, CalibratedClusterPtrVector &)
void PFECALSuperClusterAlgo::buildSuperCluster ( CalibratedClusterPtr ,
CalibratedClusterPtrVector  
)
private

Definition at line 278 of file PFECALSuperClusterAlgo.cc.

References _clustype, _eweight, _pfEnergyCalibration, reco::SuperCluster::addCluster(), reco::CaloCluster::addHitAndFraction(), reco::SuperCluster::addPreshowerCluster(), applyCrackCorrections_, barrelRecHits_, beamSpot_, channelStatus_, TauDecayModes::dec, doSatelliteClusterMerge_, dropUnseedable_, PFLayer::ECAL_BARREL, PFLayer::ECAL_ENDCAP, EEtoPS_, endcapRecHits_, reco::PFCluster::energy(), reco::CaloCluster::energy(), etawidthSuperClusterBarrel_, etawidthSuperClusterEndcap_, Exception, ESCondObjectContainer< T >::find(), edm::SortedCollection< T, SORT >::find(), fractionForMajority_, edm::Ptr< T >::get(), ESCondObjectContainer< T >::getMap(), PFLayer::HGCAL, mps_fire::i, isOOTCollection_, kCalibratedNoPS, kCalibratedTotal, EcalRecHit::kOutOfTime, kRaw, reco::PFCluster::layer(), PFClusterWidthAlgo::pflowEtaWidth(), PFClusterWidthAlgo::pflowPhiWidth(), phiwidthSuperClusterBarrel_, phiwidthSuperClusterEndcap_, reco::BeamSpot::position(), reco::CaloCluster::position(), RecoTauValidation_cfi::posX, RecoTauValidation_cfi::posY, reco::SuperCluster::preshowerClustersBegin(), reco::SuperCluster::preshowerClustersEnd(), PFLayer::PS1, PFLayer::PS2, ptFast(), reco::SuperCluster::rawEnergy(), reco::PFCluster::recHitFractions(), regr_, satelliteThreshold_, reco::SuperCluster::seed(), reco::CaloCluster::setCorrectedEnergy(), reco::SuperCluster::setEtaWidth(), reco::SuperCluster::setPhiWidth(), reco::SuperCluster::setPreshowerEnergy(), reco::SuperCluster::setPreshowerEnergyPlane1(), reco::SuperCluster::setPreshowerEnergyPlane2(), reco::SuperCluster::setSeed(), sortByKey(), superClustersEB_, superClustersEE_, threshSuperClusterEt_, useDynamicDPhi_, useRegression_, and verbose_.

Referenced by buildAllSuperClusters().

279 {
280  double etawidthSuperCluster = 0.0;
281  double phiwidthSuperCluster = 0.0;
282  bool isEE = false;
283  switch( seed->the_ptr()->layer() )
284  {
286  phiwidthSuperCluster = phiwidthSuperClusterBarrel_;
287  etawidthSuperCluster = etawidthSuperClusterBarrel_;
288  edm::LogInfo("PFClustering") << "Building SC number "
289  << superClustersEB_->size() + 1
290  << " in the ECAL barrel!";
291  break;
292  case PFLayer::HGCAL:
293  case PFLayer::ECAL_ENDCAP:
294 
295  phiwidthSuperCluster = phiwidthSuperClusterEndcap_;
296  etawidthSuperCluster = etawidthSuperClusterEndcap_;
297  edm::LogInfo("PFClustering") << "Building SC number "
298  << superClustersEE_->size() + 1
299  << " in the ECAL endcap!" << std::endl;
300  isEE = true;
301  break;
302  default:
303  break;
304  }
305  auto isClusteredWithSeed = std::bind(isClustered, _1, seed,_clustype,useDynamicDPhi_, etawidthSuperCluster, phiwidthSuperCluster);
306  auto matchesSeedByRecHit = std::bind(isLinkedByRecHit, _1, seed,satelliteThreshold_, fractionForMajority_,0.1,0.2);
307 
308  // this function shuffles the list of clusters into a list
309  // where all clustered sub-clusters are at the front
310  // and returns a pointer to the first unclustered cluster.
311  // The relative ordering of clusters is preserved
312  // (i.e. both resulting sub-lists are sorted by energy).
313  auto not_clustered = std::stable_partition(clusters.begin(),clusters.end(),
314  isClusteredWithSeed);
315  // satellite cluster merging
316  // it was found that large clusters can split!
317  if( doSatelliteClusterMerge_ ) {
318  not_clustered = std::stable_partition(not_clustered,clusters.end(),
319  matchesSeedByRecHit);
320  }
321 
322  if(verbose_) {
323  edm::LogInfo("PFClustering") << "Dumping cluster detail";
324  edm::LogVerbatim("PFClustering")
325  << "\tPassed seed: e = " << seed->energy_nocalib()
326  << " eta = " << seed->eta() << " phi = " << seed->phi()
327  << std::endl;
328  for( auto clus = clusters.cbegin(); clus != not_clustered; ++clus ) {
329  edm::LogVerbatim("PFClustering")
330  << "\t\tClustered cluster: e = " << (*clus)->energy_nocalib()
331  << " eta = " << (*clus)->eta() << " phi = " << (*clus)->phi()
332  << std::endl;
333  }
334  for( auto clus = not_clustered; clus != clusters.end(); ++clus ) {
335  edm::LogVerbatim("PFClustering")
336  << "\tNon-Clustered cluster: e = " << (*clus)->energy_nocalib()
337  << " eta = " << (*clus)->eta() << " phi = " << (*clus)->phi()
338  << std::endl;
339  }
340  }
341 
342  if (not_clustered == clusters.begin()) {
343  if(dropUnseedable_){
344  clusters.erase(clusters.begin());
345  return;
346  }
347  else {
348  throw cms::Exception("PFECALSuperClusterAlgo::buildSuperCluster")
349  << "Cluster is not seedable!" << std::endl
350  << "\tNon-Clustered cluster: e = " << (*not_clustered)->energy_nocalib()
351  << " eta = " << (*not_clustered)->eta() << " phi = " << (*not_clustered)->phi()
352  << std::endl;
353  }
354  }
355 
356  // move the clustered clusters out of available cluster list
357  // and into a temporary vector for building the SC
358  CalibratedClusterPtrVector clustered(clusters.begin(),not_clustered);
359  clusters.erase(clusters.begin(),not_clustered);
360  // need the vector of raw pointers for a PF width class
361  std::vector<const reco::PFCluster*> bare_ptrs;
362  // calculate necessary parameters and build the SC
363  double posX(0), posY(0), posZ(0),
364  corrSCEnergy(0), corrPS1Energy(0), corrPS2Energy(0),
365  ePS1(0), ePS2(0), energyweight(0), energyweighttot(0);
366  std::vector<double> ps1_energies, ps2_energies;
367  int condP1(1), condP2(1);
368  for( auto& clus : clustered ) {
369  ePS1 = ePS2 = 0;
370  energyweight = clus->energy_nocalib();
371  bare_ptrs.push_back(clus->the_ptr().get());
372  // update EE calibrated super cluster energies
373  if( isEE ) {
374  ePS1 = ePS2 = 0;
375  condP1 = condP2 = 1;
376  ps1_energies.clear();
377  ps2_energies.clear();
378  auto ee_key_val =
379  std::make_pair(clus->the_ptr().key(),edm::Ptr<reco::PFCluster>());
380  const auto clustops = std::equal_range(EEtoPS_->begin(),
381  EEtoPS_->end(),
382  ee_key_val,
383  sortByKey);
384  for( auto i_ps = clustops.first; i_ps != clustops.second; ++i_ps) {
385  edm::Ptr<reco::PFCluster> psclus(i_ps->second);
386 
387  auto const& recH_Frac = psclus->recHitFractions();
388 
389  switch( psclus->layer() ) {
390  case PFLayer::PS1:
391  ps1_energies.push_back(psclus->energy());
392  for (auto const& recH : recH_Frac){
393  ESDetId strip1 = recH.recHitRef()->detId();
394  if(strip1 != ESDetId(0)){
396  // getStatusCode() == 1 => dead channel
397  //apply correction if all recHits in dead region
398  if(status_p1->getStatusCode() == 0) condP1 = 0; //active
399  }
400  }
401  break;
402  case PFLayer::PS2:
403  ps2_energies.push_back(psclus->energy());
404  for (auto const& recH : recH_Frac){
405  ESDetId strip2 = recH.recHitRef()->detId();
406  if(strip2 != ESDetId(0)) {
408  if(status_p2->getStatusCode() == 0) condP2 = 0;
409  }
410  }
411  break;
412  default:
413  break;
414  }
415  }
416  if(condP1 == 1) ePS1 = -1.;
417  if(condP2 == 1) ePS2 = -1.;
418  _pfEnergyCalibration->energyEm(*(clus->the_ptr()),
419  ps1_energies,ps2_energies,
420  ePS1,ePS2,
422  }
423 
424  if(ePS1 == -1.) ePS1 = 0;
425  if(ePS2 == -1.) ePS2 = 0;
426 
427  switch( _eweight ) {
428  case kRaw: // energyweight is initialized to raw cluster energy
429  break;
430  case kCalibratedNoPS:
431  energyweight = clus->energy() - ePS1 - ePS2;
432  break;
433  case kCalibratedTotal:
434  energyweight = clus->energy();
435  break;
436  default:
437  break;
438  }
439  const math::XYZPoint& cluspos = clus->the_ptr()->position();
440  posX += energyweight * cluspos.X();
441  posY += energyweight * cluspos.Y();
442  posZ += energyweight * cluspos.Z();
443 
444  energyweighttot += energyweight;
445  corrSCEnergy += clus->energy();
446  corrPS1Energy += ePS1;
447  corrPS2Energy += ePS2;
448  }
449  posX /= energyweighttot;
450  posY /= energyweighttot;
451  posZ /= energyweighttot;
452 
453  // now build the supercluster
454  reco::SuperCluster new_sc(corrSCEnergy,math::XYZPoint(posX,posY,posZ));
455  new_sc.setCorrectedEnergy(corrSCEnergy);
456  new_sc.setSeed(clustered.front()->the_ptr());
457  new_sc.setPreshowerEnergy(corrPS1Energy+corrPS2Energy);
458  new_sc.setPreshowerEnergyPlane1(corrPS1Energy);
459  new_sc.setPreshowerEnergyPlane2(corrPS2Energy);
460  for( const auto& clus : clustered ) {
461  new_sc.addCluster(clus->the_ptr());
462 
463  auto& hits_and_fractions = clus->the_ptr()->hitsAndFractions();
464  for( auto& hit_and_fraction : hits_and_fractions ) {
465  new_sc.addHitAndFraction(hit_and_fraction.first,hit_and_fraction.second);
466  }
467  if( isEE ) {
468  auto ee_key_val =
469  std::make_pair(clus->the_ptr().key(),edm::Ptr<reco::PFCluster>());
470  const auto clustops = std::equal_range(EEtoPS_->begin(),
471  EEtoPS_->end(),
472  ee_key_val,
473  sortByKey);
474  // EE rechits should be uniquely matched to sets of pre-shower
475  // clusters at this point, so we throw an exception if otherwise
476  // now wrapped in EDM debug flags
477  for( auto i_ps = clustops.first; i_ps != clustops.second; ++i_ps) {
478  edm::Ptr<reco::PFCluster> psclus(i_ps->second);
479 #ifdef EDM_ML_DEBUG
480  auto found_pscluster = std::find_if(new_sc.preshowerClustersBegin(),
481  new_sc.preshowerClustersEnd(),
482  [&i_ps](const auto& i) { return i.key() == i_ps->first;});
483  if( found_pscluster == new_sc.preshowerClustersEnd() ) {
484 #endif
485  new_sc.addPreshowerCluster(psclus);
486 #ifdef EDM_ML_DEBUG
487  } else {
488  throw cms::Exception("PFECALSuperClusterAlgo::buildSuperCluster")
489  << "Found a PS cluster matched to more than one EE cluster!"
490  << std::endl << std::hex << psclus.get() << " == "
491  << found_pscluster->get() << std::dec << std::endl;
492  }
493 #endif
494  }
495  }
496  }
497 
498  // calculate linearly weighted cluster widths
499  PFClusterWidthAlgo pfwidth(bare_ptrs);
500  new_sc.setEtaWidth(pfwidth.pflowEtaWidth());
501  new_sc.setPhiWidth(pfwidth.pflowPhiWidth());
502 
503  // cache the value of the raw energy
504  new_sc.rawEnergy();
505 
506  //apply regression energy corrections
507  if( useRegression_ ) {
508  regr_->modifyObject(new_sc);
509  }
510 
511  // save the super cluster to the appropriate list (if it passes the final
512  // Et threshold)
513  //Note that Et is computed here with respect to the beamspot position
514  //in order to be consistent with the cut applied in the
515  //ElectronSeedProducer
516  double scEtBS =
517  ptFast(new_sc.energy(),new_sc.position(),beamSpot_->position());
518 
519  if ( scEtBS > threshSuperClusterEt_ ) {
520  switch( seed->the_ptr()->layer() ) {
522  if(isOOTCollection_) {
523  DetId seedId = new_sc.seed()->seed();
525  if (!seedRecHit->checkFlag(EcalRecHit::kOutOfTime)) break;
526  }
527  superClustersEB_->push_back(new_sc);
528  break;
529  case PFLayer::HGCAL:
530  case PFLayer::ECAL_ENDCAP:
531  if(isOOTCollection_) {
532  DetId seedId = new_sc.seed()->seed();
534  if (!seedRecHit->checkFlag(EcalRecHit::kOutOfTime)) break;
535  }
536  superClustersEE_->push_back(new_sc);
537  break;
538  default:
539  break;
540  }
541  }
542 }
const ESChannelStatus * channelStatus_
std::unique_ptr< SCEnergyCorrectorSemiParm > regr_
std::unique_ptr< reco::SuperClusterCollection > superClustersEB_
const self & getMap() const
std::vector< EcalRecHit >::const_iterator const_iterator
const reco::BeamSpot * beamSpot_
const reco::PFCluster::EEtoPSAssociation * EEtoPS_
double ptFast(const double energy, const math::XYZPoint &position, const math::XYZPoint &origin)
std::unique_ptr< reco::SuperClusterCollection > superClustersEE_
std::vector< CalibratedClusterPtr > CalibratedClusterPtrVector
std::shared_ptr< PFEnergyCalibration > _pfEnergyCalibration
const_iterator find(uint32_t rawId) const
Definition: DetId.h:18
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12
bool sortByKey(const EEPSPair &a, const EEPSPair &b)
std::vector< Item >::const_iterator const_iterator
iterator find(key_type k)
const Point & position() const
position
Definition: BeamSpot.h:62
const EcalRecHitCollection * barrelRecHits_
const EcalRecHitCollection * endcapRecHits_
std::unique_ptr<reco::SuperClusterCollection>& PFECALSuperClusterAlgo::getEBOutputSCCollection ( )
inline

Definition at line 110 of file PFECALSuperClusterAlgo.h.

References superClustersEB_.

110 { return superClustersEB_; }
std::unique_ptr< reco::SuperClusterCollection > superClustersEB_
std::unique_ptr<reco::SuperClusterCollection>& PFECALSuperClusterAlgo::getEEOutputSCCollection ( )
inline

Definition at line 112 of file PFECALSuperClusterAlgo.h.

References loadAndSortPFClusters(), run(), and superClustersEE_.

112 { return superClustersEE_; }
std::unique_ptr< reco::SuperClusterCollection > superClustersEE_
void PFECALSuperClusterAlgo::loadAndSortPFClusters ( const edm::Event evt)

Definition at line 172 of file PFECALSuperClusterAlgo.cc.

References _clustersEB, _clustersEE, barrelRecHits_, beamSpot_, fastPrimaryVertexProducer_cfi::clusters, PFLayer::ECAL_BARREL, PFLayer::ECAL_ENDCAP, EEtoPS_, endcapRecHits_, Exception, edm::Event::getByToken(), PFLayer::HGCAL, mps_fire::i, inputTagBarrelRecHits_, inputTagBeamSpot_, inputTagEndcapRecHits_, inputTagPFClusters_, inputTagPFClustersES_, isOOTCollection_, edm::HandleBase::isValid(), LogDebug, edm::Handle< T >::product(), regr_, superClustersEB_, superClustersEE_, threshPFClusterBarrel_, threshPFClusterEndcap_, and useRegression_.

Referenced by getEEOutputSCCollection(), and update().

172  {
173 
174  //load input collections
175  //Load the pfcluster collections
176  edm::Handle<edm::View<reco::PFCluster> > pfclustersHandle;
177  iEvent.getByToken( inputTagPFClusters_, pfclustersHandle );
178 
180  iEvent.getByToken( inputTagPFClustersES_, psAssociationHandle);
181 
182  const PFClusterView& clusters = *pfclustersHandle.product();
183  const reco::PFCluster::EEtoPSAssociation& psclusters = *psAssociationHandle.product();
184 
185  //load BeamSpot
187  iEvent.getByToken( inputTagBeamSpot_, bsHandle);
188  beamSpot_ = bsHandle.product();
189 
190  //initialize regression for this event
191  if (useRegression_) {
192  regr_->setEvent(iEvent);
193  }
194 
195  // reset the system for running
196  superClustersEB_ = std::make_unique<reco::SuperClusterCollection>();
197  _clustersEB.clear();
198  superClustersEE_ = std::make_unique<reco::SuperClusterCollection>();
199  _clustersEE.clear();
200  EEtoPS_ = &psclusters;
201 
202  //Select PF clusters available for the clustering
203  for ( size_t i = 0; i < clusters.size(); ++i ){
204  auto cluster = clusters.ptrAt(i);
205  LogDebug("PFClustering")
206  << "Loading PFCluster i="<<cluster.key()
207  <<" energy="<<cluster->energy()<<std::endl;
208 
209  // protection for sim clusters
210  if( cluster->caloID().detectors() == 0 &&
211  cluster->hitsAndFractions().empty() ) continue;
212 
213  CalibratedClusterPtr calib_cluster(new CalibratedPFCluster(cluster));
214  switch( cluster->layer() ) {
216  if( calib_cluster->energy() > threshPFClusterBarrel_ ) {
217  _clustersEB.push_back(calib_cluster);
218  }
219  break;
220  case PFLayer::HGCAL:
221  case PFLayer::ECAL_ENDCAP:
222  if( calib_cluster->energy() > threshPFClusterEndcap_ ) {
223  _clustersEE.push_back(calib_cluster);
224  }
225  break;
226  default:
227  break;
228  }
229  }
230  // sort full cluster collections by their calibrated energy
231  // this will put all the seeds first by construction
232  std::sort(_clustersEB.begin(), _clustersEB.end(), greaterByEt);
233  std::sort(_clustersEE.begin(), _clustersEE.end(), greaterByEt);
234 
235  // set recHit collections for OOT photons
236  if (isOOTCollection_)
237  {
238  edm::Handle<EcalRecHitCollection> barrelRecHitsHandle;
239  iEvent.getByToken(inputTagBarrelRecHits_, barrelRecHitsHandle);
240  if (!barrelRecHitsHandle.isValid()) {
241  throw cms::Exception("PFECALSuperClusterAlgo")
242  << "If you use OOT photons, need to specify proper barrel rec hit collection";
243  }
244  barrelRecHits_ = barrelRecHitsHandle.product();
245 
246  edm::Handle<EcalRecHitCollection> endcapRecHitsHandle;
247  iEvent.getByToken(inputTagEndcapRecHits_, endcapRecHitsHandle);
248  if (!endcapRecHitsHandle.isValid()) {
249  throw cms::Exception("PFECALSuperClusterAlgo")
250  << "If you use OOT photons, need to specify proper endcap rec hit collection";
251  }
252  endcapRecHits_ = endcapRecHitsHandle.product();
253  }
254 }
#define LogDebug(id)
edm::EDGetTokenT< edm::View< reco::PFCluster > > inputTagPFClusters_
std::unique_ptr< SCEnergyCorrectorSemiParm > regr_
std::unique_ptr< reco::SuperClusterCollection > superClustersEB_
edm::EDGetTokenT< EcalRecHitCollection > inputTagBarrelRecHits_
const reco::BeamSpot * beamSpot_
const reco::PFCluster::EEtoPSAssociation * EEtoPS_
std::unique_ptr< reco::SuperClusterCollection > superClustersEE_
edm::EDGetTokenT< EcalRecHitCollection > inputTagEndcapRecHits_
std::shared_ptr< CalibratedPFCluster > CalibratedClusterPtr
int iEvent
Definition: GenABIO.cc:224
std::vector< std::pair< CaloClusterPtr::key_type, edm::Ptr< PFCluster > > > EEtoPSAssociation
Definition: PFCluster.h:50
CalibratedClusterPtrVector _clustersEE
bool isValid() const
Definition: HandleBase.h:74
edm::EDGetTokenT< reco::PFCluster::EEtoPSAssociation > inputTagPFClustersES_
T const * product() const
Definition: Handle.h:74
edm::EDGetTokenT< reco::BeamSpot > inputTagBeamSpot_
const EcalRecHitCollection * barrelRecHits_
CalibratedClusterPtrVector _clustersEB
const EcalRecHitCollection * endcapRecHits_
void PFECALSuperClusterAlgo::run ( )

Definition at line 256 of file PFECALSuperClusterAlgo.cc.

References _clustersEB, _clustersEE, buildAllSuperClusters(), threshPFClusterSeedBarrel_, and threshPFClusterSeedEndcap_.

Referenced by getEEOutputSCCollection().

256  {
257  // clusterize the EB
259  // clusterize the EE
261 }
void buildAllSuperClusters(CalibratedClusterPtrVector &, double seedthresh)
CalibratedClusterPtrVector _clustersEE
CalibratedClusterPtrVector _clustersEB
void PFECALSuperClusterAlgo::setClusteringType ( clustering_type  thetype)
inline

Definition at line 72 of file PFECALSuperClusterAlgo.h.

References _clustype.

72 { _clustype = thetype; }
void PFECALSuperClusterAlgo::setCrackCorrections ( bool  applyCrackCorrections)
inline
void PFECALSuperClusterAlgo::setDropUnseedable ( const bool  d)
inline
void PFECALSuperClusterAlgo::setEnergyWeighting ( energy_weight  thetype)
inline

Definition at line 74 of file PFECALSuperClusterAlgo.h.

References _eweight.

74 { _eweight = thetype; }
void PFECALSuperClusterAlgo::setEtawidthSuperClusterBarrel ( double  etawidth)
inline

Definition at line 90 of file PFECALSuperClusterAlgo.h.

References etawidthSuperClusterBarrel_.

void PFECALSuperClusterAlgo::setEtawidthSuperClusterEndcap ( double  etawidth)
inline
void PFECALSuperClusterAlgo::setIsOOTCollection ( bool  isOOTCollection)
inline
void PFECALSuperClusterAlgo::setMajorityFraction ( const double  f)
inline

Definition at line 98 of file PFECALSuperClusterAlgo.h.

References f, and fractionForMajority_.

double f[11][100]
void PFECALSuperClusterAlgo::setPFClusterCalibration ( const std::shared_ptr< PFEnergyCalibration > &  calib)

Definition at line 125 of file PFECALSuperClusterAlgo.cc.

References _pfEnergyCalibration, and calib.

Referenced by PFECALSuperClusterAlgo(), and setEtawidthSuperClusterEndcap().

125  {
127 }
MVATrainerComputer * calib
Definition: MVATrainer.cc:64
std::shared_ptr< PFEnergyCalibration > _pfEnergyCalibration
void PFECALSuperClusterAlgo::setPhiwidthSuperClusterBarrel ( double  phiwidth)
inline

Definition at line 89 of file PFECALSuperClusterAlgo.h.

References phiwidthSuperClusterBarrel_.

void PFECALSuperClusterAlgo::setPhiwidthSuperClusterEndcap ( double  phiwidth)
inline

Definition at line 91 of file PFECALSuperClusterAlgo.h.

References phiwidthSuperClusterEndcap_.

void PFECALSuperClusterAlgo::setSatelliteMerging ( const bool  doit)
inline

Definition at line 96 of file PFECALSuperClusterAlgo.h.

References doSatelliteClusterMerge_.

void PFECALSuperClusterAlgo::setSatelliteThreshold ( const double  t)
inline
void PFECALSuperClusterAlgo::setThreshPFClusterBarrel ( double  thresh)
inline
void PFECALSuperClusterAlgo::setThreshPFClusterEndcap ( double  thresh)
inline
void PFECALSuperClusterAlgo::setThreshPFClusterSeedBarrel ( double  thresh)
inline
void PFECALSuperClusterAlgo::setThreshPFClusterSeedEndcap ( double  thresh)
inline
void PFECALSuperClusterAlgo::setThreshSuperClusterEt ( double  thresh)
inline
void PFECALSuperClusterAlgo::setTokens ( const edm::ParameterSet iConfig,
edm::ConsumesCollector &&  cc 
)

Definition at line 129 of file PFECALSuperClusterAlgo.cc.

References edm::ParameterSet::getParameter(), inputTagBarrelRecHits_, inputTagBeamSpot_, inputTagEndcapRecHits_, inputTagPFClusters_, inputTagPFClustersES_, isOOTCollection_, regr_, and useRegression_.

Referenced by setCrackCorrections().

129  {
130 
132  cc.consumes<edm::View<reco::PFCluster> >(iConfig.getParameter<edm::InputTag>("PFClusters"));
136  cc.consumes<reco::BeamSpot>(iConfig.getParameter<edm::InputTag>("BeamSpot"));
137 
138  if (useRegression_) {
139  const edm::ParameterSet &regconf = iConfig.getParameter<edm::ParameterSet>("regressionConfig");
140 
141  regr_.reset(new SCEnergyCorrectorSemiParm());
142  regr_->setTokens(regconf, cc);
143  }
144 
145  if (isOOTCollection_) { // OOT photons only
147  cc.consumes<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>("barrelRecHits"));
149  cc.consumes<EcalRecHitCollection>(iConfig.getParameter<edm::InputTag>("endcapRecHits"));
150  }
151 }
EDGetTokenT< ProductType > consumes(edm::InputTag const &tag)
T getParameter(std::string const &) const
edm::EDGetTokenT< edm::View< reco::PFCluster > > inputTagPFClusters_
std::unique_ptr< SCEnergyCorrectorSemiParm > regr_
edm::EDGetTokenT< EcalRecHitCollection > inputTagBarrelRecHits_
edm::EDGetTokenT< EcalRecHitCollection > inputTagEndcapRecHits_
std::vector< std::pair< CaloClusterPtr::key_type, edm::Ptr< PFCluster > > > EEtoPSAssociation
Definition: PFCluster.h:50
edm::EDGetTokenT< reco::PFCluster::EEtoPSAssociation > inputTagPFClustersES_
edm::EDGetTokenT< reco::BeamSpot > inputTagBeamSpot_
void PFECALSuperClusterAlgo::setUseDynamicDPhi ( bool  useit)
inline

Definition at line 78 of file PFECALSuperClusterAlgo.h.

References useDynamicDPhi_.

void PFECALSuperClusterAlgo::setUseETForSeeding ( bool  useET)
inline

Definition at line 76 of file PFECALSuperClusterAlgo.h.

References threshIsET_.

void PFECALSuperClusterAlgo::setUseRegression ( bool  useRegression)
inline
void PFECALSuperClusterAlgo::setVerbosityLevel ( bool  verbose)
inline

Definition at line 70 of file PFECALSuperClusterAlgo.h.

References verbose, and verbose_.

void PFECALSuperClusterAlgo::update ( const edm::EventSetup setup)

Definition at line 153 of file PFECALSuperClusterAlgo.cc.

References _pfEnergyCalibration, channelStatus_, edm::EventSetup::get(), loadAndSortPFClusters(), edm::ESHandle< T >::product(), regr_, and useRegression_.

Referenced by progressbar.ProgressBar::__next__(), MatrixUtil.Matrix::__setitem__(), MatrixUtil.Steps::__setitem__(), Vispa.Gui.VispaWidget.VispaWidget::autosize(), Vispa.Views.LineDecayView.LineDecayContainer::createObject(), Vispa.Views.LineDecayView.LineDecayContainer::deselectAllObjects(), Vispa.Gui.VispaWidgetOwner.VispaWidgetOwner::deselectAllWidgets(), Vispa.Gui.VispaWidget.VispaWidget::enableAutosizing(), progressbar.ProgressBar::finish(), Vispa.Gui.MenuWidget.MenuWidget::leaveEvent(), Vispa.Gui.VispaWidgetOwner.VispaWidgetOwner::mouseMoveEvent(), Vispa.Gui.MenuWidget.MenuWidget::mouseMoveEvent(), Vispa.Views.LineDecayView.LineDecayContainer::mouseMoveEvent(), Vispa.Gui.VispaWidgetOwner.VispaWidgetOwner::mouseReleaseEvent(), Vispa.Views.LineDecayView.LineDecayContainer::objectMoved(), MatrixUtil.Steps::overwrite(), Vispa.Views.LineDecayView.LineDecayContainer::removeObject(), Vispa.Gui.ConnectableWidget.ConnectableWidget::removePorts(), Vispa.Gui.FindDialog.FindDialog::reset(), Vispa.Gui.PortConnection.PointToPointConnection::select(), Vispa.Gui.VispaWidget.VispaWidget::select(), Vispa.Views.LineDecayView.LineDecayContainer::select(), setCrackCorrections(), Vispa.Gui.VispaWidget.VispaWidget::setText(), Vispa.Gui.VispaWidget.VispaWidget::setTitle(), Vispa.Gui.ZoomableWidget.ZoomableWidget::setZoom(), Vispa.Views.LineDecayView.LineDecayContainer::setZoom(), and Vispa.Gui.PortConnection.PointToPointConnection::updateConnection().

153  {
154 
155  if (useRegression_) {
156  regr_->setEventSetup(setup);
157  }
158 
159  edm::ESHandle<ESEEIntercalibConstants> esEEInterCalibHandle_;
160  setup.get<ESEEIntercalibConstantsRcd>().get(esEEInterCalibHandle_);
161  _pfEnergyCalibration->initAlphaGamma_ESplanes_fromDB(esEEInterCalibHandle_.product());
162 
163  edm::ESHandle<ESChannelStatus> esChannelStatusHandle_;
164  setup.get<ESChannelStatusRcd>().get(esChannelStatusHandle_);
165  channelStatus_ = esChannelStatusHandle_.product();
166 
167 }
const ESChannelStatus * channelStatus_
std::unique_ptr< SCEnergyCorrectorSemiParm > regr_
std::shared_ptr< PFEnergyCalibration > _pfEnergyCalibration
T get() const
Definition: EventSetup.h:71
T const * product() const
Definition: ESHandle.h:86

Member Data Documentation

CalibratedClusterPtrVector PFECALSuperClusterAlgo::_clustersEB
private

Definition at line 127 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and run().

CalibratedClusterPtrVector PFECALSuperClusterAlgo::_clustersEE
private

Definition at line 128 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and run().

clustering_type PFECALSuperClusterAlgo::_clustype
private

Definition at line 133 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setClusteringType().

energy_weight PFECALSuperClusterAlgo::_eweight
private

Definition at line 134 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setEnergyWeighting().

std::shared_ptr<PFEnergyCalibration> PFECALSuperClusterAlgo::_pfEnergyCalibration
private

Definition at line 132 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), setPFClusterCalibration(), and update().

bool PFECALSuperClusterAlgo::applyCrackCorrections_
private

Definition at line 164 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setCrackCorrections().

const EcalRecHitCollection* PFECALSuperClusterAlgo::barrelRecHits_
private

Definition at line 171 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and loadAndSortPFClusters().

const reco::BeamSpot* PFECALSuperClusterAlgo::beamSpot_
private

Definition at line 124 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and loadAndSortPFClusters().

const ESChannelStatus* PFECALSuperClusterAlgo::channelStatus_
private

Definition at line 125 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and update().

bool PFECALSuperClusterAlgo::doSatelliteClusterMerge_
private

Definition at line 158 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setSatelliteMerging().

bool PFECALSuperClusterAlgo::dropUnseedable_
private

Definition at line 160 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setDropUnseedable().

const reco::PFCluster::EEtoPSAssociation* PFECALSuperClusterAlgo::EEtoPS_
private

Definition at line 131 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and loadAndSortPFClusters().

const EcalRecHitCollection* PFECALSuperClusterAlgo::endcapRecHits_
private

Definition at line 172 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and loadAndSortPFClusters().

double PFECALSuperClusterAlgo::etawidthSuperClusterBarrel_
private

Definition at line 154 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setEtawidthSuperClusterBarrel().

double PFECALSuperClusterAlgo::etawidthSuperClusterEndcap_
private

Definition at line 156 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setEtawidthSuperClusterEndcap().

double PFECALSuperClusterAlgo::fractionForMajority_
private

Definition at line 159 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setMajorityFraction().

edm::EDGetTokenT<EcalRecHitCollection> PFECALSuperClusterAlgo::inputTagBarrelRecHits_
private

Definition at line 169 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and setTokens().

edm::EDGetTokenT<reco::BeamSpot> PFECALSuperClusterAlgo::inputTagBeamSpot_
private

Definition at line 122 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and setTokens().

edm::EDGetTokenT<EcalRecHitCollection> PFECALSuperClusterAlgo::inputTagEndcapRecHits_
private

Definition at line 170 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and setTokens().

edm::EDGetTokenT<edm::View<reco::PFCluster> > PFECALSuperClusterAlgo::inputTagPFClusters_
private

Definition at line 120 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and setTokens().

edm::EDGetTokenT<reco::PFCluster::EEtoPSAssociation> PFECALSuperClusterAlgo::inputTagPFClustersES_
private

Definition at line 121 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and setTokens().

bool PFECALSuperClusterAlgo::isOOTCollection_
private
double PFECALSuperClusterAlgo::phiwidthSuperClusterBarrel_
private

Definition at line 153 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setPhiwidthSuperClusterBarrel().

double PFECALSuperClusterAlgo::phiwidthSuperClusterEndcap_
private

Definition at line 155 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setPhiwidthSuperClusterEndcap().

std::unique_ptr<SCEnergyCorrectorSemiParm> PFECALSuperClusterAlgo::regr_
private
double PFECALSuperClusterAlgo::satelliteThreshold_
private

Definition at line 159 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setSatelliteThreshold().

std::unique_ptr<reco::SuperClusterCollection> PFECALSuperClusterAlgo::superClustersEB_
private
std::unique_ptr<reco::SuperClusterCollection> PFECALSuperClusterAlgo::superClustersEE_
private
bool PFECALSuperClusterAlgo::threshIsET_
private

Definition at line 165 of file PFECALSuperClusterAlgo.h.

Referenced by buildAllSuperClusters(), and setUseETForSeeding().

double PFECALSuperClusterAlgo::threshPFClusterBarrel_
private

Definition at line 149 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and setThreshPFClusterBarrel().

double PFECALSuperClusterAlgo::threshPFClusterEndcap_
private

Definition at line 151 of file PFECALSuperClusterAlgo.h.

Referenced by loadAndSortPFClusters(), and setThreshPFClusterEndcap().

double PFECALSuperClusterAlgo::threshPFClusterSeedBarrel_
private

Definition at line 148 of file PFECALSuperClusterAlgo.h.

Referenced by run(), and setThreshPFClusterSeedBarrel().

double PFECALSuperClusterAlgo::threshPFClusterSeedEndcap_
private

Definition at line 150 of file PFECALSuperClusterAlgo.h.

Referenced by run(), and setThreshPFClusterSeedEndcap().

double PFECALSuperClusterAlgo::threshSuperClusterEt_
private

Definition at line 146 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setThreshSuperClusterEt().

bool PFECALSuperClusterAlgo::useDynamicDPhi_
private

Definition at line 162 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setUseDynamicDPhi().

bool PFECALSuperClusterAlgo::useRegression_
private
bool PFECALSuperClusterAlgo::verbose_
private

Definition at line 140 of file PFECALSuperClusterAlgo.h.

Referenced by buildSuperCluster(), and setVerbosityLevel().