CMS 3D CMS Logo

List of all members | Public Member Functions | Private Member Functions | Private Attributes
SimpleConvertedPhotonAnalyzer Class Reference
Inheritance diagram for SimpleConvertedPhotonAnalyzer:
edm::one::EDAnalyzer<> edm::one::EDAnalyzerBase edm::EDConsumerBase

Public Member Functions

void analyze (const edm::Event &, const edm::EventSetup &) override
 
void beginJob () override
 
void endJob () override
 
 SimpleConvertedPhotonAnalyzer (const edm::ParameterSet &)
 
 ~SimpleConvertedPhotonAnalyzer () override
 
- Public Member Functions inherited from edm::one::EDAnalyzer<>
 EDAnalyzer ()=default
 
SerialTaskQueueglobalLuminosityBlocksQueue () final
 
SerialTaskQueueglobalRunsQueue () final
 
bool wantsGlobalLuminosityBlocks () const final
 
bool wantsGlobalRuns () const final
 
bool wantsInputProcessBlocks () const final
 
bool wantsProcessBlocks () const final
 
- Public Member Functions inherited from edm::one::EDAnalyzerBase
void callWhenNewProductsRegistered (std::function< void(BranchDescription const &)> const &func)
 
 EDAnalyzerBase ()
 
ModuleDescription const & moduleDescription () const
 
bool wantsStreamLuminosityBlocks () const
 
bool wantsStreamRuns () const
 
 ~EDAnalyzerBase () override
 
- Public Member Functions inherited from edm::EDConsumerBase
std::vector< ConsumesInfoconsumesInfo () const
 
void convertCurrentProcessAlias (std::string const &processName)
 Convert "@currentProcess" in InputTag process names to the actual current process name. More...
 
 EDConsumerBase ()
 
 EDConsumerBase (EDConsumerBase &&)=default
 
 EDConsumerBase (EDConsumerBase const &)=delete
 
ESProxyIndex const * esGetTokenIndices (edm::Transition iTrans) const
 
std::vector< ESProxyIndex > const & esGetTokenIndicesVector (edm::Transition iTrans) const
 
std::vector< ESRecordIndex > const & esGetTokenRecordIndicesVector (edm::Transition iTrans) const
 
ProductResolverIndexAndSkipBit indexFrom (EDGetToken, BranchType, TypeID const &) const
 
void itemsMayGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
void itemsToGet (BranchType, std::vector< ProductResolverIndexAndSkipBit > &) const
 
std::vector< ProductResolverIndexAndSkipBit > const & itemsToGetFrom (BranchType iType) const
 
void labelsForToken (EDGetToken iToken, Labels &oLabels) const
 
void modulesWhoseProductsAreConsumed (std::array< std::vector< ModuleDescription const * > *, NumBranchTypes > &modulesAll, std::vector< ModuleProcessName > &modulesInPreviousProcesses, ProductRegistry const &preg, std::map< std::string, ModuleDescription const * > const &labelsToDesc, std::string const &processName) const
 
EDConsumerBaseoperator= (EDConsumerBase &&)=default
 
EDConsumerBase const & operator= (EDConsumerBase const &)=delete
 
bool registeredToConsume (ProductResolverIndex, bool, BranchType) const
 
bool registeredToConsumeMany (TypeID const &, BranchType) const
 
ProductResolverIndexAndSkipBit uncheckedIndexFrom (EDGetToken) const
 
void updateLookup (BranchType iBranchType, ProductResolverIndexHelper const &, bool iPrefetchMayGet)
 
void updateLookup (eventsetup::ESRecordsToProxyIndices const &)
 
virtual ~EDConsumerBase () noexcept(false)
 

Private Member Functions

float etaTransformation (float a, float b)
 

Private Attributes

std::string convertedPhotonCollection_
 
std::string convertedPhotonCollectionProducer_
 
TFile * fOutputFile_
 
std::string fOutputFileName_
 
TH2F * h2_tk_inPtVsR_
 
TH2F * h2_tk_nHitsVsR_
 
TH1F * h_deltaEta_
 
TH1F * h_deltaPhi_
 
TH1F * h_ErecoEMC_
 
TH1F * h_MCConvE_
 
TH1F * h_MCConvEta_
 
TH1F * h_MCConvPt_
 
TH1F * h_MCphoE_
 
TH1F * h_MCphoEta_
 
TH1F * h_MCphoPhi_
 
TH1F * h_phoE_
 
TH1F * h_phoEta_
 
TH1F * h_phoPhi_
 
TH1F * h_scE_
 
TH1F * h_scEta_
 
TH1F * h_scPhi_
 
std::string HepMCLabel
 
int nEvt_
 
int nMatched_
 
int nMCPho_
 
std::string SimHitLabel
 
std::string SimTkLabel
 
std::string SimVtxLabel
 
PhotonMCTruthFinderthePhotonMCTruthFinder_
 

Additional Inherited Members

- Public Types inherited from edm::one::EDAnalyzerBase
typedef EDAnalyzerBase ModuleType
 
- Public Types inherited from edm::EDConsumerBase
typedef ProductLabels Labels
 
- Static Public Member Functions inherited from edm::one::EDAnalyzerBase
static const std::string & baseType ()
 
static void fillDescriptions (ConfigurationDescriptions &descriptions)
 
static void prevalidate (ConfigurationDescriptions &descriptions)
 
- Protected Member Functions inherited from edm::EDConsumerBase
EDGetToken consumes (const TypeToGet &id, edm::InputTag const &tag)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > consumes (edm::InputTag const &tag)
 
template<BranchType B = InEvent>
EDConsumerBaseAdaptor< B > consumes (edm::InputTag tag) noexcept
 
template<BranchType B>
EDGetToken consumes (TypeToGet const &id, edm::InputTag const &tag)
 
ConsumesCollector consumesCollector ()
 Use a ConsumesCollector to gather consumes information from helper functions. More...
 
template<typename ProductType , BranchType B = InEvent>
void consumesMany ()
 
void consumesMany (const TypeToGet &id)
 
template<BranchType B>
void consumesMany (const TypeToGet &id)
 
template<typename ESProduct , typename ESRecord , Transition Tr = Transition::Event>
auto esConsumes ()
 
template<Transition Tr = Transition::Event>
constexpr auto esConsumes () noexcept
 
template<typename ESProduct , typename ESRecord , Transition Tr = Transition::Event>
auto esConsumes (ESInputTag const &tag)
 
template<Transition Tr = Transition::Event>
auto esConsumes (ESInputTag tag) noexcept
 
template<Transition Tr = Transition::Event>
ESGetTokenGeneric esConsumes (eventsetup::EventSetupRecordKey const &iRecord, eventsetup::DataKey const &iKey)
 Used with EventSetupRecord::doGet. More...
 
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<BranchType B>
EDGetToken mayConsume (const TypeToGet &id, edm::InputTag const &tag)
 
template<typename ProductType , BranchType B = InEvent>
EDGetTokenT< ProductType > mayConsume (edm::InputTag const &tag)
 

Detailed Description

Definition at line 36 of file SimpleConvertedPhotonAnalyzer.cc.

Constructor & Destructor Documentation

◆ SimpleConvertedPhotonAnalyzer()

SimpleConvertedPhotonAnalyzer::SimpleConvertedPhotonAnalyzer ( const edm::ParameterSet pset)
explicit

Definition at line 101 of file SimpleConvertedPhotonAnalyzer.cc.

102  : fOutputFileName_(pset.getUntrackedParameter<string>("HistOutFile", std::string("TestConversions.root"))),
103  fOutputFile_(nullptr) {
104  convertedPhotonCollectionProducer_ = pset.getParameter<std::string>("phoProducer");
105  convertedPhotonCollection_ = pset.getParameter<std::string>("convertedPhotonCollection");
106  //
107 }

References convertedPhotonCollection_, convertedPhotonCollectionProducer_, muonDTDigis_cfi::pset, and AlCaHLTBitMon_QueryRunRegistry::string.

◆ ~SimpleConvertedPhotonAnalyzer()

SimpleConvertedPhotonAnalyzer::~SimpleConvertedPhotonAnalyzer ( )
override

Definition at line 109 of file SimpleConvertedPhotonAnalyzer.cc.

109 { delete thePhotonMCTruthFinder_; }

References thePhotonMCTruthFinder_.

Member Function Documentation

◆ analyze()

void SimpleConvertedPhotonAnalyzer::analyze ( const edm::Event e,
const edm::EventSetup  
)
overridevirtual

Loop over recontructed photons

End loop over Reco particles

End loop over MC particles

Implements edm::one::EDAnalyzerBase.

Definition at line 188 of file SimpleConvertedPhotonAnalyzer.cc.

188  {
189  using namespace edm;
190  const float etaPhiDistance = 0.01;
191  // Fiducial region
192  //UNUSED const float TRK_BARL =0.9;
193  const float BARL = 1.4442; // DAQ TDR p.290
194  const float END_LO = 1.566;
195  const float END_HI = 2.5;
196  // Electron mass
197  //UNUSED const Float_t mElec= 0.000511;
198 
199  nEvt_++;
200  LogInfo("ConvertedPhotonAnalyzer") << "ConvertedPhotonAnalyzer Analyzing event number: " << e.id()
201  << " Global Counter " << nEvt_ << "\n";
202  // LogDebug("ConvertedPhotonAnalyzer") << "ConvertedPhotonAnalyzer Analyzing event number: " << e.id() << " Global Counter " << nEvt_ <<"\n";
203  std::cout << "ConvertedPhotonAnalyzer Analyzing event number: " << e.id() << " Global Counter " << nEvt_ << "\n";
204 
206  Handle<reco::ConversionCollection> convertedPhotonHandle;
207  e.getByLabel(convertedPhotonCollectionProducer_, convertedPhotonCollection_, convertedPhotonHandle);
208  const reco::ConversionCollection phoCollection = *(convertedPhotonHandle.product());
209  std::cout << "ConvertedPhotonAnalyzer Converted photon collection size " << phoCollection.size() << "\n";
210 
212  std::cout << " ConvertedPhotonAnalyzer Looking for MC truth "
213  << "\n";
214 
215  //get simtrack info
216  std::vector<SimTrack> theSimTracks;
217  std::vector<SimVertex> theSimVertices;
218 
221  e.getByLabel("g4SimHits", SimTk);
222  e.getByLabel("g4SimHits", SimVtx);
223 
224  theSimTracks.insert(theSimTracks.end(), SimTk->begin(), SimTk->end());
225  theSimVertices.insert(theSimVertices.end(), SimVtx->begin(), SimVtx->end());
226 
227  std::vector<PhotonMCTruth> mcPhotons = thePhotonMCTruthFinder_->find(theSimTracks, theSimVertices);
228  std::cout << " ConvertedPhotonAnalyzer mcPhotons size " << mcPhotons.size() << std::endl;
229 
230  // Loop over simulated photons
231  //UNUSED int iDet=0;
232  //UNUSED int iRadius=-1;
233  //UNUSED int indPho=0;
234 
235  for (std::vector<PhotonMCTruth>::const_iterator mcPho = mcPhotons.begin(); mcPho != mcPhotons.end(); mcPho++) {
236  float mcPhi = (*mcPho).fourMomentum().phi();
237  float mcEta = (*mcPho).fourMomentum().pseudoRapidity();
238  mcEta = etaTransformation(mcEta, (*mcPho).primaryVertex().z());
239 
240  if (!(fabs(mcEta) <= BARL || (fabs(mcEta) >= END_LO && fabs(mcEta) <= END_HI))) {
241  continue;
242  } // all ecal fiducial region
243 
244  std::cout << " ConvertedPhotonAnalyzer MC Photons before matching " << std::endl;
245  std::cout << " ConvertedPhotonAnalyzer Photons isAconversion " << (*mcPho).isAConversion()
246  << " mcMatchingPhoton energy " << (*mcPho).fourMomentum().e() << " conversion vertex R "
247  << (*mcPho).vertex().perp() << " Z " << (*mcPho).vertex().z() << " x " << (*mcPho).vertex().x() << " y "
248  << (*mcPho).vertex().y() << " z " << (*mcPho).vertex().z() << std::endl;
249  std::cout << " ConvertedPhotonAnalyzer mcEta " << mcEta << " mcPhi " << mcPhi << std::endl;
250 
251  h_MCphoE_->Fill((*mcPho).fourMomentum().e());
252  h_MCphoEta_->Fill((*mcPho).fourMomentum().eta());
253  h_MCphoPhi_->Fill((*mcPho).fourMomentum().phi());
254 
255  // keep only visible conversions
256  if ((*mcPho).isAConversion() == 0)
257  continue;
258 
259  nMCPho_++;
260 
261  h_MCConvEta_->Fill(fabs((*mcPho).fourMomentum().pseudoRapidity()) - 0.001);
262 
263  bool REJECTED;
264 
266  std::cout << " ConvertedPhotonAnalyzer Starting loop over photon candidates "
267  << "\n";
268  for (reco::ConversionCollection::const_iterator iPho = phoCollection.begin(); iPho != phoCollection.end(); iPho++) {
269  REJECTED = false;
270 
271  std::cout << " ConvertedPhotonAnalyzer Reco SC energy " << (*iPho).caloCluster()[0]->energy() << "\n";
272 
273  float phiClu = (*iPho).caloCluster()[0]->phi();
274  float etaClu = (*iPho).caloCluster()[0]->eta();
275  float deltaPhi = phiClu - mcPhi;
276  float deltaEta = etaClu - mcEta;
277 
278  if (deltaPhi > Geom::pi())
279  deltaPhi -= Geom::twoPi();
280  if (deltaPhi < -Geom::pi())
281  deltaPhi += Geom::twoPi();
282  deltaPhi = std::pow(deltaPhi, 2);
283  deltaEta = std::pow(deltaEta, 2);
284  float delta = deltaPhi + deltaEta;
285  if (delta >= etaPhiDistance)
286  REJECTED = true;
287 
288  // if ( ! ( fabs(etaClu) <= BARL || ( fabs(etaClu) >= END_LO && fabs(etaClu) <=END_HI ) ) ) REJECTED=true;
289 
290  if (REJECTED)
291  continue;
292  std::cout << " MATCHED " << std::endl;
293  nMatched_++;
294 
295  std::cout << " ConvertedPhotonAnalyzer Matching candidate " << std::endl;
296 
297  std::cout << " ConvertedPhotonAnalyzer Photons isAconversion " << (*mcPho).isAConversion()
298  << " mcMatchingPhoton energy " << (*mcPho).fourMomentum().e()
299  << " ConvertedPhotonAnalyzer conversion vertex R " << (*mcPho).vertex().perp() << " Z "
300  << (*mcPho).vertex().z() << std::endl;
301 
302  h_ErecoEMC_->Fill((*iPho).caloCluster()[0]->energy() / (*mcPho).fourMomentum().e());
303  h_deltaPhi_->Fill((*iPho).caloCluster()[0]->position().phi() - mcPhi);
304  h_deltaEta_->Fill((*iPho).caloCluster()[0]->position().eta() - mcEta);
305 
306  h_scE_->Fill((*iPho).caloCluster()[0]->energy());
307  h_scEta_->Fill((*iPho).caloCluster()[0]->position().eta());
308  h_scPhi_->Fill((*iPho).caloCluster()[0]->position().phi());
309 
310  for (unsigned int i = 0; i < (*iPho).tracks().size(); i++) {
311  std::cout << " ConvertedPhotonAnalyzer Reco Track charge " << (*iPho).tracks()[i]->charge()
312  << " Num of RecHits " << (*iPho).tracks()[i]->recHitsSize() << " inner momentum "
313  << sqrt((*iPho).tracks()[i]->innerMomentum().Mag2()) << "\n";
314 
315  h2_tk_nHitsVsR_->Fill((*mcPho).vertex().perp(), (*iPho).tracks()[i]->recHitsSize());
316  h2_tk_inPtVsR_->Fill((*mcPho).vertex().perp(), sqrt((*iPho).tracks()[i]->innerMomentum().Mag2()));
317  }
318 
319  }
320 
321  }
322 }

References convertedPhotonCollection_, convertedPhotonCollectionProducer_, gather_cfg::cout, dumpMFGeometry_cfg::delta, spr::deltaEta, SiPixelRawToDigiRegional_cfi::deltaPhi, MillePedeFileConverter_cfg::e, etaTransformation(), PhotonMCTruthFinder::find(), h2_tk_inPtVsR_, h2_tk_nHitsVsR_, h_deltaEta_, h_deltaPhi_, h_ErecoEMC_, h_MCConvEta_, h_MCphoE_, h_MCphoEta_, h_MCphoPhi_, h_scE_, h_scEta_, h_scPhi_, mps_fire::i, nEvt_, nMatched_, nMCPho_, Geom::pi(), funct::pow(), edm::Handle< T >::product(), mathSSE::sqrt(), thePhotonMCTruthFinder_, and Geom::twoPi().

◆ beginJob()

void SimpleConvertedPhotonAnalyzer::beginJob ( void  )
overridevirtual

Reco - MC

Reimplemented from edm::one::EDAnalyzerBase.

Definition at line 111 of file SimpleConvertedPhotonAnalyzer.cc.

111  {
112  nEvt_ = 0;
113  nMCPho_ = 0;
114  nMatched_ = 0;
115 
117 
118  fOutputFile_ = new TFile(fOutputFileName_.c_str(), "RECREATE");
119 
121  h_ErecoEMC_ = new TH1F("deltaE", " delta(reco-mc) energy", 100, 0., 2.);
122  h_deltaPhi_ = new TH1F("deltaPhi", " delta(reco-mc) phi", 100, -0.1, 0.1);
123  h_deltaEta_ = new TH1F("deltaEta", " delta(reco-mc) eta", 100, -0.05, 0.05);
124 
126  h_MCphoE_ = new TH1F("MCphoE", "MC photon energy", 100, 0., 100.);
127  h_MCphoPhi_ = new TH1F("MCphoPhi", "MC photon phi", 40, -3.14, 3.14);
128  h_MCphoEta_ = new TH1F("MCphoEta", "MC photon eta", 40, -3., 3.);
129 
131  h_MCConvE_ = new TH1F("MCConvE", "MC converted photon energy", 100, 0., 100.);
132  h_MCConvPt_ = new TH1F("MCConvPt", "MC converted photon pt", 100, 0., 100.);
133  h_MCConvEta_ = new TH1F("MCConvEta", "MC converted photon eta", 50, 0., 2.5);
134 
136  h_scE_ = new TH1F("scE", "Uncorrected converted photons : SC Energy ", 100, 0., 200.);
137  h_scEta_ = new TH1F("scEta", "Uncorrected converted photons: SC Eta ", 40, -3., 3.);
138  h_scPhi_ = new TH1F("scPhi", "Uncorrected converted photons: SC Phi ", 40, -3.14, 3.14);
139  //
140  h_phoE_ = new TH1F("phoE", "Uncorrected converted photons : Energy ", 100, 0., 200.);
141  h_phoEta_ = new TH1F("phoEta", "Uncorrected converted photons: Eta ", 40, -3., 3.);
142  h_phoPhi_ = new TH1F("phoPhi", "Uncorrected converted photons: Phi ", 40, -3.14, 3.14);
143 
144  // Recontructed tracks from converted photon candidates
145  h2_tk_nHitsVsR_ = new TH2F("tknHitsVsR", "Tracks Hits vs R ", 12, 0., 120., 20, 0.5, 20.5);
146  h2_tk_inPtVsR_ = new TH2F("tkInPtvsR", "Tracks inner Pt vs R ", 12, 0., 120., 100, 0., 100.);
147 
148  return;
149 }

References fOutputFile_, fOutputFileName_, h2_tk_inPtVsR_, h2_tk_nHitsVsR_, h_deltaEta_, h_deltaPhi_, h_ErecoEMC_, h_MCConvE_, h_MCConvEta_, h_MCConvPt_, h_MCphoE_, h_MCphoEta_, h_MCphoPhi_, h_phoE_, h_phoEta_, h_phoPhi_, h_scE_, h_scEta_, h_scPhi_, nEvt_, nMatched_, nMCPho_, and thePhotonMCTruthFinder_.

◆ endJob()

void SimpleConvertedPhotonAnalyzer::endJob ( void  )
overridevirtual

Reimplemented from edm::one::EDAnalyzerBase.

Definition at line 324 of file SimpleConvertedPhotonAnalyzer.cc.

324  {
325  fOutputFile_->Write();
326  fOutputFile_->Close();
327 
328  edm::LogInfo("ConvertedPhotonAnalyzer") << "Analyzed " << nEvt_ << "\n";
329  // std::cout << "::endJob Analyzed " << nEvt_ << " events " << " with total " << nPho_ << " Photons " << "\n";
330  std::cout << "ConvertedPhotonAnalyzer::endJob Analyzed " << nEvt_ << " events "
331  << "\n";
332 
333  return;
334 }

References gather_cfg::cout, fOutputFile_, and nEvt_.

◆ etaTransformation()

float SimpleConvertedPhotonAnalyzer::etaTransformation ( float  a,
float  b 
)
private

Definition at line 151 of file SimpleConvertedPhotonAnalyzer.cc.

151  {
152  //---Definitions
153  const float PI = 3.1415927;
154  //UNUSED const float TWOPI = 2.0*PI;
155 
156  //---Definitions for ECAL
157  const float R_ECAL = 136.5;
158  const float Z_Endcap = 328.0;
159  const float etaBarrelEndcap = 1.479;
160 
161  //---ETA correction
162 
163  float Theta = 0.0;
164  float ZEcal = R_ECAL * sinh(EtaParticle) + Zvertex;
165 
166  if (ZEcal != 0.0)
167  Theta = atan(R_ECAL / ZEcal);
168  if (Theta < 0.0)
169  Theta = Theta + PI;
170  float ETA = -log(tan(0.5 * Theta));
171 
172  if (fabs(ETA) > etaBarrelEndcap) {
173  float Zend = Z_Endcap;
174  if (EtaParticle < 0.0)
175  Zend = -Zend;
176  float Zlen = Zend - Zvertex;
177  float RR = Zlen / sinh(EtaParticle);
178  Theta = atan(RR / Zend);
179  if (Theta < 0.0)
180  Theta = Theta + PI;
181  ETA = -log(tan(0.5 * Theta));
182  }
183  //---Return the result
184  return ETA;
185  //---end
186 }

References ETA, etaBarrelEndcap, dqm-mbProfile::log, PI, R_ECAL, funct::tan(), Z_Endcap, and ZEcal.

Referenced by analyze().

Member Data Documentation

◆ convertedPhotonCollection_

std::string SimpleConvertedPhotonAnalyzer::convertedPhotonCollection_
private

Definition at line 65 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and SimpleConvertedPhotonAnalyzer().

◆ convertedPhotonCollectionProducer_

std::string SimpleConvertedPhotonAnalyzer::convertedPhotonCollectionProducer_
private

Definition at line 64 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and SimpleConvertedPhotonAnalyzer().

◆ fOutputFile_

TFile* SimpleConvertedPhotonAnalyzer::fOutputFile_
private

Definition at line 53 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by beginJob(), and endJob().

◆ fOutputFileName_

std::string SimpleConvertedPhotonAnalyzer::fOutputFileName_
private

Definition at line 52 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by beginJob().

◆ h2_tk_inPtVsR_

TH2F* SimpleConvertedPhotonAnalyzer::h2_tk_inPtVsR_
private

Definition at line 93 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h2_tk_nHitsVsR_

TH2F* SimpleConvertedPhotonAnalyzer::h2_tk_nHitsVsR_
private

Definition at line 91 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_deltaEta_

TH1F* SimpleConvertedPhotonAnalyzer::h_deltaEta_
private

Definition at line 69 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_deltaPhi_

TH1F* SimpleConvertedPhotonAnalyzer::h_deltaPhi_
private

Definition at line 68 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_ErecoEMC_

TH1F* SimpleConvertedPhotonAnalyzer::h_ErecoEMC_
private

Definition at line 67 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_MCConvE_

TH1F* SimpleConvertedPhotonAnalyzer::h_MCConvE_
private

Definition at line 77 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by beginJob().

◆ h_MCConvEta_

TH1F* SimpleConvertedPhotonAnalyzer::h_MCConvEta_
private

Definition at line 79 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_MCConvPt_

TH1F* SimpleConvertedPhotonAnalyzer::h_MCConvPt_
private

Definition at line 78 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by beginJob().

◆ h_MCphoE_

TH1F* SimpleConvertedPhotonAnalyzer::h_MCphoE_
private

Definition at line 72 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_MCphoEta_

TH1F* SimpleConvertedPhotonAnalyzer::h_MCphoEta_
private

Definition at line 74 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_MCphoPhi_

TH1F* SimpleConvertedPhotonAnalyzer::h_MCphoPhi_
private

Definition at line 73 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_phoE_

TH1F* SimpleConvertedPhotonAnalyzer::h_phoE_
private

Definition at line 86 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by beginJob().

◆ h_phoEta_

TH1F* SimpleConvertedPhotonAnalyzer::h_phoEta_
private

Definition at line 87 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by beginJob().

◆ h_phoPhi_

TH1F* SimpleConvertedPhotonAnalyzer::h_phoPhi_
private

Definition at line 88 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by beginJob().

◆ h_scE_

TH1F* SimpleConvertedPhotonAnalyzer::h_scE_
private

Definition at line 82 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_scEta_

TH1F* SimpleConvertedPhotonAnalyzer::h_scEta_
private

Definition at line 83 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ h_scPhi_

TH1F* SimpleConvertedPhotonAnalyzer::h_scPhi_
private

Definition at line 84 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ HepMCLabel

std::string SimpleConvertedPhotonAnalyzer::HepMCLabel
private

Definition at line 59 of file SimpleConvertedPhotonAnalyzer.cc.

◆ nEvt_

int SimpleConvertedPhotonAnalyzer::nEvt_
private

Definition at line 55 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), beginJob(), and endJob().

◆ nMatched_

int SimpleConvertedPhotonAnalyzer::nMatched_
private

Definition at line 57 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ nMCPho_

int SimpleConvertedPhotonAnalyzer::nMCPho_
private

Definition at line 56 of file SimpleConvertedPhotonAnalyzer.cc.

Referenced by analyze(), and beginJob().

◆ SimHitLabel

std::string SimpleConvertedPhotonAnalyzer::SimHitLabel
private

Definition at line 62 of file SimpleConvertedPhotonAnalyzer.cc.

◆ SimTkLabel

std::string SimpleConvertedPhotonAnalyzer::SimTkLabel
private

Definition at line 60 of file SimpleConvertedPhotonAnalyzer.cc.

◆ SimVtxLabel

std::string SimpleConvertedPhotonAnalyzer::SimVtxLabel
private

Definition at line 61 of file SimpleConvertedPhotonAnalyzer.cc.

◆ thePhotonMCTruthFinder_

PhotonMCTruthFinder* SimpleConvertedPhotonAnalyzer::thePhotonMCTruthFinder_
private
SimpleConvertedPhotonAnalyzer::h_MCConvEta_
TH1F * h_MCConvEta_
Definition: SimpleConvertedPhotonAnalyzer.cc:79
PI
Definition: PayloadInspector.h:21
mps_fire.i
i
Definition: mps_fire.py:428
SimpleConvertedPhotonAnalyzer::h_phoE_
TH1F * h_phoE_
Definition: SimpleConvertedPhotonAnalyzer.cc:86
edm::Handle::product
T const * product() const
Definition: Handle.h:70
PI
#define PI
Definition: QcdUeDQM.h:37
edm
HLT enums.
Definition: AlignableModifier.h:19
gather_cfg.cout
cout
Definition: gather_cfg.py:144
SimpleConvertedPhotonAnalyzer::h_MCphoE_
TH1F * h_MCphoE_
Definition: SimpleConvertedPhotonAnalyzer.cc:72
PhotonMCTruthFinder::find
std::vector< PhotonMCTruth > find(const std::vector< SimTrack > &simTracks, const std::vector< SimVertex > &simVertices)
Definition: PhotonMCTruthFinder.cc:17
edm::LogInfo
Log< level::Info, false > LogInfo
Definition: MessageLogger.h:125
SimpleConvertedPhotonAnalyzer::nEvt_
int nEvt_
Definition: SimpleConvertedPhotonAnalyzer.cc:55
edm::Handle< reco::ConversionCollection >
SimpleConvertedPhotonAnalyzer::h_MCConvPt_
TH1F * h_MCConvPt_
Definition: SimpleConvertedPhotonAnalyzer.cc:78
reco::ConversionCollection
std::vector< Conversion > ConversionCollection
collectin of Conversion objects
Definition: ConversionFwd.h:9
spr::deltaEta
static const double deltaEta
Definition: CaloConstants.h:8
SimpleConvertedPhotonAnalyzer::h_deltaPhi_
TH1F * h_deltaPhi_
Definition: SimpleConvertedPhotonAnalyzer.cc:68
SiPixelRawToDigiRegional_cfi.deltaPhi
deltaPhi
Definition: SiPixelRawToDigiRegional_cfi.py:9
mathSSE::sqrt
T sqrt(T t)
Definition: SSEVec.h:19
SimpleConvertedPhotonAnalyzer::h_phoPhi_
TH1F * h_phoPhi_
Definition: SimpleConvertedPhotonAnalyzer.cc:88
Geom::pi
constexpr double pi()
Definition: Pi.h:31
Geom::twoPi
constexpr double twoPi()
Definition: Pi.h:32
PhotonMCTruthFinder
Definition: PhotonMCTruthFinder.h:20
SimpleConvertedPhotonAnalyzer::h_scE_
TH1F * h_scE_
Definition: SimpleConvertedPhotonAnalyzer.cc:82
AlCaHLTBitMon_QueryRunRegistry.string
string
Definition: AlCaHLTBitMon_QueryRunRegistry.py:256
SimpleConvertedPhotonAnalyzer::fOutputFile_
TFile * fOutputFile_
Definition: SimpleConvertedPhotonAnalyzer.cc:53
dumpMFGeometry_cfg.delta
delta
Definition: dumpMFGeometry_cfg.py:25
funct::tan
Tan< T >::type tan(const T &t)
Definition: Tan.h:22
SimpleConvertedPhotonAnalyzer::convertedPhotonCollectionProducer_
std::string convertedPhotonCollectionProducer_
Definition: SimpleConvertedPhotonAnalyzer.cc:64
SimpleConvertedPhotonAnalyzer::thePhotonMCTruthFinder_
PhotonMCTruthFinder * thePhotonMCTruthFinder_
Definition: SimpleConvertedPhotonAnalyzer.cc:50
SimpleConvertedPhotonAnalyzer::h_deltaEta_
TH1F * h_deltaEta_
Definition: SimpleConvertedPhotonAnalyzer.cc:69
SimpleConvertedPhotonAnalyzer::nMatched_
int nMatched_
Definition: SimpleConvertedPhotonAnalyzer.cc:57
SimpleConvertedPhotonAnalyzer::h_scEta_
TH1F * h_scEta_
Definition: SimpleConvertedPhotonAnalyzer.cc:83
SimpleConvertedPhotonAnalyzer::h_MCphoPhi_
TH1F * h_MCphoPhi_
Definition: SimpleConvertedPhotonAnalyzer.cc:73
SimpleConvertedPhotonAnalyzer::h2_tk_nHitsVsR_
TH2F * h2_tk_nHitsVsR_
Definition: SimpleConvertedPhotonAnalyzer.cc:91
SimpleConvertedPhotonAnalyzer::h_phoEta_
TH1F * h_phoEta_
Definition: SimpleConvertedPhotonAnalyzer.cc:87
SimpleConvertedPhotonAnalyzer::h_scPhi_
TH1F * h_scPhi_
Definition: SimpleConvertedPhotonAnalyzer.cc:84
SimpleConvertedPhotonAnalyzer::nMCPho_
int nMCPho_
Definition: SimpleConvertedPhotonAnalyzer.cc:56
SimpleConvertedPhotonAnalyzer::convertedPhotonCollection_
std::string convertedPhotonCollection_
Definition: SimpleConvertedPhotonAnalyzer.cc:65
ETA
#define ETA
Definition: GenericBenchmark.cc:28
SimpleConvertedPhotonAnalyzer::h_MCphoEta_
TH1F * h_MCphoEta_
Definition: SimpleConvertedPhotonAnalyzer.cc:74
dqm-mbProfile.log
log
Definition: dqm-mbProfile.py:17
funct::pow
Power< A, B >::type pow(const A &a, const B &b)
Definition: Power.h:29
SimpleConvertedPhotonAnalyzer::etaTransformation
float etaTransformation(float a, float b)
Definition: SimpleConvertedPhotonAnalyzer.cc:151
SimpleConvertedPhotonAnalyzer::h_MCConvE_
TH1F * h_MCConvE_
Definition: SimpleConvertedPhotonAnalyzer.cc:77
ZEcal
static constexpr float ZEcal
Definition: L1TkEmParticleProducer.cc:40
SimpleConvertedPhotonAnalyzer::fOutputFileName_
std::string fOutputFileName_
Definition: SimpleConvertedPhotonAnalyzer.cc:52
SimpleConvertedPhotonAnalyzer::h2_tk_inPtVsR_
TH2F * h2_tk_inPtVsR_
Definition: SimpleConvertedPhotonAnalyzer.cc:93
Z_Endcap
static constexpr float Z_Endcap
Definition: ECALPositionCalculator.cc:11
R_ECAL
static constexpr float R_ECAL
Definition: ECALPositionCalculator.cc:10
SimpleConvertedPhotonAnalyzer::h_ErecoEMC_
TH1F * h_ErecoEMC_
Definition: SimpleConvertedPhotonAnalyzer.cc:67
muonDTDigis_cfi.pset
pset
Definition: muonDTDigis_cfi.py:27
MillePedeFileConverter_cfg.e
e
Definition: MillePedeFileConverter_cfg.py:37
etaBarrelEndcap
static constexpr float etaBarrelEndcap
Definition: ECALPositionCalculator.cc:12