Public Member Functions | Private Attributes | List of all members
myana::RegCNNVertexAna Class Reference
Inheritance diagram for myana::RegCNNVertexAna:
art::EDAnalyzer art::detail::Analyzer art::detail::LegacyModule art::Observer art::ModuleBase

Public Member Functions

 RegCNNVertexAna (fhicl::ParameterSet const &pset)
 
void analyze (art::Event const &evt)
 
void reconfigure (fhicl::ParameterSet const &p)
 
void reset ()
 
- Public Member Functions inherited from art::EDAnalyzer
 EDAnalyzer (fhicl::ParameterSet const &pset)
 
template<typename Config >
 EDAnalyzer (Table< Config > const &config)
 
std::string workerType () const
 
- Public Member Functions inherited from art::detail::Analyzer
virtual ~Analyzer () noexcept
 
 Analyzer (fhicl::ParameterSet const &pset)
 
template<typename Config >
 Analyzer (Table< Config > const &config)
 
void doBeginJob (SharedResources const &resources)
 
void doEndJob ()
 
void doRespondToOpenInputFile (FileBlock const &fb)
 
void doRespondToCloseInputFile (FileBlock const &fb)
 
void doRespondToOpenOutputFiles (FileBlock const &fb)
 
void doRespondToCloseOutputFiles (FileBlock const &fb)
 
bool doBeginRun (RunPrincipal &rp, ModuleContext const &mc)
 
bool doEndRun (RunPrincipal &rp, ModuleContext const &mc)
 
bool doBeginSubRun (SubRunPrincipal &srp, ModuleContext const &mc)
 
bool doEndSubRun (SubRunPrincipal &srp, ModuleContext const &mc)
 
bool doEvent (EventPrincipal &ep, ModuleContext const &mc, std::atomic< std::size_t > &counts_run, std::atomic< std::size_t > &counts_passed, std::atomic< std::size_t > &counts_failed)
 
- Public Member Functions inherited from art::Observer
 ~Observer () noexcept
 
 Observer (Observer const &)=delete
 
 Observer (Observer &&)=delete
 
Observeroperator= (Observer const &)=delete
 
Observeroperator= (Observer &&)=delete
 
void registerProducts (ProductDescriptions &, ModuleDescription const &)
 
void fillDescriptions (ModuleDescription const &)
 
fhicl::ParameterSetID selectorConfig () const
 
- Public Member Functions inherited from art::ModuleBase
virtual ~ModuleBase () noexcept
 
 ModuleBase ()
 
ModuleDescription const & moduleDescription () const
 
void setModuleDescription (ModuleDescription const &)
 
std::array< std::vector< ProductInfo >, NumBranchTypes > const & getConsumables () const
 
void sortConsumables (std::string const &current_process_name)
 
template<typename T , BranchType BT>
ViewToken< T > consumesView (InputTag const &tag)
 
template<typename T , BranchType BT>
ViewToken< T > mayConsumeView (InputTag const &tag)
 

Private Attributes

TTree * fTree
 
int ievt
 
double trueEnergy
 
float regcnn_energy
 
float CNN_vertex [3]
 
float CNN_vertex1ststep [3]
 
float CNN_vertex2ndstep [3]
 
float CNN_vertex2 [3]
 
int InDet
 
int FidCut
 
int nhits
 
int nu_truth_N
 
int nupdg_truth [kMax]
 
int numode_truth [kMax]
 
int nuccnc_truth [kMax]
 
double nueng_truth [kMax]
 
double nuvtxx_truth [kMax]
 
double nuvtxy_truth [kMax]
 
double nuvtxz_truth [kMax]
 
double ErecoNue
 
double RecoLepEnNue
 
double RecoHadEnNue
 
int RecoMethodNue
 
int pandora_nu_vtx
 
double pandora_nu_vtx_x
 
double pandora_nu_vtx_y
 
double pandora_nu_vtx_z
 
std::string fMCGenModuleLabel
 
std::string fHitsModuleLabel
 
std::string fEnergyRecoNueLabel
 
std::string fPandoraNuVertexModuleLabel
 
std::string fRegCNNResultLabel
 
std::string fRegCNNModuleLabel
 
std::string fRegCNNVtxResultLabel
 
std::string fRegCNNVtx1ststepResultLabel
 
std::string fRegCNNVtx2ndstepResultLabel
 
std::string fRegCNNVtxResult2Label
 
std::string fRegCNNVtxModuleLabel
 
std::string fRegCNNVtx1ststepModuleLabel
 
std::string fRegCNNVtx2ndstepModuleLabel
 
std::string fRegCNNVtxModule2Label
 
art::ServiceHandle< art::TFileService > tfs
 

Additional Inherited Members

- Public Types inherited from art::EDAnalyzer
using WorkerType = WorkerT< EDAnalyzer >
 
using ModuleType = EDAnalyzer
 
- Protected Member Functions inherited from art::Observer
std::string const & processName () const
 
bool wantAllEvents () const noexcept
 
bool wantEvent (ScheduleID id, Event const &e) const
 
Handle< TriggerResultsgetTriggerResults (Event const &e) const
 
 Observer (fhicl::ParameterSet const &config)
 
 Observer (std::vector< std::string > const &select_paths, std::vector< std::string > const &reject_paths, fhicl::ParameterSet const &config)
 
- Protected Member Functions inherited from art::ModuleBase
ConsumesCollectorconsumesCollector ()
 
template<typename T , BranchType = InEvent>
ProductToken< T > consumes (InputTag const &)
 
template<typename Element , BranchType = InEvent>
ViewToken< Element > consumesView (InputTag const &)
 
template<typename T , BranchType = InEvent>
void consumesMany ()
 
template<typename T , BranchType = InEvent>
ProductToken< T > mayConsume (InputTag const &)
 
template<typename Element , BranchType = InEvent>
ViewToken< Element > mayConsumeView (InputTag const &)
 
template<typename T , BranchType = InEvent>
void mayConsumeMany ()
 

Detailed Description

Definition at line 36 of file RegCNNVertexAna_module.cc.

Constructor & Destructor Documentation

myana::RegCNNVertexAna::RegCNNVertexAna ( fhicl::ParameterSet const &  pset)

Definition at line 102 of file RegCNNVertexAna_module.cc.

102  : EDAnalyzer(pset)
103 {
104  this->reconfigure(pset);
105  fTree = tfs->make<TTree>("anatree", "anatree");
106  fTree->Branch("ievent", &ievt, "ievent/I");
107  fTree->Branch("InDet", &InDet, "InDet/I");
108  fTree->Branch("FidCut", &FidCut, "FidCut/I");
109  fTree->Branch("TrueEnergy", &trueEnergy, "TrueEnergy/D");
110  fTree->Branch("CNNEnergy", &regcnn_energy, "CNNEnergy/F");
111  fTree->Branch("CNNVertex", CNN_vertex, "CNNVertex[3]/F");
112  fTree->Branch("CNNVertex1ststep", CNN_vertex1ststep, "CNNVertex1ststep[3]/F");
113  fTree->Branch("CNNVertex2ndstep", CNN_vertex2ndstep, "CNNVertex2ndstep[3]/F");
114  fTree->Branch("CNNVertex2", CNN_vertex2, "CNNVertex2[3]/F");
115 
116  fTree->Branch("NuTruthN", &nu_truth_N, "NuTruthN/I");
117  fTree->Branch("NuEngTruth", nueng_truth, "NuEngTruth[NuTruthN]/D");
118  fTree->Branch("NuPDGTruth", nupdg_truth, "NuPDGTruth[NuTruthN]/I");
119  fTree->Branch("NuModeTruth", numode_truth, "NuModeTruth[NuTruthN]/I");
120  fTree->Branch("NuCCNCTruth", nuccnc_truth, "NuCCNCTruth[NuTruthN]/I");
121 
122  fTree->Branch("NuVtxXTruth", nuvtxx_truth, "NuVtxXTruth[NuTruthN]/D");
123  fTree->Branch("NuVtxYTruth", nuvtxy_truth, "NuVtxYTruth[NuTruthN]/D");
124  fTree->Branch("NuVtxZTruth", nuvtxz_truth, "NuVtxZTruth[NuTruthN]/D");
125 
126  fTree->Branch("PandNuVtx", &pandora_nu_vtx, "PandNuVtx/I");
127  fTree->Branch("PandNuVertexX", &pandora_nu_vtx_x, "PandNuVertexX/D");
128  fTree->Branch("PandNuVertexY", &pandora_nu_vtx_y, "PandNuVertexY/D");
129  fTree->Branch("PandNuVertexZ", &pandora_nu_vtx_z, "PandNuVertexZ/D");
130 
131  fTree->Branch("NHits", &nhits, "NHits/I");
132 
133  fTree->Branch("ErecoNue", &ErecoNue, "ErecoNue/D");
134  fTree->Branch("RecoLepEnNue", &RecoLepEnNue, "RecoLepEnNue/D");
135  fTree->Branch("RecoHadEnNue", &RecoHadEnNue, "RecoHadEnNue/D");
136  fTree->Branch("RecoMethodNue", &RecoMethodNue, "RecoMethodNue/I");
137 
138 
139 }
art::ServiceHandle< art::TFileService > tfs
EDAnalyzer(fhicl::ParameterSet const &pset)
Definition: EDAnalyzer.h:25
void reconfigure(fhicl::ParameterSet const &p)

Member Function Documentation

void myana::RegCNNVertexAna::analyze ( art::Event const &  evt)
virtual

Implements art::EDAnalyzer.

Definition at line 164 of file RegCNNVertexAna_module.cc.

165 {
166  this->reset();
167  ievt = evt.id().event();
168  bool isMC = !evt.isRealData();
169 
170  // * MC truth information
171 
172  std::vector<art::Ptr<simb::MCTruth> > mclist;
173  if (isMC){
174  auto mctruthListHandle = evt.getHandle< std::vector<simb::MCTruth> >(fMCGenModuleLabel);
175  if (mctruthListHandle)
176  art::fill_ptr_vector(mclist, mctruthListHandle);
177  }
178 
179  // Get the hits out of the event record
180  std::vector<art::Ptr<recob::Hit> > hits;
181  auto hitHandle = evt.getHandle<std::vector<recob::Hit> >(fHitsModuleLabel);
182  if (hitHandle)
183  art::fill_ptr_vector(hits, hitHandle);
184 
185  // Get DUNE energy Reco
186  auto engrecoHandle = evt.getHandle<dune::EnergyRecoOutput>(fEnergyRecoNueLabel);
187 
188  // Get RegCNN Results
190  auto cnnresultListHandle = evt.getHandle<std::vector<cnn::RegCNNResult>>(itag);
191 
193  auto cnnvtxresultListHandle = evt.getHandle<std::vector<cnn::RegCNNResult>>(itag2);
194 
196  auto cnnvtxresultListHandle1st = evt.getHandle<std::vector<cnn::RegCNNResult>>(itag3);
197 
199  auto cnnvtxresultListHandle2nd = evt.getHandle<std::vector<cnn::RegCNNResult>>(itag4);
200 
202  auto cnnvtxresultListHandle2 = evt.getHandle<std::vector<cnn::RegCNNResult>>(itag5);
203 
204  // Get Truth information
205  if (mclist.size()>0)
206  {
207  int neutrino_i = 0;
208  for(size_t iList = 0; (iList < mclist.size()) && (neutrino_i < kMax) ; ++iList)
209  {
210  if (mclist[iList]->NeutrinoSet())
211  {
212  nueng_truth[neutrino_i] = mclist[iList]->GetNeutrino().Nu().Momentum().E();
213  nupdg_truth[neutrino_i] = mclist[iList]->GetNeutrino().Nu().PdgCode();
214  nuccnc_truth[neutrino_i] = mclist[iList]->GetNeutrino().CCNC();
215  numode_truth[neutrino_i] = mclist[iList]->GetNeutrino().Mode();
216 
217  nuvtxx_truth[neutrino_i] = mclist[iList]->GetNeutrino().Nu().Vx();
218  nuvtxy_truth[neutrino_i] = mclist[iList]->GetNeutrino().Nu().Vy();
219  nuvtxz_truth[neutrino_i] = mclist[iList]->GetNeutrino().Nu().Vz();
220 
221  neutrino_i++;
222  }
223  }
224  nu_truth_N = neutrino_i;
225  }
226  // Get Hit information
227  nhits = hits.size();
228  InDet = 0;
229  //cut with true vertex in fiducial volume
230  FidCut = 0;
231  if (nu_truth_N>0){
232  if(fabs(nuvtxx_truth[0]) < 310. && fabs(nuvtxy_truth[0]) < 550. && nuvtxz_truth[0] > 50. && nuvtxz_truth[0] < 1250.) FidCut = 1;
233  }
234 
235  // Pandora Nu Vertex
236  lar_pandora::PFParticleVector particleVector;
238  lar_pandora::VertexVector vertexVector;
239  lar_pandora::PFParticlesToVertices particlesToVertices;
241 
242  pandora_nu_vtx = 0, pandora_nu_vtx_x = -10000, pandora_nu_vtx_y = -10000, pandora_nu_vtx_z = -10000;
243 
244  double xyz_temp[3] = {0.0, 0.0, 0.0} ;
245  for (unsigned int ipfp = 0; ipfp < particleVector.size(); ipfp++){
246  const art::Ptr<recob::PFParticle> particle = particleVector.at(ipfp);
247  if (!particle->IsPrimary()) continue;
248 
249  // Particles <-> Vertices
250  lar_pandora::PFParticlesToVertices::const_iterator vIter = particlesToVertices.find(particle);
251  if (particlesToVertices.end() != vIter)
252  {
253  const lar_pandora::VertexVector &vertexVector = vIter->second;
254  if (!vertexVector.empty())
255  {
256  if (vertexVector.size() !=1)
257  std::cout << " Warning: Found particle with more than one associated vertex " << std::endl;
258 
259  const art::Ptr<recob::Vertex> vertex_pfp = *(vertexVector.begin());
260  vertex_pfp->XYZ(xyz_temp);
261 
262  pandora_nu_vtx = 1;
263  pandora_nu_vtx_x = xyz_temp[0];
264  pandora_nu_vtx_y = xyz_temp[1];
265  pandora_nu_vtx_z = xyz_temp[2];
266  }
267  } // end of if
268  } // end of loop particleVector
269 
270 
271 
272  // Get RecoE from DUNE
273  if (!engrecoHandle.failedToGet())
274  {
275  ErecoNue = engrecoHandle->fNuLorentzVector.E();
276  RecoLepEnNue = engrecoHandle->fLepLorentzVector.E();
277  RecoHadEnNue = engrecoHandle->fHadLorentzVector.E();
278  RecoMethodNue = engrecoHandle->recoMethodUsed;
279  std::cout<< ErecoNue << std::endl;
280  }
281 
282  // Get RegCNN Results
283  if (!cnnresultListHandle.failedToGet())
284  {
285  if (!cnnresultListHandle->empty())
286  {
287  const std::vector<float>& v = (*cnnresultListHandle)[0].fOutput;
288  for (unsigned int ii = 0; ii < 1; ii++){
289  regcnn_energy = v[ii];
290  }
291  }
292  }
293 
294 
295  // Get RegCNN Results
296  if (!cnnvtxresultListHandle.failedToGet())
297  {
298  if (!cnnvtxresultListHandle->empty())
299  {
300  const std::vector<float>& v = (*cnnvtxresultListHandle)[0].fOutput;
301  for (unsigned int ii = 0; ii < 3; ii++){
302  CNN_vertex[ii] = v[ii];
303  }
304  }
305  }
306 
307  // Get RegCNN Results
308  if (!cnnvtxresultListHandle2.failedToGet())
309  {
310  if (!cnnvtxresultListHandle2->empty())
311  {
312  const std::vector<float>& v = (*cnnvtxresultListHandle2)[0].fOutput;
313  for (unsigned int ii = 0; ii < 3; ii++){
314  CNN_vertex2[ii] = v[ii];
315  }
316  }
317  }
318 
319  // Get RegCNN Results
320  if (!cnnvtxresultListHandle1st.failedToGet())
321  {
322  if (!cnnvtxresultListHandle1st->empty())
323  {
324  const std::vector<float>& v = (*cnnvtxresultListHandle1st)[0].fOutput;
325  //std::cout << v[0] << std::endl;
326  for (unsigned int ii = 0; ii < 3; ii++){
327  CNN_vertex1ststep[ii] = v[ii];
328  }
329  }
330  }
331  // Get RegCNN Results
332  if (!cnnvtxresultListHandle2nd.failedToGet())
333  {
334  if (!cnnvtxresultListHandle2nd->empty())
335  {
336  const std::vector<float>& v = (*cnnvtxresultListHandle2nd)[0].fOutput;
337  //std::cout << v[0] << std::endl;
338  for (unsigned int ii = 0; ii < 3; ii++){
339  CNN_vertex2ndstep[ii] = v[ii];
340  }
341  }
342  }
343 
344 
345 
346  // fill entry
347  fTree->Fill();
348 }
void XYZ(double *xyz) const
Legacy method to access vertex position, preserved to avoid breaking code. Please try to use Vertex::...
Definition: Vertex.cxx:36
unsigned int event
Definition: DataStructs.h:636
intermediate_table::const_iterator const_iterator
std::map< art::Ptr< recob::PFParticle >, VertexVector > PFParticlesToVertices
const int kMax
std::vector< art::Ptr< recob::PFParticle > > PFParticleVector
static void CollectVertices(const art::Event &evt, const std::string &label, VertexVector &vertexVector, PFParticlesToVertices &particlesToVertices)
Collect the reconstructed PFParticles and associated Vertices from the ART event record.
bool IsPrimary() const
Returns whether the particle is the root of the flow.
Definition: PFParticle.h:86
static void CollectPFParticles(const art::Event &evt, const std::string &label, PFParticleVector &particleVector)
Collect the reconstructed PFParticles from the ART event record.
std::vector< art::Ptr< recob::Vertex > > VertexVector
TCEvent evt
Definition: DataStructs.cxx:7
void fill_ptr_vector(std::vector< Ptr< T >> &ptrs, H const &h)
Definition: Ptr.h:297
QTextStream & endl(QTextStream &s)
void myana::RegCNNVertexAna::reconfigure ( fhicl::ParameterSet const &  p)

Definition at line 141 of file RegCNNVertexAna_module.cc.

142 {
143  fMCGenModuleLabel = pset.get<std::string>("MCGenModuleLabel");
144  fHitsModuleLabel = pset.get<std::string>("HitsModuleLabel");
145  fEnergyRecoNueLabel = pset.get<std::string>("EnergyRecoNueLabel");
146 
147  fPandoraNuVertexModuleLabel = pset.get<std::string>("PandoraNuVertexModuleLabel");
148 
149  fRegCNNResultLabel = pset.get<std::string>("RegCNNEngResultLabel");
150  fRegCNNModuleLabel = pset.get<std::string>("RegCNNEngModuleLabel");
151 
152  fRegCNNVtxResultLabel = pset.get<std::string>("RegCNNVtxResultLabel");
153  fRegCNNVtx1ststepResultLabel = pset.get<std::string>("RegCNNVtx1ststepResultLabel");
154  fRegCNNVtx2ndstepResultLabel = pset.get<std::string>("RegCNNVtx2ndstepResultLabel");
155  fRegCNNVtxResult2Label = pset.get<std::string>("RegCNNVtxResult2Label");
156 
157  fRegCNNVtxModuleLabel = pset.get<std::string>("RegCNNVtxModuleLabel");
158  fRegCNNVtx1ststepModuleLabel = pset.get<std::string>("RegCNNVtx1ststepModuleLabel");
159  fRegCNNVtx2ndstepModuleLabel = pset.get<std::string>("RegCNNVtx2ndstepModuleLabel");
160  fRegCNNVtxModule2Label = pset.get<std::string>("RegCNNVtxModule2Label");
161 
162 }
std::string string
Definition: nybbler.cc:12
void myana::RegCNNVertexAna::reset ( )

Definition at line 350 of file RegCNNVertexAna_module.cc.

351 {
352  ievt = -9999;
353  trueEnergy = -99999;
354  regcnn_energy = -99999;
355  ErecoNue = -99999;
356  RecoLepEnNue = -99999;
357  RecoHadEnNue = -99999;
358  RecoMethodNue = -99999;
359 
360  for (int ii = 0; ii < 3; ii++){
361  CNN_vertex[ii] = -99999;
362  CNN_vertex1ststep[ii] = -99999;
363  CNN_vertex2ndstep[ii] = -99999;
364  CNN_vertex2[ii] = -99999;
365  }
366  nu_truth_N = 0;
367  for (int ii = 0; ii < kMax; ++ii)
368  {
369  nupdg_truth[ii] = -99999;
370  numode_truth[ii] = -99999;
371  nuccnc_truth[ii] = -99999;
372  nueng_truth[ii] = -99999;
373 
374  nuvtxx_truth[ii] = -99999;
375  nuvtxy_truth[ii] = -99999;
376  nuvtxz_truth[ii] = -99999;
377 
378  }
379 
380 }
const int kMax

Member Data Documentation

float myana::RegCNNVertexAna::CNN_vertex[3]
private

Definition at line 49 of file RegCNNVertexAna_module.cc.

float myana::RegCNNVertexAna::CNN_vertex1ststep[3]
private

Definition at line 50 of file RegCNNVertexAna_module.cc.

float myana::RegCNNVertexAna::CNN_vertex2[3]
private

Definition at line 52 of file RegCNNVertexAna_module.cc.

float myana::RegCNNVertexAna::CNN_vertex2ndstep[3]
private

Definition at line 51 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::ErecoNue
private

Definition at line 66 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fEnergyRecoNueLabel
private

Definition at line 80 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fHitsModuleLabel
private

Definition at line 79 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::FidCut
private

Definition at line 55 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fMCGenModuleLabel
private

Definition at line 78 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fPandoraNuVertexModuleLabel
private

Definition at line 82 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNModuleLabel
private

Definition at line 85 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNResultLabel
private

Definition at line 84 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtx1ststepModuleLabel
private

Definition at line 93 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtx1ststepResultLabel
private

Definition at line 88 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtx2ndstepModuleLabel
private

Definition at line 94 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtx2ndstepResultLabel
private

Definition at line 89 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtxModule2Label
private

Definition at line 95 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtxModuleLabel
private

Definition at line 92 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtxResult2Label
private

Definition at line 90 of file RegCNNVertexAna_module.cc.

std::string myana::RegCNNVertexAna::fRegCNNVtxResultLabel
private

Definition at line 87 of file RegCNNVertexAna_module.cc.

TTree* myana::RegCNNVertexAna::fTree
private

Definition at line 45 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::ievt
private

Definition at line 46 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::InDet
private

Definition at line 54 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::nhits
private

Definition at line 56 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::nu_truth_N
private

Definition at line 57 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::nuccnc_truth[kMax]
private

Definition at line 60 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::nueng_truth[kMax]
private

Definition at line 61 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::numode_truth[kMax]
private

Definition at line 59 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::nupdg_truth[kMax]
private

Definition at line 58 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::nuvtxx_truth[kMax]
private

Definition at line 62 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::nuvtxy_truth[kMax]
private

Definition at line 63 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::nuvtxz_truth[kMax]
private

Definition at line 64 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::pandora_nu_vtx
private

Definition at line 72 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::pandora_nu_vtx_x
private

Definition at line 73 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::pandora_nu_vtx_y
private

Definition at line 74 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::pandora_nu_vtx_z
private

Definition at line 75 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::RecoHadEnNue
private

Definition at line 68 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::RecoLepEnNue
private

Definition at line 67 of file RegCNNVertexAna_module.cc.

int myana::RegCNNVertexAna::RecoMethodNue
private

Definition at line 69 of file RegCNNVertexAna_module.cc.

float myana::RegCNNVertexAna::regcnn_energy
private

Definition at line 48 of file RegCNNVertexAna_module.cc.

art::ServiceHandle<art::TFileService> myana::RegCNNVertexAna::tfs
private

Definition at line 98 of file RegCNNVertexAna_module.cc.

double myana::RegCNNVertexAna::trueEnergy
private

Definition at line 47 of file RegCNNVertexAna_module.cc.


The documentation for this class was generated from the following file: