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,
  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, const CaloID &caloID)
 
 CaloCluster (double energy, const math::XYZPoint &position)
 constructor from values More...
 
 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 53 of file CaloCluster.h.

Member Enumeration Documentation

◆ AlgoId

Enumerator
island 
hybrid 
fixedMatrix 
dynamicHybrid 
multi5x5 
particleFlow 
hgcal_em 
hgcal_had 
hfnose 
undefined 

Definition at line 33 of file CaloCluster.h.

◆ HCalFlags

Enumerator
badHcalMarker 

Definition at line 49 of file CaloCluster.h.

◆ SCFlags

Enumerator
cleanOnly 
common 
uncleanOnly 

Definition at line 47 of file CaloCluster.h.

Constructor & Destructor Documentation

◆ CaloCluster() [1/7]

reco::CaloCluster::CaloCluster ( )
inline

default constructor. Sets energy and position to zero

Definition at line 56 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 60 of file CaloCluster.h.

double energy_
cluster energy
Definition: CaloCluster.h:222
double correctedEnergy_
Definition: CaloCluster.h:223
float correctedEnergyUncertainty_
Definition: CaloCluster.h:224
AlgoID algoID() const
Definition: CaloCluster.h:190

◆ CaloCluster() [3/7]

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

Definition at line 63 of file CaloCluster.h.

64  : energy_(energy),
65  correctedEnergy_(-1.0),
68  caloID_(caloID),
70  flags_(0) {}
const math::XYZPoint & position() const
cluster centroid position
Definition: CaloCluster.h:153
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227
CaloID caloID_
bitmask for detector information
Definition: CaloCluster.h:230
double energy_
cluster energy
Definition: CaloCluster.h:222
double correctedEnergy_
Definition: CaloCluster.h:223
float correctedEnergyUncertainty_
Definition: CaloCluster.h:224
const CaloID & caloID() const
Definition: CaloCluster.h:200
double energy() const
cluster energy
Definition: CaloCluster.h:148

◆ CaloCluster() [4/7]

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

constructor from values

Definition at line 76 of file CaloCluster.h.

77  : energy_(energy),
78  correctedEnergy_(-1.0),
82  flags_(0) {}
const math::XYZPoint & position() const
cluster centroid position
Definition: CaloCluster.h:153
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227
double energy_
cluster energy
Definition: CaloCluster.h:222
double correctedEnergy_
Definition: CaloCluster.h:223
float correctedEnergyUncertainty_
Definition: CaloCluster.h:224
double energy() const
cluster energy
Definition: CaloCluster.h:148

◆ 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 84 of file CaloCluster.h.

References flags(), flags_, and flagsMask_.

86  : energy_(energy),
87  correctedEnergy_(-1.0),
90  caloID_(caloID),
91  algoID_(algoID) {
93  }
const math::XYZPoint & position() const
cluster centroid position
Definition: CaloCluster.h:153
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227
uint32_t flags() const
Definition: CaloCluster.h:192
CaloID caloID_
bitmask for detector information
Definition: CaloCluster.h:230
double energy_
cluster energy
Definition: CaloCluster.h:222
double correctedEnergy_
Definition: CaloCluster.h:223
float correctedEnergyUncertainty_
Definition: CaloCluster.h:224
const CaloID & caloID() const
Definition: CaloCluster.h:200
double energy() const
cluster energy
Definition: CaloCluster.h:148
static const uint32_t flagsMask_
Definition: CaloCluster.h:246
AlgoID algoID() const
Definition: CaloCluster.h:190

◆ 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 95 of file CaloCluster.h.

References flags(), flags_, and flagsMask_.

102  : energy_(energy),
103  correctedEnergy_(-1.0),
106  caloID_(caloID),
107  hitsAndFractions_(usedHitsAndFractions),
108  algoID_(algoId),
109  seedId_(seedId) {
110  flags_ = flags & flagsMask_;
111  }
const math::XYZPoint & position() const
cluster centroid position
Definition: CaloCluster.h:153
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227
uint32_t flags() const
Definition: CaloCluster.h:192
CaloID caloID_
bitmask for detector information
Definition: CaloCluster.h:230
double energy_
cluster energy
Definition: CaloCluster.h:222
double correctedEnergy_
Definition: CaloCluster.h:223
float correctedEnergyUncertainty_
Definition: CaloCluster.h:224
const CaloID & caloID() const
Definition: CaloCluster.h:200
DetId seedId_
DetId of seed.
Definition: CaloCluster.h:239
std::vector< std::pair< DetId, float > > hitsAndFractions_
Definition: CaloCluster.h:233
double energy() const
cluster energy
Definition: CaloCluster.h:148
static const uint32_t flagsMask_
Definition: CaloCluster.h:246

◆ 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 115 of file CaloCluster.h.

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

121  : energy_(energy),
122  correctedEnergy_(-1.0),
125  algoID_(algoId) {
126  hitsAndFractions_.reserve(usedHits.size());
127  for (size_t i = 0; i < usedHits.size(); i++)
128  hitsAndFractions_.push_back(std::pair<DetId, float>(usedHits[i], 1.));
129  flags_ = flags & flagsMask_;
130  }
const math::XYZPoint & position() const
cluster centroid position
Definition: CaloCluster.h:153
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227
uint32_t flags() const
Definition: CaloCluster.h:192
double energy_
cluster energy
Definition: CaloCluster.h:222
double correctedEnergy_
Definition: CaloCluster.h:223
float correctedEnergyUncertainty_
Definition: CaloCluster.h:224
std::vector< std::pair< DetId, float > > hitsAndFractions_
Definition: CaloCluster.h:233
double energy() const
cluster energy
Definition: CaloCluster.h:148
static const uint32_t flagsMask_
Definition: CaloCluster.h:246

◆ ~CaloCluster()

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

destructor

Definition at line 133 of file CaloCluster.h.

133 {}

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 190 of file CaloCluster.h.

References algo().

Referenced by reco::operator<<().

190 { return algo(); }
AlgoId algo() const
algorithm identifier
Definition: CaloCluster.h:189

◆ caloID()

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

◆ correctedEnergy()

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

Definition at line 149 of file CaloCluster.h.

References correctedEnergy_.

Referenced by CalibratedPFCluster::energy(), EcalRegressionData::fill(), and reco::operator<<().

149 { return correctedEnergy_; }
double correctedEnergy_
Definition: CaloCluster.h:223

◆ correctedEnergyUncertainty()

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

Definition at line 150 of file CaloCluster.h.

References correctedEnergyUncertainty_.

150 { return correctedEnergyUncertainty_; }
float correctedEnergyUncertainty_
Definition: CaloCluster.h:224

◆ energy()

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

cluster energy

Definition at line 148 of file CaloCluster.h.

References energy_.

Referenced by ESRecoSummary::analyze(), ElectronCalibration::analyze(), ElectronCalibrationUniv::analyze(), FWCaloClusterProxyBuilder::build(), FWTracksterHitsProxyBuilder::build(), FWTracksterLayersProxyBuilder::build(), ConversionTrackCandidateProducer::buildCollections(), ClusterShapeAlgo::calc_AbsZernikeMoment(), EcalClusterToolsT< noZS >::calc_AbsZernikeMoment(), HLTEcalResonanceFilter::calcPaircluster(), HLTRegionalEcalResonanceFilter::calcPaircluster(), ClusterShapeAlgo::Calculate_BarrelBasketEnergyFraction(), SuperClusterShapeAlgo::Calculate_Covariances(), ClusterShapeAlgo::Calculate_EnergyDepTopology(), reco::EcalClustersGraph::computeCovariances(), reco::EcalClustersGraph::computeShowerShapes(), reco::EcalClustersGraph::computeVariables(), 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(), ticl::PatternRecognitionbyFastJet< TILES >::energyRegressionAndID(), TrackstersMergeProducerV3::energyRegressionAndID(), TrackstersMergeProducer::energyRegressionAndID(), reco::PreshowerCluster::et(), ClusterShapeAlgo::fast_AbsZernikeMoment(), EcalClusterToolsT< noZS >::fast_AbsZernikeMoment(), ZeeCalibration::fillEleInfo(), PFEGammaAlgo::fillPFCandidates(), PFECALSuperClusterAlgo::finalizeSuperCluster(), 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(), 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().

148 { return energy_; }
double energy_
cluster energy
Definition: CaloCluster.h:222

◆ eta()

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

pseudorapidity of cluster centroid

Definition at line 180 of file CaloCluster.h.

References position_.

Referenced by Particle.Particle::__str__(), EgammaIsoESDetIdCollectionProducer::addDetIds(), ElectronCalibration::analyze(), ConversionTrackCandidateProducer::buildCollections(), HLTEcalResonanceFilter::calcPaircluster(), EgammaSuperClusters::closestMCParticle(), EgammaTowerIsolationNew< NC >::compute(), hgcal::EGammaPCAHelper::computeShowerWidth(), reco::EcalClustersGraph::computeVariables(), EGEnergyCorrector::CorrectedEnergyWithError(), datamodel.Object::DeltaR(), egammaisolation::EgammaEcalExtractor::deposit(), egamma::ecalClusterEnergyUncertaintyElectronSpecific(), PFEnergyCalibration::energyEm(), ticl::PatternRecognitionbyCLUE3D< TILES >::energyRegressionAndID(), ticl::PatternRecognitionbyCA< TILES >::energyRegressionAndID(), ticl::PatternRecognitionbyFastJet< TILES >::energyRegressionAndID(), TrackstersMergeProducerV3::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(), EcalClusterEnergyCorrection::getValue(), EcalClusterEnergyCorrectionObjectSpecific::getValue(), EcalClusterEnergyUncertainty::getValue(), EcalClusterCrackCorrection::getValue(), Jet.Jet::jetID(), egammaTools::localEcalClusterCoordsEE(), PreshowerClusterAlgo::makeOneCluster(), EGRegressionModifierV1::modifyObject(), datamodel.Object::p4(), 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().

180 { return position_.eta(); }
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227

◆ flags()

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

Definition at line 192 of file CaloCluster.h.

References flags_, and flagsMask_.

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

192 { return flags_ & flagsMask_; }
static const uint32_t flagsMask_
Definition: CaloCluster.h:246

◆ 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 209 of file CaloCluster.h.

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(), reco::EcalClustersGraph::computeCovariances(), reco::EcalClustersGraph::computeShowerShapes(), reco::EcalClustersGraph::computeVariables(), EcalClusterToolsT< noZS >::covariances(), PFElectronTranslator::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(), ticl::PatternRecognitionbyFastJet< TILES >::energyRegressionAndID(), TrackstersMergeProducerV3::energyRegressionAndID(), TrackstersMergeProducer::energyRegressionAndID(), EcalClusterToolsT< noZS >::eRight(), EcalClusterToolsT< noZS >::eTop(), egHLT::OffHelper::fillClusShapeData(), reco::EcalClustersGraph::fillHits(), 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().

209 { return hitsAndFractions_; }
std::vector< std::pair< DetId, float > > hitsAndFractions_
Definition: CaloCluster.h:233

◆ isInClean()

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

Definition at line 197 of file CaloCluster.h.

References flags(), and uncleanOnly.

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

197 { return flags() < uncleanOnly; }
uint32_t flags() const
Definition: CaloCluster.h:192

◆ isInUnclean()

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

Definition at line 198 of file CaloCluster.h.

References common, and flags().

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

198 { return flags() >= common; }
uint32_t flags() const
Definition: CaloCluster.h:192

◆ operator<()

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

comparison < operator

Definition at line 165 of file CaloCluster.h.

References energy_.

165 { return (energy_ < rhs.energy_); }
double energy_
cluster energy
Definition: CaloCluster.h:222

◆ operator<=()

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

comparison <= operator

Definition at line 162 of file CaloCluster.h.

References energy_.

162 { return (energy_ <= rhs.energy_); }
double energy_
cluster energy
Definition: CaloCluster.h:222

◆ operator==()

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

comparison == operator

Definition at line 168 of file CaloCluster.h.

References energy_.

168 { return (energy_ == rhs.energy_); };
double energy_
cluster energy
Definition: CaloCluster.h:222

◆ operator>()

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

comparison > operator

Definition at line 159 of file CaloCluster.h.

References energy_.

159 { return (energy_ > rhs.energy_); }
double energy_
cluster energy
Definition: CaloCluster.h:222

◆ operator>=()

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

comparison >= operator

Definition at line 156 of file CaloCluster.h.

References energy_.

156 { return (energy_ >= rhs.energy_); }
double energy_
cluster energy
Definition: CaloCluster.h:222

◆ phi()

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

azimuthal angle of cluster centroid

Definition at line 183 of file CaloCluster.h.

References position_.

Referenced by Particle.Particle::__str__(), EgammaIsoESDetIdCollectionProducer::addDetIds(), HLTEcalResonanceFilter::calcPaircluster(), EgammaSuperClusters::closestMCParticle(), EgammaTowerIsolationNew< NC >::compute(), hgcal::EGammaPCAHelper::computeShowerWidth(), reco::EcalClustersGraph::computeVariables(), EGEnergyCorrector::CorrectedEnergyWithError(), datamodel.Object::DeltaR(), egammaisolation::EgammaEcalExtractor::deposit(), PFEnergyCalibration::energyEm(), ticl::PatternRecognitionbyCLUE3D< TILES >::energyRegressionAndID(), ticl::PatternRecognitionbyCA< TILES >::energyRegressionAndID(), ticl::PatternRecognitionbyFastJet< TILES >::energyRegressionAndID(), TrackstersMergeProducerV3::energyRegressionAndID(), TrackstersMergeProducer::energyRegressionAndID(), EcalRegressionData::fill(), EGRegressionModifierV3::getRegData(), SCEnergyCorrectorSemiParm::getRegDataECALV1(), SCEnergyCorrectorSemiParm::getRegDataHGCALV1(), PreshowerClusterAlgo::makeOneCluster(), EGRegressionModifierV1::modifyObject(), reco::PreshowerCluster::operator==(), datamodel.Object::p4(), SuperClusterHelper::phi(), ntupleDataFormat.Track::phiPull(), HFRecoEcalCandidateAlgo::produce(), SuperClusterHelper::seedPhi(), FWPFBlockProxyBuilder::setupClusterElement(), FWPFClusterLegoProxyBuilder::sharedBuild(), and SuperClusterHelper::SuperClusterHelper().

183 { return position_.phi(); }
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227

◆ position()

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

cluster centroid position

Definition at line 153 of file CaloCluster.h.

References position_.

Referenced by ContainmentCorrectionAnalyzer::analyze(), FWCaloClusterProxyBuilder::build(), FWTracksterHitsProxyBuilder::build(), FWTracksterLayersProxyBuilder::build(), ConversionTrackCandidateProducer::buildCollections(), HLTRegionalEcalResonanceFilter::calcPaircluster(), SuperClusterShapeAlgo::Calculate_Covariances(), ClusterShapeAlgo::Calculate_EnergyDepTopology(), reco::EcalClustersGraph::clusterPosition(), reco::EcalClustersGraph::computeCovariances(), converter::SuperClusterToCandidate::convert(), PFElectronTranslator::createBasicCluster(), GsfElectronAlgo::createElectron(), TrackingRegionsFromSuperClustersProducer::createTrackingRegion(), egammaisolation::EgammaEcalExtractor::deposit(), ZeeCalibration::fillEleInfo(), PFEGammaAlgo::fillPFCandidates(), PFECALSuperClusterAlgo::finalizeSuperCluster(), 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().

153 { return position_; }
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227

◆ printHitAndFraction()

string CaloCluster::printHitAndFraction ( unsigned  i) const

print hitAndFraction

Definition at line 15 of file CaloCluster.cc.

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

Referenced by reco::operator<<().

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 }
const std::vector< std::pair< DetId, float > > & hitsAndFractions() const
Definition: CaloCluster.h:209
size_t size() const
size in number of hits (e.g. in crystals for ECAL)
Definition: CaloCluster.h:186

◆ reset()

void CaloCluster::reset ( void  )

resets the CaloCluster (position, energy, hitsAndFractions)

Definition at line 9 of file CaloCluster.cc.

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

9  {
11  energy_ = 0;
12  hitsAndFractions_.clear();
13 }
math::XYZPoint position_
cluster centroid position
Definition: CaloCluster.h:227
double energy_
cluster energy
Definition: CaloCluster.h:222
std::vector< std::pair< DetId, float > > hitsAndFractions_
Definition: CaloCluster.h:233
XYZPointD XYZPoint
point in space with cartesian internal representation
Definition: Point3D.h:12

◆ seed()

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

◆ setAlgoId()

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

Definition at line 143 of file CaloCluster.h.

References algoID_, and l1ctLayer2EG_cff::id.

◆ setCaloId()

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

Definition at line 141 of file CaloCluster.h.

References caloID_, and l1ctLayer2EG_cff::id.

141 { caloID_ = id; }
CaloID caloID_
bitmask for detector information
Definition: CaloCluster.h:230

◆ 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 193 of file CaloCluster.h.

References flags(), flags_, and flagsMask_.

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

193  {
194  uint32_t reserved = (flags_ & ~flagsMask_);
195  flags_ = (reserved) | (flags & flagsMask_);
196  }
uint32_t flags() const
Definition: CaloCluster.h:192
static const uint32_t flagsMask_
Definition: CaloCluster.h:246

◆ 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

size in number of hits (e.g. in crystals for ECAL)

Definition at line 186 of file CaloCluster.h.

References hitsAndFractions_.

Referenced by ntupleDataFormat._Collection::__iter__(), ntupleDataFormat._Collection::__len__(), FWTracksterLayersProxyBuilder::build(), EcalClusterLazyToolsBase::getEcalRecHitCollection(), and HGCalLayerClusterProducer::produce().

186 { return hitsAndFractions_.size(); }
std::vector< std::pair< DetId, float > > hitsAndFractions_
Definition: CaloCluster.h:233

◆ 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 236 of file CaloCluster.h.

Referenced by algo(), and setAlgoId().

◆ caloID_

CaloID reco::CaloCluster::caloID_
protected

bitmask for detector information

Definition at line 230 of file CaloCluster.h.

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

◆ correctedEnergy_

double reco::CaloCluster::correctedEnergy_
protected

Definition at line 223 of file CaloCluster.h.

Referenced by correctedEnergy(), and setCorrectedEnergy().

◆ correctedEnergyUncertainty_

float reco::CaloCluster::correctedEnergyUncertainty_
protected

Definition at line 224 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 244 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 239 of file CaloCluster.h.

Referenced by seed(), and setSeed().