CMS 3D CMS Logo

List of all members | Classes | Public Member Functions | Private Member Functions | Private Attributes
EGRegressionModifierV3 Class Reference
Inheritance diagram for EGRegressionModifierV3:
ModifyObjectValueBase

Classes

struct  EleRegs
 
struct  PhoRegs
 

Public Member Functions

 EGRegressionModifierV3 (const edm::ParameterSet &conf, edm::ConsumesCollector &cc)
 
void modifyObject (reco::GsfElectron &) const final
 
void modifyObject (reco::Photon &) const final
 
void modifyObject (pat::Electron &) const final
 
void modifyObject (pat::Photon &) const final
 
void setEvent (const edm::Event &) final
 
void setEventContent (const edm::EventSetup &) final
 
 ~EGRegressionModifierV3 () override
 
- Public Member Functions inherited from ModifyObjectValueBase
virtual void modifyObject (reco::Muon &) const
 
virtual void modifyObject (reco::BaseTau &) const
 
virtual void modifyObject (reco::Jet &) const
 
virtual void modifyObject (pat::Muon &) const
 
virtual void modifyObject (pat::Tau &) const
 
virtual void modifyObject (pat::Jet &) const
 
 ModifyObjectValueBase (const edm::ParameterSet &conf)
 
const std::string & name () const
 
virtual ~ModifyObjectValueBase ()
 

Private Member Functions

std::array< float, 32 > getRegData (const reco::GsfElectron &ele) const
 
std::array< float, 32 > getRegData (const reco::Photon &pho) const
 
void getSeedCrysCoord (const reco::CaloCluster &clus, int &iEtaOrX, int &iPhiOrY) const
 

Private Attributes

edm::ESHandle< CaloGeometrycaloGeomHandle_
 
edm::ESGetToken< CaloGeometry, CaloGeometryRecordcaloGeomToken_
 
std::unique_ptr< EleRegseleRegs_
 
float maxRawEnergyForLowPtEBSigma_
 
float maxRawEnergyForLowPtEESigma_
 
std::unique_ptr< PhoRegsphoRegs_
 
edm::EDGetTokenT< double > rhoToken_
 
float rhoValue_
 
bool useBuggedHOverE_
 
bool useClosestToCentreSeedCrysDef_
 

Detailed Description

Definition at line 22 of file EGRegressionModifierV3.cc.

Constructor & Destructor Documentation

◆ EGRegressionModifierV3()

EGRegressionModifierV3::EGRegressionModifierV3 ( const edm::ParameterSet conf,
edm::ConsumesCollector cc 
)

Definition at line 73 of file EGRegressionModifierV3.cc.

References caloGeomToken_, gpuPixelDoublets::cc, eleRegs_, edm::ParameterSet::exists(), edm::ParameterSet::getParameterSet(), phoRegs_, and useClosestToCentreSeedCrysDef_.

74  : ModifyObjectValueBase(conf),
75  rhoValue_(0.),
76  rhoToken_(cc.consumes(conf.getParameter<edm::InputTag>("rhoTag"))),
77  useClosestToCentreSeedCrysDef_(conf.getParameter<bool>("useClosestToCentreSeedCrysDef")),
78  useBuggedHOverE_(conf.getParameter<bool>("useBuggedHOverE")),
79  maxRawEnergyForLowPtEBSigma_(conf.getParameter<double>("maxRawEnergyForLowPtEBSigma")),
80  maxRawEnergyForLowPtEESigma_(conf.getParameter<double>("maxRawEnergyForLowPtEESigma")) {
81  if (conf.exists("eleRegs")) {
82  eleRegs_ = std::make_unique<EleRegs>(conf.getParameterSet("eleRegs"), cc);
83  }
84  if (conf.exists("phoRegs")) {
85  phoRegs_ = std::make_unique<PhoRegs>(conf.getParameterSet("phoRegs"), cc);
86  }
88  caloGeomToken_ = cc.esConsumes();
89  }
90 }
T getParameter(std::string const &) const
Definition: ParameterSet.h:307
uint32_t cc[maxCellsPerHit]
Definition: gpuFishbone.h:49
edm::EDGetTokenT< double > rhoToken_
bool exists(std::string const &parameterName) const
checks if a parameter exists
ParameterSet const & getParameterSet(std::string const &) const
std::unique_ptr< PhoRegs > phoRegs_
ModifyObjectValueBase(const edm::ParameterSet &conf)
edm::ESGetToken< CaloGeometry, CaloGeometryRecord > caloGeomToken_
std::unique_ptr< EleRegs > eleRegs_

◆ ~EGRegressionModifierV3()

EGRegressionModifierV3::~EGRegressionModifierV3 ( )
override

Definition at line 92 of file EGRegressionModifierV3.cc.

92 {}

Member Function Documentation

◆ getRegData() [1/2]

std::array< float, 32 > EGRegressionModifierV3::getRegData ( const reco::GsfElectron ele) const
private

Definition at line 205 of file EGRegressionModifierV3.cc.

References funct::abs(), data, reco::deltaPhi(), reco::GsfElectron::ShowerShape::e5x5, reco::CaloCluster::eta(), reco::GsfElectron::full5x5_hcalOverEcalBc(), reco::GsfElectron::full5x5_showerShape(), getSeedCrysCoord(), reco::GsfElectron::hcalOverEcalBc(), l1tPhase2CaloJetEmulator_cfi::iEta, electrons_cff::isEB, reco::GsfElectron::isEB(), WZElectronSkims53X_cff::max, reco::GsfElectron::nSaturatedXtals(), electrons_cff::numberOfClusters, reco::CaloCluster::phi(), egamma_custom_cff::rawEnergy, rhoValue_, reco::GsfElectron::superCluster(), and useBuggedHOverE_.

Referenced by modifyObject().

205  {
206  std::array<float, 32> data;
207 
208  const reco::SuperClusterRef& superClus = ele.superCluster();
209  const edm::Ptr<reco::CaloCluster>& seedClus = superClus->seed();
210 
211  const bool isEB = ele.isEB();
212  const double rawEnergy = superClus->rawEnergy();
213  const double rawESEnergy = superClus->preshowerEnergy();
214  const int numberOfClusters = superClus->clusters().size();
215  const auto& ssFull5x5 = ele.full5x5_showerShape();
216 
217  float e5x5Inverse = ssFull5x5.e5x5 != 0. ? vdt::fast_inv(ssFull5x5.e5x5) : 0.;
218 
219  data[0] = rawEnergy;
220  data[1] = superClus->etaWidth();
221  data[2] = superClus->phiWidth();
222  data[3] = superClus->seed()->energy() / rawEnergy;
223  data[4] = ssFull5x5.e5x5 / rawEnergy;
224  //the full5x5 is not regression corrected and thus is the correct one to use
226  data[6] = rhoValue_;
227  data[7] = seedClus->eta() - superClus->position().Eta();
228  data[8] = reco::deltaPhi(seedClus->phi(), superClus->position().Phi());
229  data[9] = ssFull5x5.r9;
230  data[10] = ssFull5x5.sigmaIetaIeta;
231  data[11] = ssFull5x5.sigmaIetaIphi;
232  data[12] = ssFull5x5.sigmaIphiIphi;
233  data[13] = ssFull5x5.eMax * e5x5Inverse;
234  data[14] = ssFull5x5.e2nd * e5x5Inverse;
235  data[15] = ssFull5x5.eTop * e5x5Inverse;
236  data[16] = ssFull5x5.eBottom * e5x5Inverse;
237  data[17] = ssFull5x5.eLeft * e5x5Inverse;
238  data[18] = ssFull5x5.eRight * e5x5Inverse;
239  data[19] = ssFull5x5.e2x5Max * e5x5Inverse;
240  data[20] = ssFull5x5.e2x5Left * e5x5Inverse;
241  data[21] = ssFull5x5.e2x5Right * e5x5Inverse;
242  data[22] = ssFull5x5.e2x5Top * e5x5Inverse;
243  data[23] = ssFull5x5.e2x5Bottom * e5x5Inverse;
244  data[24] = ele.nSaturatedXtals();
245  data[25] = std::max(0, numberOfClusters);
246 
247  if (isEB) {
248  int iEta, iPhi;
249  getSeedCrysCoord(*seedClus, iEta, iPhi);
250  int signIEta = iEta > 0 ? +1 : -1;
251  data[26] = iEta;
252  data[27] = iPhi;
253  data[28] = (iEta - signIEta) % 5;
254  data[29] = (iPhi - 1) % 2;
255  const int iEtaCorr = iEta - (iEta > 0 ? +1 : -1);
256  const int iEtaCorr26 = iEta - (iEta > 0 ? +26 : -26);
257  data[30] = std::abs(iEta) <= 25 ? iEtaCorr % 20 : iEtaCorr26 % 20;
258  data[31] = (iPhi - 1) % 20;
259  } else {
260  int iX, iY;
261  getSeedCrysCoord(*seedClus, iX, iY);
262  data[26] = iX;
263  data[27] = iY;
264  data[28] = rawESEnergy / rawEnergy;
265  }
266 
267  return data;
268 }
constexpr double deltaPhi(double phi1, double phi2)
Definition: deltaPhi.h:26
float full5x5_hcalOverEcalBc(int depth=0) const
Definition: GsfElectron.h:478
float hcalOverEcalBc(const ShowerShape &ss, int depth) const
Definition: GsfElectron.h:442
double phi() const
azimuthal angle of cluster centroid
Definition: CaloCluster.h:184
bool isEB() const
Definition: GsfElectron.h:328
void getSeedCrysCoord(const reco::CaloCluster &clus, int &iEtaOrX, int &iPhiOrY) const
const ShowerShape & full5x5_showerShape() const
Definition: GsfElectron.h:488
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
char data[epos_bytes_allocation]
Definition: EPOS_Wrapper.h:80
double eta() const
pseudorapidity of cluster centroid
Definition: CaloCluster.h:181
SuperClusterRef superCluster() const override
reference to a SuperCluster
Definition: GsfElectron.h:155
float nSaturatedXtals() const
Definition: GsfElectron.h:519

◆ getRegData() [2/2]

std::array< float, 32 > EGRegressionModifierV3::getRegData ( const reco::Photon pho) const
private

Definition at line 270 of file EGRegressionModifierV3.cc.

References funct::abs(), data, reco::deltaPhi(), reco::Photon::ShowerShape::e5x5, reco::CaloCluster::eta(), reco::Photon::full5x5_r9(), reco::Photon::full5x5_showerShapeVariables(), getSeedCrysCoord(), reco::Photon::hadronicOverEm(), l1tPhase2CaloJetEmulator_cfi::iEta, reco::Photon::isEB(), electrons_cff::isEB, WZElectronSkims53X_cff::max, reco::Photon::nSaturatedXtals(), electrons_cff::numberOfClusters, reco::CaloCluster::phi(), egamma_custom_cff::rawEnergy, rhoValue_, and reco::Photon::superCluster().

270  {
271  std::array<float, 32> data;
272 
273  const reco::SuperClusterRef& superClus = pho.superCluster();
274  const edm::Ptr<reco::CaloCluster>& seedClus = superClus->seed();
275 
276  const bool isEB = pho.isEB();
277  const double rawEnergy = superClus->rawEnergy();
278  const double rawESEnergy = superClus->preshowerEnergy();
279  const int numberOfClusters = superClus->clusters().size();
280  const auto& ssFull5x5 = pho.full5x5_showerShapeVariables();
281 
282  float e5x5Inverse = ssFull5x5.e5x5 != 0. ? vdt::fast_inv(ssFull5x5.e5x5) : 0.;
283 
284  data[0] = rawEnergy;
285  data[1] = superClus->etaWidth();
286  data[2] = superClus->phiWidth();
287  data[3] = superClus->seed()->energy() / rawEnergy;
288  data[4] = ssFull5x5.e5x5 / rawEnergy;
289  //interestingly enough this differs from electrons where it uses cone based
290  //naively Sam would have thought using cone based is even worse than tower based
291  data[5] = pho.hadronicOverEm();
292  data[6] = rhoValue_;
293  data[7] = seedClus->eta() - superClus->position().Eta();
294  data[8] = reco::deltaPhi(seedClus->phi(), superClus->position().Phi());
295  data[9] = pho.full5x5_r9();
296  data[10] = ssFull5x5.sigmaIetaIeta;
297  //interestingly sigmaIEtaIPhi differs in defination here from
298  //electron & sc definations of sigmaIEtaIPhi
299  data[11] = ssFull5x5.sigmaIetaIphi;
300  data[12] = ssFull5x5.sigmaIphiIphi;
301  data[13] = ssFull5x5.maxEnergyXtal * e5x5Inverse;
302  data[14] = ssFull5x5.e2nd * e5x5Inverse;
303  data[15] = ssFull5x5.eTop * e5x5Inverse;
304  data[16] = ssFull5x5.eBottom * e5x5Inverse;
305  data[17] = ssFull5x5.eLeft * e5x5Inverse;
306  data[18] = ssFull5x5.eRight * e5x5Inverse;
307  data[19] = ssFull5x5.e2x5Max * e5x5Inverse;
308  data[20] = ssFull5x5.e2x5Left * e5x5Inverse;
309  data[21] = ssFull5x5.e2x5Right * e5x5Inverse;
310  data[22] = ssFull5x5.e2x5Top * e5x5Inverse;
311  data[23] = ssFull5x5.e2x5Bottom * e5x5Inverse;
312  data[24] = pho.nSaturatedXtals();
313  data[25] = std::max(0, numberOfClusters);
314 
315  if (isEB) {
316  int iEta, iPhi;
317  getSeedCrysCoord(*seedClus, iEta, iPhi);
318  data[26] = iEta;
319  data[27] = iPhi;
320  int signIEta = iEta > 0 ? +1 : -1;
321  data[28] = (iEta - signIEta) % 5;
322  data[29] = (iPhi - 1) % 2;
323  const int iEtaCorr = iEta - (iEta > 0 ? +1 : -1);
324  const int iEtaCorr26 = iEta - (iEta > 0 ? +26 : -26);
325  data[30] = std::abs(iEta) <= 25 ? iEtaCorr % 20 : iEtaCorr26 % 20;
326  data[31] = (iPhi - 1) % 20;
327  } else {
328  int iX, iY;
329  getSeedCrysCoord(*seedClus, iX, iY);
330  data[26] = iX;
331  data[27] = iY;
332  data[28] = rawESEnergy / rawEnergy;
333  }
334 
335  return data;
336 }
constexpr double deltaPhi(double phi1, double phi2)
Definition: deltaPhi.h:26
const ShowerShape & full5x5_showerShapeVariables() const
Definition: Photon.h:216
bool isEB() const
Definition: Photon.h:126
double phi() const
azimuthal angle of cluster centroid
Definition: CaloCluster.h:184
float nSaturatedXtals() const
Definition: Photon.h:312
void getSeedCrysCoord(const reco::CaloCluster &clus, int &iEtaOrX, int &iPhiOrY) const
reco::SuperClusterRef superCluster() const override
Ref to SuperCluster.
Abs< T >::type abs(const T &t)
Definition: Abs.h:22
float hadronicOverEm(int depth=0) const
Definition: Photon.h:239
char data[epos_bytes_allocation]
Definition: EPOS_Wrapper.h:80
double eta() const
pseudorapidity of cluster centroid
Definition: CaloCluster.h:181
float full5x5_r9() const
Definition: Photon.h:291

◆ getSeedCrysCoord()

void EGRegressionModifierV3::getSeedCrysCoord ( const reco::CaloCluster clus,
int &  iEtaOrX,
int &  iPhiOrY 
) const
private

Definition at line 338 of file EGRegressionModifierV3.cc.

References caloGeomHandle_, EcalBarrel, EBDetId::ieta(), electrons_cff::isEB, EEDetId::ix(), egammaTools::localEcalClusterCoordsEB(), egammaTools::localEcalClusterCoordsEE(), reco::CaloCluster::seed(), DetId::subdetId(), and useClosestToCentreSeedCrysDef_.

Referenced by getRegData().

338  {
339  iEtaOrX = 0;
340  iPhiOrY = 0;
341 
342  const bool isEB = clus.seed().subdetId() == EcalBarrel;
343 
345  float dummy;
346  if (isEB) {
348  } else {
350  }
351  } else {
352  if (isEB) {
353  const EBDetId ebId(clus.seed());
354  iEtaOrX = ebId.ieta();
355  iPhiOrY = ebId.iphi();
356  } else {
357  const EEDetId eeId(clus.seed());
358  iEtaOrX = eeId.ix();
359  iPhiOrY = eeId.iy();
360  }
361  }
362 }
void localEcalClusterCoordsEB(const reco::CaloCluster &bclus, const CaloGeometry &geom, float &etacry, float &phicry, int &ieta, int &iphi, float &thetatilt, float &phitilt)
DetId seed() const
return DetId of seed
Definition: CaloCluster.h:219
int ix() const
Definition: EEDetId.h:77
int ieta() const
get the crystal ieta
Definition: EBDetId.h:49
edm::ESHandle< CaloGeometry > caloGeomHandle_
constexpr int subdetId() const
get the contents of the subdetector field (not cast into any detector&#39;s numbering enum) ...
Definition: DetId.h:48
void localEcalClusterCoordsEE(const reco::CaloCluster &bclus, const CaloGeometry &geom, float &xcry, float &ycry, int &ix, int &iy, float &thetatilt, float &phitilt)

◆ modifyObject() [1/4]

void EGRegressionModifierV3::modifyObject ( reco::GsfElectron ele) const
finalvirtual

Reimplemented from ModifyObjectValueBase.

Definition at line 106 of file EGRegressionModifierV3.cc.

References reco::GsfElectron::correctMomentum(), eleRegs_, reco::GsfElectron::fbrem(), DetId::Forward, getRegData(), edm::Ref< C, T, F >::isAvailable(), reco::GsfElectron::isEB(), CastorSimpleRecAlgoImpl::isSaturated(), reco::GsfElectron::ClassificationVariables::kDefaultValue, maxRawEnergyForLowPtEBSigma_, maxRawEnergyForLowPtEESigma_, SiStripPI::min, reco::GsfElectron::nSaturatedXtals(), reco::GsfElectron::p4(), egamma_custom_cff::rawEnergy, l1trig_cff::rawEt, reco::GsfElectron::setCorrectedEcalEnergy(), reco::GsfElectron::setCorrectedEcalEnergyError(), reco::GsfElectron::superCluster(), and reco::GsfElectron::trackMomentumError().

Referenced by modifyObject().

106  {
107  //check if we have specified an electron regression correction and
108  //return the object unmodified if so
109  if (!eleRegs_)
110  return;
111 
112  const reco::SuperClusterRef& superClus = ele.superCluster();
113 
114  // skip HGCAL for now
115  if (superClus->seed()->seed().det() == DetId::Forward)
116  return;
117 
118  // do not apply corrections in case of missing info (slimmed MiniAOD electrons)
119  bool rescaleDependentValues = superClus->clusters().isAvailable();
120 
121  //check if fbrem is filled as its needed for E/p combination so abort if its set to the default value
122  //this will be the case for <5 (or current cuts) for miniAOD electrons
124  return;
125 
126  auto regData = getRegData(ele);
127  const float rawEnergy = superClus->rawEnergy();
128  const float rawESEnergy = superClus->preshowerEnergy();
129  //bug here, it should include the ES, kept for backwards compat
130  const float rawEt = rawEnergy * superClus->position().rho() / superClus->position().r();
131  const bool isSaturated = ele.nSaturatedXtals() != 0;
132 
133  const float ecalMean = eleRegs_->ecalOnlyMean(rawEt, ele.isEB(), isSaturated, regData.data());
134  const float ecalMeanCorr = ecalMean > 0. ? ecalMean : 1.0;
135  //as the sample is trained flat in pt, the regression's only source of very high energy
136  //electrons is in the high endcap and therefore it gives a very poor resolution estimate
137  //to any electrons with this energy, regardless of their actual eta
138  //hence this lovely hack
139  if (ele.isEB() && maxRawEnergyForLowPtEBSigma_ >= 0 && eleRegs_->ecalOnlySigma.useLowEtBin(rawEt, isSaturated)) {
140  regData[0] = std::min(regData[0], maxRawEnergyForLowPtEBSigma_);
141  }
142  if (!ele.isEB() && maxRawEnergyForLowPtEESigma_ >= 0 && eleRegs_->ecalOnlySigma.useLowEtBin(rawEt, isSaturated)) {
143  regData[0] = std::min(regData[0], maxRawEnergyForLowPtEESigma_);
144  }
145  const float ecalSigma = eleRegs_->ecalOnlySigma(rawEt, ele.isEB(), isSaturated, regData.data());
146 
147  const float corrEnergy = (rawEnergy + rawESEnergy) * ecalMeanCorr;
148  const float corrEnergyErr = corrEnergy * ecalSigma;
149 
150  ele.setCorrectedEcalEnergy(corrEnergy, rescaleDependentValues);
151  ele.setCorrectedEcalEnergyError(corrEnergyErr);
152 
153  std::pair<float, float> combEnergyAndErr = eleRegs_->epComb.combine(ele);
154  const math::XYZTLorentzVector newP4 = ele.p4() * combEnergyAndErr.first / ele.p4().t();
155  ele.correctMomentum(newP4, ele.trackMomentumError(), combEnergyAndErr.second);
156 }
float trackMomentumError() const
Definition: GsfElectron.h:884
void correctMomentum(const LorentzVector &p4, float trackMomentumError, float p4Error)
Definition: GsfElectron.h:905
std::array< float, 32 > getRegData(const reco::GsfElectron &ele) const
bool isEB() const
Definition: GsfElectron.h:328
XYZTLorentzVectorD XYZTLorentzVector
Lorentz vector with cylindrical internal representation using pseudorapidity.
Definition: LorentzVector.h:29
void setCorrectedEcalEnergyError(float newEnergyError)
Definition: GsfElectron.cc:170
bool isAvailable() const
Definition: Ref.h:535
const LorentzVector & p4(P4Kind kind) const
Definition: GsfElectron.cc:217
std::unique_ptr< EleRegs > eleRegs_
void setCorrectedEcalEnergy(float newEnergy)
Definition: GsfElectron.cc:174
float fbrem() const
Definition: GsfElectron.h:809
bool isSaturated(const Digi &digi, const int &maxADCvalue, int ifirst, int n)
SuperClusterRef superCluster() const override
reference to a SuperCluster
Definition: GsfElectron.h:155
float nSaturatedXtals() const
Definition: GsfElectron.h:519

◆ modifyObject() [2/4]

void EGRegressionModifierV3::modifyObject ( reco::Photon pho) const
finalvirtual

Reimplemented from ModifyObjectValueBase.

Definition at line 162 of file EGRegressionModifierV3.cc.

References DetId::Forward, getRegData(), edm::Ref< C, T, F >::isAvailable(), reco::Photon::isEB(), CastorSimpleRecAlgoImpl::isSaturated(), maxRawEnergyForLowPtEBSigma_, maxRawEnergyForLowPtEESigma_, SiStripPI::min, reco::Photon::nSaturatedXtals(), phoRegs_, egamma_custom_cff::rawEnergy, l1trig_cff::rawEt, reco::Photon::setCorrectedEnergy(), and reco::Photon::superCluster().

162  {
163  //check if we have specified an photon regression correction and
164  //return the object unmodified if so
165  if (!phoRegs_)
166  return;
167 
168  const reco::SuperClusterRef& superClus = pho.superCluster();
169 
170  // skip HGCAL for now
171  if (superClus->seed()->seed().det() == DetId::Forward)
172  return;
173 
174  // do not apply corrections in case of missing info (happens for some slimmed MiniAOD photons)
175  if (!superClus->clusters().isAvailable())
176  return;
177 
178  auto regData = getRegData(pho);
179 
180  const float rawEnergy = superClus->rawEnergy();
181  const float rawESEnergy = superClus->preshowerEnergy();
182  //bug here, it should include the ES, kept for backwards compat
183  const float rawEt = rawEnergy * superClus->position().rho() / superClus->position().r();
184  const bool isSaturated = pho.nSaturatedXtals();
185  const float ecalMean = phoRegs_->ecalOnlyMean(rawEt, pho.isEB(), isSaturated, regData.data());
186  const float ecalMeanCorr = ecalMean > 0. ? ecalMean : 1.0;
187 
188  //see the electrons for explaination of this lovely feature
189  if (pho.isEB() && maxRawEnergyForLowPtEBSigma_ >= 0 && phoRegs_->ecalOnlySigma.useLowEtBin(rawEt, isSaturated)) {
190  regData[0] = std::min(regData[0], maxRawEnergyForLowPtEBSigma_);
191  }
192  if (!pho.isEB() && maxRawEnergyForLowPtEESigma_ >= 0 && phoRegs_->ecalOnlySigma.useLowEtBin(rawEt, isSaturated)) {
193  regData[0] = std::min(regData[0], maxRawEnergyForLowPtEESigma_);
194  }
195  const float ecalSigma = phoRegs_->ecalOnlySigma(rawEt, pho.isEB(), isSaturated, regData.data());
196 
197  const double corrEnergy = (rawEnergy + rawESEnergy) * ecalMeanCorr;
198  const double corrEnergyErr = corrEnergy * ecalSigma;
199 
200  pho.setCorrectedEnergy(reco::Photon::P4type::regression2, corrEnergy, corrEnergyErr, true);
201 }
void setCorrectedEnergy(P4type type, float E, float dE, bool toCand=true)
bool isEB() const
Definition: Photon.h:126
std::unique_ptr< PhoRegs > phoRegs_
float nSaturatedXtals() const
Definition: Photon.h:312
std::array< float, 32 > getRegData(const reco::GsfElectron &ele) const
reco::SuperClusterRef superCluster() const override
Ref to SuperCluster.
bool isAvailable() const
Definition: Ref.h:535
bool isSaturated(const Digi &digi, const int &maxADCvalue, int ifirst, int n)

◆ modifyObject() [3/4]

void EGRegressionModifierV3::modifyObject ( pat::Electron ele) const
finalvirtual

Reimplemented from ModifyObjectValueBase.

Definition at line 158 of file EGRegressionModifierV3.cc.

References modifyObject().

158  {
159  modifyObject(static_cast<reco::GsfElectron&>(ele));
160 }
void modifyObject(reco::GsfElectron &) const final

◆ modifyObject() [4/4]

void EGRegressionModifierV3::modifyObject ( pat::Photon pho) const
finalvirtual

Reimplemented from ModifyObjectValueBase.

Definition at line 203 of file EGRegressionModifierV3.cc.

References modifyObject().

203 { modifyObject(static_cast<reco::Photon&>(pho)); }
void modifyObject(reco::GsfElectron &) const final

◆ setEvent()

void EGRegressionModifierV3::setEvent ( const edm::Event evt)
finalvirtual

Reimplemented from ModifyObjectValueBase.

Definition at line 94 of file EGRegressionModifierV3.cc.

References edm::Event::get(), rhoToken_, and rhoValue_.

94 { rhoValue_ = evt.get(rhoToken_); }
bool get(ProductID const &oid, Handle< PROD > &result) const
Definition: Event.h:344
edm::EDGetTokenT< double > rhoToken_

◆ setEventContent()

void EGRegressionModifierV3::setEventContent ( const edm::EventSetup iSetup)
finalvirtual

Reimplemented from ModifyObjectValueBase.

Definition at line 96 of file EGRegressionModifierV3.cc.

References caloGeomHandle_, caloGeomToken_, eleRegs_, edm::EventSetup::getHandle(), phoRegs_, and useClosestToCentreSeedCrysDef_.

96  {
97  if (eleRegs_)
98  eleRegs_->setEventContent(iSetup);
99  if (phoRegs_)
100  phoRegs_->setEventContent(iSetup);
103  }
104 }
std::unique_ptr< PhoRegs > phoRegs_
edm::ESHandle< CaloGeometry > caloGeomHandle_
ESHandle< T > getHandle(const ESGetToken< T, R > &iToken) const
Definition: EventSetup.h:130
edm::ESGetToken< CaloGeometry, CaloGeometryRecord > caloGeomToken_
std::unique_ptr< EleRegs > eleRegs_

Member Data Documentation

◆ caloGeomHandle_

edm::ESHandle<CaloGeometry> EGRegressionModifierV3::caloGeomHandle_
private

Definition at line 68 of file EGRegressionModifierV3.cc.

Referenced by getSeedCrysCoord(), and setEventContent().

◆ caloGeomToken_

edm::ESGetToken<CaloGeometry, CaloGeometryRecord> EGRegressionModifierV3::caloGeomToken_
private

Definition at line 67 of file EGRegressionModifierV3.cc.

Referenced by EGRegressionModifierV3(), and setEventContent().

◆ eleRegs_

std::unique_ptr<EleRegs> EGRegressionModifierV3::eleRegs_
private

Definition at line 57 of file EGRegressionModifierV3.cc.

Referenced by EGRegressionModifierV3(), modifyObject(), and setEventContent().

◆ maxRawEnergyForLowPtEBSigma_

float EGRegressionModifierV3::maxRawEnergyForLowPtEBSigma_
private

Definition at line 65 of file EGRegressionModifierV3.cc.

Referenced by modifyObject().

◆ maxRawEnergyForLowPtEESigma_

float EGRegressionModifierV3::maxRawEnergyForLowPtEESigma_
private

Definition at line 66 of file EGRegressionModifierV3.cc.

Referenced by modifyObject().

◆ phoRegs_

std::unique_ptr<PhoRegs> EGRegressionModifierV3::phoRegs_
private

Definition at line 58 of file EGRegressionModifierV3.cc.

Referenced by EGRegressionModifierV3(), modifyObject(), and setEventContent().

◆ rhoToken_

edm::EDGetTokenT<double> EGRegressionModifierV3::rhoToken_
private

Definition at line 61 of file EGRegressionModifierV3.cc.

Referenced by setEvent().

◆ rhoValue_

float EGRegressionModifierV3::rhoValue_
private

Definition at line 60 of file EGRegressionModifierV3.cc.

Referenced by getRegData(), and setEvent().

◆ useBuggedHOverE_

bool EGRegressionModifierV3::useBuggedHOverE_
private

Definition at line 64 of file EGRegressionModifierV3.cc.

Referenced by getRegData().

◆ useClosestToCentreSeedCrysDef_

bool EGRegressionModifierV3::useClosestToCentreSeedCrysDef_
private