CMS 3D CMS Logo

List of all members | Public Types | Public Member Functions | Protected Attributes | Static Protected Attributes | Friends
reco::CaloCluster Class Reference

#include <CaloCluster.h>

Inheritance diagram for reco::CaloCluster:
reco::PFCluster reco::PreshowerCluster reco::SuperCluster reco::HGCalMultiCluster reco::PFSuperCluster

Public Types

enum  AlgoId {
  island = 0, hybrid = 1, fixedMatrix = 2, dynamicHybrid = 3,
  multi5x5 = 4, particleFlow = 5, hgcal_em = 6, hgcal_had = 7,
  hgcal_mixed = 8, hfnose = 9, undefined = 1000
}
 
typedef AlgoId AlgoID
 
enum  HCalFlags { badHcalMarker = 1 }
 
enum  SCFlags { cleanOnly = 0, common = 100, uncleanOnly = 200 }
 

Public Member Functions

void addHitAndFraction (DetId id, float fraction)
 
AlgoId algo () const
 algorithm identifier More...
 
AlgoID algoID () const
 
 CaloCluster ()
 default constructor. Sets energy and position to zero More...
 
 CaloCluster (AlgoID algoID)
 constructor with algoId, to be used in all child classes More...
 
 CaloCluster (double energy, const math::XYZPoint &position)
 constructor from values More...
 
 CaloCluster (double energy, const math::XYZPoint &position, const CaloID &caloID)
 
 CaloCluster (double energy, const math::XYZPoint &position, const CaloID &caloID, const AlgoID &algoID, uint32_t flags=0)
 
 CaloCluster (double energy, const math::XYZPoint &position, const CaloID &caloID, const std::vector< std::pair< DetId, float > > &usedHitsAndFractions, const AlgoId algoId, const DetId seedId=DetId(0), uint32_t flags=0)
 
 CaloCluster (double energy, const math::XYZPoint &position, float chi2, const std::vector< DetId > &usedHits, const AlgoId algoId, uint32_t flags=0)
 temporary compatibility constructor More...
 
const CaloIDcaloID () const
 
double correctedEnergy () const
 
float correctedEnergyUncertainty () const
 
double energy () const
 cluster energy More...
 
double eta () const
 pseudorapidity of cluster centroid More...
 
uint32_t flags () const
 
const std::vector< std::pair< DetId, float > > & hitsAndFractions () const
 
bool isInClean () const
 
bool isInUnclean () const
 
bool operator< (const CaloCluster &rhs) const
 comparison < operator More...
 
bool operator<= (const CaloCluster &rhs) const
 comparison <= operator More...
 
bool operator== (const CaloCluster &rhs) const
 comparison == operator More...
 
bool operator> (const CaloCluster &rhs) const
 comparison > operator More...
 
bool operator>= (const CaloCluster &rhs) const
 comparison >= operator More...
 
double phi () const
 azimuthal angle of cluster centroid More...
 
const math::XYZPointposition () const
 cluster centroid position More...
 
std::string printHitAndFraction (unsigned i) const
 print hitAndFraction More...
 
void reset ()
 resets the CaloCluster (position, energy, hitsAndFractions) More...
 
DetId seed () const
 return DetId of seed More...
 
void setAlgoId (const AlgoId &id)
 
void setCaloId (const CaloID &id)
 
void setCorrectedEnergy (double cenergy)
 
void setCorrectedEnergyUncertainty (float energyerr)
 
void setEnergy (double energy)
 
void setFlags (uint32_t flags)
 
void setPosition (const math::XYZPoint &p)
 
void setSeed (const DetId &id)
 
size_t size () const
 size in number of hits (e.g. in crystals for ECAL) More...
 
double x () const
 x coordinate of cluster centroid More...
 
double y () const
 y coordinate of cluster centroid More...
 
double z () const
 z coordinate of cluster centroid More...
 
virtual ~CaloCluster ()
 destructor More...
 

Protected Attributes

AlgoID algoID_
 
CaloID caloID_
 bitmask for detector information More...
 
double correctedEnergy_
 
float correctedEnergyUncertainty_
 
double energy_
 cluster energy More...
 
uint32_t flags_
 
std::vector< std::pair< DetId, float > > hitsAndFractions_
 
math::XYZPoint position_
 cluster centroid position More...
 
DetId seedId_
 DetId of seed. More...
 

Static Protected Attributes

static const uint32_t flagsMask_ = 0x0FFFFFFF
 
static const uint32_t flagsOffset_ = 28
 

Friends

std::ostream & operator<< (std::ostream &out, const CaloCluster &cluster)
 print me More...
 

Detailed Description

Base class for all types calorimeter clusters

Author
Shahram Rahatlou, INFN

Comments: modified AlgoId enumeration to include cleaning status flags In summary: algoID_ < 200 object is in clean collection algoID_ >=100 object is in unclean collection

Definition at line 31 of file CaloCluster.h.

Member Typedef Documentation

◆ AlgoID

Definition at line 54 of file CaloCluster.h.

Member Enumeration Documentation

◆ AlgoId

Enumerator
island 
hybrid 
fixedMatrix 
dynamicHybrid 
multi5x5 
particleFlow 
hgcal_em 
hgcal_had 
hgcal_mixed 
hfnose 
undefined 

Definition at line 33 of file CaloCluster.h.

33  {
34  island = 0,
35  hybrid = 1,
36  fixedMatrix = 2,
37  dynamicHybrid = 3,
38  multi5x5 = 4,
39  particleFlow = 5,
40  hgcal_em = 6,
41  hgcal_had = 7,
42  hgcal_mixed = 8,
43  hfnose = 9,
44  undefined = 1000
45  };

◆ HCalFlags

Enumerator
badHcalMarker 

Definition at line 50 of file CaloCluster.h.

50 { badHcalMarker = 1 };

◆ SCFlags

Enumerator
cleanOnly 
common 
uncleanOnly 

Definition at line 48 of file CaloCluster.h.

48 { cleanOnly = 0, common = 100, uncleanOnly = 200 };

Constructor & Destructor Documentation

◆ CaloCluster() [1/7]

reco::CaloCluster::CaloCluster ( )
inline

default constructor. Sets energy and position to zero

Definition at line 57 of file CaloCluster.h.

◆ CaloCluster() [2/7]

reco::CaloCluster::CaloCluster ( AlgoID  algoID)
inline

constructor with algoId, to be used in all child classes

Definition at line 61 of file CaloCluster.h.

◆ CaloCluster() [3/7]

reco::CaloCluster::CaloCluster ( double  energy,
const math::XYZPoint position,
const CaloID caloID 
)
inline

Definition at line 64 of file CaloCluster.h.

65  : energy_(energy),
66  correctedEnergy_(-1.0),
69  caloID_(caloID),
71  flags_(0) {}

◆ CaloCluster() [4/7]

reco::CaloCluster::CaloCluster ( double  energy,
const math::XYZPoint position 
)
inline

constructor from values

Definition at line 77 of file CaloCluster.h.

78  : energy_(energy),
79  correctedEnergy_(-1.0),
83  flags_(0) {}

◆ CaloCluster() [5/7]

reco::CaloCluster::CaloCluster ( double  energy,
const math::XYZPoint position,
const CaloID caloID,
const AlgoID algoID,
uint32_t  flags = 0 
)
inline

Definition at line 85 of file CaloCluster.h.

87  : energy_(energy),
88  correctedEnergy_(-1.0),
91  caloID_(caloID),
92  algoID_(algoID) {
94  }

References flags(), flags_, and flagsMask_.

◆ CaloCluster() [6/7]

reco::CaloCluster::CaloCluster ( double  energy,
const math::XYZPoint position,
const CaloID caloID,
const std::vector< std::pair< DetId, float > > &  usedHitsAndFractions,
const AlgoId  algoId,
const DetId  seedId = DetId(0),
uint32_t  flags = 0 
)
inline

Definition at line 96 of file CaloCluster.h.

103  : energy_(energy),
104  correctedEnergy_(-1.0),
107  caloID_(caloID),
108  hitsAndFractions_(usedHitsAndFractions),
109  algoID_(algoId),
110  seedId_(seedId) {
111  flags_ = flags & flagsMask_;
112  }

References flags(), flags_, and flagsMask_.

◆ CaloCluster() [7/7]

reco::CaloCluster::CaloCluster ( double  energy,
const math::XYZPoint position,
float  chi2,
const std::vector< DetId > &  usedHits,
const AlgoId  algoId,
uint32_t  flags = 0 
)
inline

temporary compatibility constructor

Definition at line 116 of file CaloCluster.h.

122  : energy_(energy),
123  correctedEnergy_(-1.0),
126  algoID_(algoId) {
127  hitsAndFractions_.reserve(usedHits.size());
128  for (size_t i = 0; i < usedHits.size(); i++)
129  hitsAndFractions_.push_back(std::pair<DetId, float>(usedHits[i], 1.));
130  flags_ = flags & flagsMask_;
131  }

References flags(), flags_, flagsMask_, hitsAndFractions_, and mps_fire::i.

◆ ~CaloCluster()

virtual reco::CaloCluster::~CaloCluster ( )
inlinevirtual

destructor

Definition at line 134 of file CaloCluster.h.

134 {}

Member Function Documentation

◆ addHitAndFraction()

void reco::CaloCluster::addHitAndFraction ( DetId  id,
float  fraction 
)
inline

◆ algo()

AlgoId reco::CaloCluster::algo ( ) const
inline

◆ algoID()

AlgoID reco::CaloCluster::algoID ( ) const
inline

Definition at line 191 of file CaloCluster.h.

191 { return algo(); }

References algo().

Referenced by reco::operator<<().

◆ caloID()

const CaloID& reco::CaloCluster::caloID ( ) const
inline

◆ correctedEnergy()

double reco::CaloCluster::correctedEnergy ( ) const
inline

◆ correctedEnergyUncertainty()

float reco::CaloCluster::correctedEnergyUncertainty ( ) const
inline

Definition at line 151 of file CaloCluster.h.

151 { return correctedEnergyUncertainty_; }

References correctedEnergyUncertainty_.

◆ energy()

double reco::CaloCluster::energy ( ) const
inline

cluster energy

Definition at line 149 of file CaloCluster.h.

149 { return energy_; }

References energy_.

Referenced by ESRecoSummary::analyze(), ElectronCalibration::analyze(), ElectronCalibrationUniv::analyze(), FWCaloClusterProxyBuilder::build(), FWTracksterHitsProxyBuilder::build(), ConversionTrackCandidateProducer::buildCollections(), PFECALSuperClusterAlgo::buildSuperCluster(), ClusterShapeAlgo::calc_AbsZernikeMoment(), EcalClusterToolsT< noZS >::calc_AbsZernikeMoment(), HLTEcalResonanceFilter::calcPaircluster(), HLTRegionalEcalResonanceFilter::calcPaircluster(), ClusterShapeAlgo::Calculate_BarrelBasketEnergyFraction(), SuperClusterShapeAlgo::Calculate_Covariances(), ClusterShapeAlgo::Calculate_EnergyDepTopology(), converter::SuperClusterToCandidate::convert(), EGEnergyCorrector::CorrectedEnergyWithError(), GsfElectronAlgo::createElectron(), TrackingRegionsFromSuperClustersProducer::createTrackingRegion(), egammaisolation::EgammaEcalExtractor::deposit(), egamma::ecalClusterEnergyUncertaintyElectronSpecific(), EcalClusterToolsT< noZS >::energyBasketFractionEta(), EcalClusterToolsT< noZS >::energyBasketFractionPhi(), ticl::PatternRecognitionbyCLUE3D< TILES >::energyRegressionAndID(), ticl::PatternRecognitionbyCA< TILES >::energyRegressionAndID(), TrackstersMergeProducer::energyRegressionAndID(), reco::PreshowerCluster::et(), ClusterShapeAlgo::fast_AbsZernikeMoment(), EcalClusterToolsT< noZS >::fast_AbsZernikeMoment(), ZeeCalibration::fillEleInfo(), PFEGammaAlgo::fillPFCandidates(), EcalClusterSeverityLevelAlgo::fractionAroundClosestProblematic(), EcalClusterIsoCalculator::getBkgSubEcalClusterIso(), EcalClusterIsoCalculator::getEcalClusterIso(), EgammaEcalIsolation::getEcalEtSum(), EcalClusterToolsT< noZS >::getEnergyDepTopology(), SCEnergyCorrectorSemiParm::getRegDataECALV1(), SCEnergyCorrectorSemiParm::getRegDataHGCALV1(), EcalClusterEnergyCorrection::getValue(), EcalClusterEnergyUncertainty::getValue(), EcalClusterCrackCorrection::getValue(), hgcal::ClusterTools::getWidths(), EcalClusterSeverityLevelAlgo::goodFraction(), PFElecTkProducer::isSharingEcalEnergyWithEgSC(), egammaTools::localEcalClusterCoordsEB(), egammaTools::localEcalClusterCoordsEE(), Multi5x5BremRecoveryClusterAlgo::makeIslandSuperClusters(), PreshowerClusterAlgo::makeOneCluster(), OutInConversionSeedFinder::makeSeeds(), HybridClusterAlgo::makeSuperClusters(), EGRegressionModifierV1::modifyObject(), HoECalculator::operator()(), EcalBasicClusterLocalContCorrection::operator()(), reco::PreshowerCluster::operator<(), reco::operator<<(), HFRecoEcalCandidateAlgo::produce(), EcalDigiSelector::produce(), UncleanSCRecoveryProducer::produce(), HiEgammaSCCorrectionMaker::produce(), EgammaSCCorrectionMaker::produce(), UnifiedSCCollectionProducer::produce(), PreshowerPhiClusterProducer::produce(), PreshowerClusterProducer::produce(), Jet.Jet::rawEnergy(), SuperClusterHelper::seedEnergy(), setEnergy(), SuperClusterHelper::sortClusters(), and SuperClusterHelper::SuperClusterHelper().

◆ eta()

double reco::CaloCluster::eta ( ) const
inline

pseudorapidity of cluster centroid

Definition at line 181 of file CaloCluster.h.

181 { return position_.eta(); }

References position_.

Referenced by Particle.Particle::__str__(), EgammaIsoESDetIdCollectionProducer::addDetIds(), ElectronCalibration::analyze(), ConversionTrackCandidateProducer::buildCollections(), HLTEcalResonanceFilter::calcPaircluster(), EgammaSuperClusters::closestMCParticle(), EgammaTowerIsolationNew< NC >::compute(), hgcal::EGammaPCAHelper::computeShowerWidth(), EGEnergyCorrector::CorrectedEnergyWithError(), egammaisolation::EgammaEcalExtractor::deposit(), egamma::ecalClusterEnergyUncertaintyElectronSpecific(), PFEnergyCalibration::energyEm(), ticl::PatternRecognitionbyCLUE3D< TILES >::energyRegressionAndID(), ticl::PatternRecognitionbyCA< TILES >::energyRegressionAndID(), TrackstersMergeProducer::energyRegressionAndID(), EcalClusterLazyToolsBase::eseffsirir(), EcalClusterLazyToolsBase::eseffsixix(), EcalClusterLazyToolsBase::eseffsiyiy(), reco::PreshowerCluster::et(), SuperClusterHelper::eta(), EcalRegressionData::fill(), HGVHistoProducerAlgo::fill_cluster_histos(), EgammaEcalIsolation::getEcalEtSum(), EGRegressionModifierV3::getRegData(), SCEnergyCorrectorSemiParm::getRegDataECALHLTV1(), SCEnergyCorrectorSemiParm::getRegDataECALV1(), SCEnergyCorrectorSemiParm::getRegDataHGCALHLTV1(), SCEnergyCorrectorSemiParm::getRegDataHGCALV1(), EcalClusterEnergyCorrectionObjectSpecific::getValue(), EcalClusterEnergyCorrection::getValue(), EcalClusterEnergyUncertainty::getValue(), EcalClusterCrackCorrection::getValue(), Jet.Jet::jetID(), egammaTools::localEcalClusterCoordsEE(), PreshowerClusterAlgo::makeOneCluster(), EGRegressionModifierV1::modifyObject(), HFRecoEcalCandidateAlgo::produce(), EcalDigiSelector::produce(), UncleanSCRecoveryProducer::produce(), UnifiedSCCollectionProducer::produce(), AlCaECALRecHitReducer::produce(), Jet.Jet::puJetId(), SuperClusterHelper::seedEta(), FWPFBlockProxyBuilder::setupClusterElement(), FWPFClusterLegoProxyBuilder::sharedBuild(), FWECALCaloDataDetailViewBuilder::superClusterEtaLess(), FWECALDetailViewBuilder::superClusterEtaLess(), and SuperClusterHelper::SuperClusterHelper().

◆ flags()

uint32_t reco::CaloCluster::flags ( ) const
inline

Definition at line 193 of file CaloCluster.h.

193 { return flags_ & flagsMask_; }

References flags_, and flagsMask_.

Referenced by CaloCluster(), isInClean(), isInUnclean(), setFlags(), and reco::SuperCluster::setPreshowerPlanesStatus().

◆ hitsAndFractions()

const std::vector<std::pair<DetId, float> >& reco::CaloCluster::hitsAndFractions ( ) const
inline

replace getHitsByDetId() : return hits by DetId and their corresponding fraction of energy considered to compute the total cluster energy

Definition at line 210 of file CaloCluster.h.

210 { return hitsAndFractions_; }

References hitsAndFractions_.

Referenced by FWPFCandidateWithHitsProxyBuilder::addHitsForCandidate(), AlCaECALRecHitReducer::AddMiniRecHitCollection(), ElectronCalibration::analyze(), ElectronCalibrationUniv::analyze(), FWCaloClusterProxyBuilder::build(), FWTracksterHitsProxyBuilder::build(), GenericSimClusterMapper::buildClusters(), PFClusterFromHGCalTrackster::buildClusters(), RealisticSimClusterMapper::buildClusters(), HLTEcalResonanceFilter::calcShowerShape(), HLTRegionalEcalResonanceFilter::calcShowerShape(), PhotonIsolationCalculator::calculate(), ClusterShapeAlgo::Calculate_2ndEnergy(), ClusterShapeAlgo::Calculate_BarrelBasketEnergyFraction(), SuperClusterShapeAlgo::Calculate_Covariances(), ClusterShapeAlgo::Calculate_EnergyDepTopology(), ClusterShapeAlgo::Calculate_TopEnergy(), GsfElectronAlgo::calculateShowerShape(), PhotonIsolationCalculator::classify(), EcalClusterToolsT< noZS >::cluster2ndMoments(), EcalClusterToolsT< noZS >::covariances(), PFElectronTranslator::createBasicCluster(), PFPhotonTranslator::createBasicCluster(), HGCalShowerShapeHelper::createCalc(), GsfElectronAlgo::createElectron(), EcalClusterToolsT< noZS >::e1x3(), EcalClusterToolsT< noZS >::e1x5(), EcalClusterToolsT< noZS >::e2nd(), EcalClusterToolsT< noZS >::e2x2(), EcalClusterToolsT< noZS >::e2x5Bottom(), EcalClusterToolsT< noZS >::e2x5Left(), EcalClusterToolsT< noZS >::e2x5Max(), EcalClusterToolsT< noZS >::e2x5Right(), EcalClusterToolsT< noZS >::e2x5Top(), EcalClusterToolsT< noZS >::e3x1(), EcalClusterToolsT< noZS >::e3x2(), EcalClusterToolsT< noZS >::e3x3(), EcalClusterToolsT< noZS >::e4x4(), EcalClusterToolsT< noZS >::e5x1(), EcalClusterToolsT< noZS >::e5x5(), EcalClusterToolsT< noZS >::eBottom(), EcalClusterToolsT< noZS >::eLeft(), EcalClusterToolsT< noZS >::eMax(), EcalClusterToolsT< noZS >::energyBasketFractionEta(), EcalClusterToolsT< noZS >::energyBasketFractionPhi(), ticl::PatternRecognitionbyCLUE3D< TILES >::energyRegressionAndID(), ticl::PatternRecognitionbyCA< TILES >::energyRegressionAndID(), TrackstersMergeProducer::energyRegressionAndID(), EcalClusterToolsT< noZS >::eRight(), EcalClusterToolsT< noZS >::eTop(), egHLT::OffHelper::fillClusShapeData(), HGVHistoProducerAlgo::findmaxhit(), EcalClusterSeverityLevelAlgo::fractionAroundClosestProblematic(), hgcal::ClusterTools::getClusterHadronFraction(), EcalClusterLazyToolsBase::getEcalRecHitCollection(), EcalClusterToolsT< noZS >::getEnergyDepTopology(), EcalClusterToolsT< noZS >::getMaximum(), SCEnergyCorrectorSemiParm::getRegDataECALHLTV1(), SCEnergyCorrectorSemiParm::getRegDataECALV1(), SCEnergyCorrectorSemiParm::getRegDataHGCALV1(), EcalClusterCrackCorrection::getValue(), hgcal::ClusterTools::getWidths(), EcalClusterSeverityLevelAlgo::goodFraction(), EcalClusterToolsT< noZS >::localCovariances(), egammaTools::localEcalClusterCoordsEB(), egammaTools::localEcalClusterCoordsEE(), EcalClusterToolsT< noZS >::matrixEnergy(), EcalClusterToolsT< noZS >::matrixSize(), EcalClusterToolsT< noZS >::mean5x5PositionInLocalCrysCoord(), EcalClusterToolsT< noZS >::mean5x5PositionInXY(), EcalClusterToolsT< noZS >::meanClusterPosition(), EcalClusterToolsT< noZS >::n5x5(), EcalBasicClusterLocalContCorrection::operator()(), reco::operator<<(), ClusterClusterMapping::overlap(), reco::PreshowerCluster::PreshowerCluster(), HGCalLayerClusterProducer::produce(), EcalClusterToolsT< noZS >::roundnessBarrelSuperClusters(), EcalClusterToolsT< noZS >::roundnessBarrelSuperClustersUserExtended(), EcalClusterToolsT< noZS >::scLocalCovariances(), GsfElectronAlgo::setCutBasedPreselectionFlag(), egamma::sharedEnergy(), FWECALCaloDataDetailViewBuilder::showSuperCluster(), FWECALDetailViewBuilder::showSuperCluster(), hgcal::EGammaPCAHelper::storeRecHits(), and egamma::towerOf().

◆ isInClean()

bool reco::CaloCluster::isInClean ( ) const
inline

Definition at line 198 of file CaloCluster.h.

198 { return flags() < uncleanOnly; }

References flags(), and uncleanOnly.

Referenced by UncleanSCRecoveryProducer::produce(), and UnifiedSCCollectionProducer::produce().

◆ isInUnclean()

bool reco::CaloCluster::isInUnclean ( ) const
inline

Definition at line 199 of file CaloCluster.h.

199 { return flags() >= common; }

References common, and flags().

Referenced by UncleanSCRecoveryProducer::produce(), and UnifiedSCCollectionProducer::produce().

◆ operator<()

bool reco::CaloCluster::operator< ( const CaloCluster rhs) const
inline

comparison < operator

Definition at line 166 of file CaloCluster.h.

166 { return (energy_ < rhs.energy_); }

References energy_.

◆ operator<=()

bool reco::CaloCluster::operator<= ( const CaloCluster rhs) const
inline

comparison <= operator

Definition at line 163 of file CaloCluster.h.

163 { return (energy_ <= rhs.energy_); }

References energy_.

◆ operator==()

bool reco::CaloCluster::operator== ( const CaloCluster rhs) const
inline

comparison == operator

Definition at line 169 of file CaloCluster.h.

169 { return (energy_ == rhs.energy_); };

References energy_.

◆ operator>()

bool reco::CaloCluster::operator> ( const CaloCluster rhs) const
inline

comparison > operator

Definition at line 160 of file CaloCluster.h.

160 { return (energy_ > rhs.energy_); }

References energy_.

◆ operator>=()

bool reco::CaloCluster::operator>= ( const CaloCluster rhs) const
inline

comparison >= operator

Definition at line 157 of file CaloCluster.h.

157 { return (energy_ >= rhs.energy_); }

References energy_.

◆ phi()

double reco::CaloCluster::phi ( ) const
inline

◆ position()

const math::XYZPoint& reco::CaloCluster::position ( ) const
inline

cluster centroid position

Definition at line 154 of file CaloCluster.h.

154 { return position_; }

References position_.

Referenced by ContainmentCorrectionAnalyzer::analyze(), FWCaloClusterProxyBuilder::build(), FWTracksterHitsProxyBuilder::build(), FWTracksterLayersProxyBuilder::build(), ConversionTrackCandidateProducer::buildCollections(), PFECALSuperClusterAlgo::buildSuperCluster(), HLTRegionalEcalResonanceFilter::calcPaircluster(), SuperClusterShapeAlgo::Calculate_Covariances(), ClusterShapeAlgo::Calculate_EnergyDepTopology(), converter::SuperClusterToCandidate::convert(), PFElectronTranslator::createBasicCluster(), PFPhotonTranslator::createBasicCluster(), GsfElectronAlgo::createElectron(), TrackingRegionsFromSuperClustersProducer::createTrackingRegion(), egammaisolation::EgammaEcalExtractor::deposit(), ZeeCalibration::fillEleInfo(), PFEGammaAlgo::fillPFCandidates(), InOutConversionSeedFinder::findSeeds(), EgammaEcalIsolation::getEcalEtSum(), EcalClusterToolsT< noZS >::getEnergyDepTopology(), EgammaHcalIsolation::getHcalESum(), EgammaHcalIsolation::getHcalESumBc(), EgammaHcalIsolation::getHcalEtSum(), EgammaHcalIsolation::getHcalEtSumBc(), EgammaRecHitIsolation::getSum_(), EcalClusterCrackCorrection::getValue(), hgcal::ClusterTools::getWidths(), PFlow2DClusterizerWithTime::growPFClusters(), PFElecTkProducer::isSharingEcalEnergyWithEgSC(), egammaTools::localEcalClusterCoordsEB(), egammaTools::localEcalClusterCoordsEE(), Multi5x5BremRecoveryClusterAlgo::makeIslandSuperClusters(), PreshowerClusterAlgo::makeOneCluster(), OutInConversionSeedFinder::makeSeeds(), HybridClusterAlgo::makeSuperClusters(), ConversionTools::matchesConversion(), EcalBasicClusterLocalContCorrection::operator()(), reco::PreshowerCluster::operator<(), reco::operator<<(), reco::PreshowerCluster::operator==(), UncleanSCRecoveryProducer::produce(), HiEgammaSCCorrectionMaker::produce(), EgammaSCCorrectionMaker::produce(), SimPFProducer::produce(), PFAlgo::reconstructCluster(), KDTreeLinkerPSEcal::searchLinks(), InOutConversionSeedFinder::startSeed(), LinkByRecHit::testECALAndPSByRecHit(), LinkByRecHit::testHFEMAndHFHADByRecHit(), and LinkByRecHit::testTrackAndClusterByRecHit().

◆ printHitAndFraction()

string CaloCluster::printHitAndFraction ( unsigned  i) const

print hitAndFraction

Definition at line 15 of file CaloCluster.cc.

15  {
16  ostringstream out;
17  if (i >= hitsAndFractions().size()) // i >= 0, since i is unsigned
18  out << "out of range " << i;
19  else
20  out << "( " << hitsAndFractions()[i].first << ", " << hitsAndFractions()[i].second << " )";
21  return out.str();
22 }

References mps_fire::i, MillePedeFileConverter_cfg::out, and findQualityFiles::size.

Referenced by reco::operator<<().

◆ reset()

void CaloCluster::reset ( void  )

resets the CaloCluster (position, energy, hitsAndFractions)

Definition at line 9 of file CaloCluster.cc.

9  {
11  energy_ = 0;
12  hitsAndFractions_.clear();
13 }

Referenced by reco::PFCluster::reset().

◆ seed()

DetId reco::CaloCluster::seed ( ) const
inline

◆ setAlgoId()

void reco::CaloCluster::setAlgoId ( const AlgoId id)
inline

Definition at line 144 of file CaloCluster.h.

144 { algoID_ = id; }

References algoID_, and triggerObjects_cff::id.

◆ setCaloId()

void reco::CaloCluster::setCaloId ( const CaloID id)
inline

Definition at line 142 of file CaloCluster.h.

142 { caloID_ = id; }

References caloID_, and triggerObjects_cff::id.

◆ setCorrectedEnergy()

void reco::CaloCluster::setCorrectedEnergy ( double  cenergy)
inline

◆ setCorrectedEnergyUncertainty()

void reco::CaloCluster::setCorrectedEnergyUncertainty ( float  energyerr)
inline

◆ setEnergy()

void reco::CaloCluster::setEnergy ( double  energy)
inline

◆ setFlags()

void reco::CaloCluster::setFlags ( uint32_t  flags)
inline

Definition at line 194 of file CaloCluster.h.

194  {
195  uint32_t reserved = (flags_ & ~flagsMask_);
196  flags_ = (reserved) | (flags & flagsMask_);
197  }

References flags(), flags_, and flagsMask_.

Referenced by HiEgammaSCEnergyCorrectionAlgo::applyCorrection(), UncleanSCRecoveryProducer::produce(), and UnifiedSCCollectionProducer::produce().

◆ setPosition()

void reco::CaloCluster::setPosition ( const math::XYZPoint p)
inline

◆ setSeed()

void reco::CaloCluster::setSeed ( const DetId id)
inline

◆ size()

size_t reco::CaloCluster::size ( void  ) const
inline

◆ x()

double reco::CaloCluster::x ( ) const
inline

◆ y()

double reco::CaloCluster::y ( ) const
inline

◆ z()

double reco::CaloCluster::z ( ) const
inline

Friends And Related Function Documentation

◆ operator<<

std::ostream& operator<< ( std::ostream &  out,
const CaloCluster cluster 
)
friend

print me

Member Data Documentation

◆ algoID_

AlgoID reco::CaloCluster::algoID_
protected

Definition at line 237 of file CaloCluster.h.

Referenced by algo(), and setAlgoId().

◆ caloID_

CaloID reco::CaloCluster::caloID_
protected

bitmask for detector information

Definition at line 231 of file CaloCluster.h.

Referenced by caloID(), setCaloId(), and reco::PFCluster::setLayer().

◆ correctedEnergy_

double reco::CaloCluster::correctedEnergy_
protected

Definition at line 224 of file CaloCluster.h.

Referenced by correctedEnergy(), and setCorrectedEnergy().

◆ correctedEnergyUncertainty_

float reco::CaloCluster::correctedEnergyUncertainty_
protected

Definition at line 225 of file CaloCluster.h.

Referenced by correctedEnergyUncertainty(), and setCorrectedEnergyUncertainty().

◆ energy_

double reco::CaloCluster::energy_
protected

◆ flags_

uint32_t reco::CaloCluster::flags_
protected

flags (e.g. for handling of cleaned/uncleaned SC) 4 most significant bits reserved 28 bits for handling of cleaned/uncleaned

Definition at line 245 of file CaloCluster.h.

Referenced by CaloCluster(), flags(), reco::SuperCluster::getPreshowerPlanesStatus(), setFlags(), and reco::SuperCluster::setPreshowerPlanesStatus().

◆ flagsMask_

const uint32_t reco::CaloCluster::flagsMask_ = 0x0FFFFFFF
staticprotected

◆ flagsOffset_

const uint32_t reco::CaloCluster::flagsOffset_ = 28
staticprotected

◆ hitsAndFractions_

std::vector<std::pair<DetId, float> > reco::CaloCluster::hitsAndFractions_
protected

◆ position_

math::XYZPoint reco::CaloCluster::position_
protected

◆ seedId_

DetId reco::CaloCluster::seedId_
protected

DetId of seed.

Definition at line 240 of file CaloCluster.h.

Referenced by seed(), and setSeed().

reco::CaloCluster::fixedMatrix
Definition: CaloCluster.h:36
reco::CaloCluster::size
size_t size() const
size in number of hits (e.g. in crystals for ECAL)
Definition: CaloCluster.h:187
mps_fire.i
i
Definition: mps_fire.py:428
reco::CaloCluster::hybrid
Definition: CaloCluster.h:35
reco::CaloCluster::seedId_
DetId seedId_
DetId of seed.
Definition: CaloCluster.h:240
reco::CaloCluster::hitsAndFractions_
std::vector< std::pair< DetId, float > > hitsAndFractions_
Definition: CaloCluster.h:234
reco::CaloCluster::flagsMask_
static const uint32_t flagsMask_
Definition: CaloCluster.h:247
reco::CaloCluster::position_
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:228
reco::CaloCluster::flags
uint32_t flags() const
Definition: CaloCluster.h:193
reco::CaloCluster::caloID_
CaloID caloID_
bitmask for detector information
Definition: CaloCluster.h:231
HLT_FULL_cff.fraction
fraction
Definition: HLT_FULL_cff.py:52823
reco::CaloCluster::multi5x5
Definition: CaloCluster.h:38
reco::CaloCluster::badHcalMarker
Definition: CaloCluster.h:50
reco::CaloCluster::undefined
Definition: CaloCluster.h:44
reco::CaloCluster::hfnose
Definition: CaloCluster.h:43
math::XYZPoint
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12
AlCaHLTBitMon_ParallelJobs.p
def p
Definition: AlCaHLTBitMon_ParallelJobs.py:153
reco::CaloCluster::correctedEnergyUncertainty_
float correctedEnergyUncertainty_
Definition: CaloCluster.h:225
reco::CaloCluster::hitsAndFractions
const std::vector< std::pair< DetId, float > > & hitsAndFractions() const
Definition: CaloCluster.h:210
reco::CaloCluster::particleFlow
Definition: CaloCluster.h:39
reco::CaloCluster::algoID_
AlgoID algoID_
Definition: CaloCluster.h:237
reco::CaloCluster::common
Definition: CaloCluster.h:48
reco::CaloCluster::hgcal_had
Definition: CaloCluster.h:41
reco::CaloCluster::algoID
AlgoID algoID() const
Definition: CaloCluster.h:191
reco::CaloCluster::island
Definition: CaloCluster.h:34
reco::CaloCluster::position
const math::XYZPoint & position() const
cluster centroid position
Definition: CaloCluster.h:154
reco::CaloCluster::uncleanOnly
Definition: CaloCluster.h:48
reco::CaloCluster::hgcal_mixed
Definition: CaloCluster.h:42
triggerObjects_cff.id
id
Definition: triggerObjects_cff.py:29
reco::CaloCluster::algo
AlgoId algo() const
algorithm identifier
Definition: CaloCluster.h:190
reco::CaloCluster::energy_
double energy_
cluster energy
Definition: CaloCluster.h:223
reco::CaloCluster::dynamicHybrid
Definition: CaloCluster.h:37
reco::CaloCluster::caloID
const CaloID & caloID() const
Definition: CaloCluster.h:201
MillePedeFileConverter_cfg.out
out
Definition: MillePedeFileConverter_cfg.py:31
reco::CaloCluster::correctedEnergy_
double correctedEnergy_
Definition: CaloCluster.h:224
reco::CaloCluster::cleanOnly
Definition: CaloCluster.h:48
reco::CaloCluster::hgcal_em
Definition: CaloCluster.h:40
reco::CaloCluster::flags_
uint32_t flags_
Definition: CaloCluster.h:245
reco::CaloCluster::energy
double energy() const
cluster energy
Definition: CaloCluster.h:149
HLTEgPhaseIITestSequence_cff.algoId
algoId
Definition: HLTEgPhaseIITestSequence_cff.py:2167
common
Definition: common.py:1