LArSoft  v10_04_05
Liquid Argon Software toolkit - https://larsoft.org/
SCECorrection_module.cc
Go to the documentation of this file.
1 // Class: SCECorrection
3 // Plugin Type: producer (art v3_04_00)
4 // File: SCECorrection_module.cc
5 //
6 // Generated at Sun Mar 22 09:23:33 2020 by Edward Tyley using cetskelgen
7 // from cetlib version v3_09_00.
9 
19 #include "fhiclcpp/ParameterSet.h"
21 
29 
39 
40 namespace sce {
41  class SCECorrection;
42 }
43 
45 public:
46  explicit SCECorrection(fhicl::ParameterSet const& p);
47  // The compiler-generated destructor is fine for non-base
48  // classes without bare pointers or other resource use.
49 
50  // Plugins should not be copied or assigned.
51  SCECorrection(SCECorrection const&) = delete;
52  SCECorrection(SCECorrection&&) = delete;
53  SCECorrection& operator=(SCECorrection const&) = delete;
55 
56  // Required functions.
57  void produce(art::Event& evt) override;
58 
59 private:
60  // Declare member data here.
63 
65 
66  const std::string fPFPLabel, fTrackLabel;
67  const std::vector<std::string> fT0Labels;
68  const std::vector<bool> fT0LabelsCorrectT0;
69 
70  geo::Vector_t applyT0Shift(const double& t0, const geo::TPCID& tpcId) const;
71 
72  std::map<art::Ptr<anab::T0>, bool> getSliceT0s(
73  const art::Event& evt,
74  const std::vector<art::Ptr<recob::PFParticle>>& slicePFPs,
75  const art::Handle<std::vector<recob::PFParticle>>& pfpHandle,
76  const art::Handle<std::vector<recob::Track>>& trackHandle,
77  const art::FindManyP<recob::Track>& fmPFPTrack) const;
78 
79  std::pair<art::Ptr<anab::T0>, bool> getSliceBestT0(
80  const std::map<art::Ptr<anab::T0>, bool>& sliceT0CorrectMap) const;
81 };
82 
84  : EDProducer{p}
85  , fSCE(lar::providerFrom<spacecharge::SpaceChargeService>())
86  , fCorrectNoT0Tag(p.get<bool>("CorrectNoT0Tag"))
87  , fCorrectSCE(p.get<bool>("CorrectSCE"))
88  , fSCEXCorrFlip(p.get<bool>("SCEXCorrFlip"))
89  , fPFPLabel(p.get<std::string>("PFPLabel"))
90  , fTrackLabel(p.get<std::string>("TrackLabel"))
91  , fT0Labels(p.get<std::vector<std::string>>("T0Labels"))
92  , fT0LabelsCorrectT0(p.get<std::vector<bool>>("T0LabelsCorrectT0"))
93 {
94  produces<std::vector<anab::T0>>();
95  produces<std::vector<recob::Slice>>();
96  produces<std::vector<recob::PFParticle>>();
97  produces<std::vector<recob::SpacePoint>>();
98  produces<std::vector<recob::Cluster>>();
99  produces<std::vector<recob::Vertex>>();
100  produces<std::vector<larpandoraobj::PFParticleMetadata>>();
101 
102  produces<art::Assns<anab::T0, recob::PFParticle>>();
103  produces<art::Assns<recob::Slice, recob::Hit>>();
104 
105  produces<art::Assns<recob::PFParticle, recob::Slice>>();
106  produces<art::Assns<recob::PFParticle, recob::SpacePoint>>();
107  produces<art::Assns<recob::PFParticle, recob::Vertex>>();
108  produces<art::Assns<recob::PFParticle, recob::Cluster>>();
109  produces<art::Assns<recob::PFParticle, larpandoraobj::PFParticleMetadata>>();
110  produces<art::Assns<recob::SpacePoint, recob::Hit>>();
111  produces<art::Assns<recob::Cluster, recob::Hit>>();
112 }
113 
115 {
116  // Implementation of required member function here.
117  auto t0Collection = std::make_unique<std::vector<anab::T0>>();
118  auto pfpCollection = std::make_unique<std::vector<recob::PFParticle>>();
119  auto clusterCollection = std::make_unique<std::vector<recob::Cluster>>();
120  auto spCollection = std::make_unique<std::vector<recob::SpacePoint>>();
121  auto vtxCollection = std::make_unique<std::vector<recob::Vertex>>();
122  auto sliceCollection = std::make_unique<std::vector<recob::Slice>>();
123  auto pfpMetaCollection = std::make_unique<std::vector<larpandoraobj::PFParticleMetadata>>();
124 
125  auto t0PFPAssn = std::make_unique<art::Assns<anab::T0, recob::PFParticle>>();
126  auto sliceHitAssn = std::make_unique<art::Assns<recob::Slice, recob::Hit>>();
127  auto pfpSliceAssn = std::make_unique<art::Assns<recob::PFParticle, recob::Slice>>();
128  auto pfpVtxAssn = std::make_unique<art::Assns<recob::PFParticle, recob::Vertex>>();
129  auto pfpSPAssn = std::make_unique<art::Assns<recob::PFParticle, recob::SpacePoint>>();
130  auto pfpClusterAssn = std::make_unique<art::Assns<recob::PFParticle, recob::Cluster>>();
131  auto pfpMetaAssn =
132  std::make_unique<art::Assns<recob::PFParticle, larpandoraobj::PFParticleMetadata>>();
133  auto spHitAssn = std::make_unique<art::Assns<recob::SpacePoint, recob::Hit>>();
134  auto clusterHitAssn = std::make_unique<art::Assns<recob::Cluster, recob::Hit>>();
135 
136  art::PtrMaker<anab::T0> t0PtrMaker{evt};
137  art::PtrMaker<recob::PFParticle> pfpPtrMaker{evt};
138  art::PtrMaker<recob::Cluster> clusterPtrMaker{evt};
139  art::PtrMaker<recob::Vertex> vtxPtrMaker{evt};
140  art::PtrMaker<recob::Slice> slicePtrMaker{evt};
141  art::PtrMaker<recob::SpacePoint> spPtrMaker{evt};
143 
144  // Get all the slices in the event
146  std::vector<art::Ptr<recob::Slice>> allSlices;
147  if (evt.getByLabel(fPFPLabel, sliceHandle)) art::fill_ptr_vector(allSlices, sliceHandle);
148 
149  // Get all the Clusters in the event
151  std::vector<art::Ptr<recob::Cluster>> allClusters;
152  if (evt.getByLabel(fPFPLabel, clusterHandle)) art::fill_ptr_vector(allClusters, clusterHandle);
153 
154  // Get all the SpacePoints in the event
156  std::vector<art::Ptr<recob::SpacePoint>> allSpacePoints;
157  if (evt.getByLabel(fPFPLabel, spHandle)) art::fill_ptr_vector(allSpacePoints, spHandle);
158 
159  // Get all the PFParticles in the event
161  std::vector<art::Ptr<recob::PFParticle>> allPFParticles;
162  if (evt.getByLabel(fPFPLabel, pfpHandle)) art::fill_ptr_vector(allPFParticles, pfpHandle);
163 
164  // Get all the Tracks in the event
166  std::vector<art::Ptr<recob::Track>> allTracks;
167  if (evt.getByLabel(fTrackLabel, trackHandle)) art::fill_ptr_vector(allTracks, trackHandle);
168 
169  art::FindManyP<recob::PFParticle> fmSlicePFP(sliceHandle, evt, fPFPLabel);
170  art::FindManyP<recob::Track> fmPFPTrack(pfpHandle, evt, fTrackLabel);
171  art::FindManyP<recob::SpacePoint> fmPFPSP(pfpHandle, evt, fPFPLabel);
172  art::FindManyP<recob::Cluster> fmPFPCluster(pfpHandle, evt, fPFPLabel);
173  art::FindManyP<recob::Vertex> fmPFPVertex(pfpHandle, evt, fPFPLabel);
174  art::FindManyP<recob::Hit> fmClusterHit(clusterHandle, evt, fPFPLabel);
175  art::FindManyP<recob::Hit> fmSPHit(spHandle, evt, fPFPLabel);
176  art::FindManyP<recob::Hit> fmSliceHit(sliceHandle, evt, fPFPLabel);
178 
179  // Check the assns that are necessary, others are optional and will be checked
180  // when they are used to create the new assns
181  if (!fmSlicePFP.isValid()) {
182  throw cet::exception("SCECorrection") << "FindMany Slice-PFP is not Valid" << std::endl;
183  }
184  if (!fmPFPSP.isValid()) {
185  throw cet::exception("SCECorrection") << "FindMany PFP-SpacePoint is not Valid" << std::endl;
186  }
187  if (!fmSPHit.isValid()) {
188  throw cet::exception("SCECorrection") << "FindMany SpacePoint-Hit is not Valid" << std::endl;
189  }
190 
191  // For each slice, get all the PFPs and tracks and check for T0 tags
192  auto const clockData = art::ServiceHandle<detinfo::DetectorClocksService const>()->DataFor(evt);
193  auto const detProp =
195 
196  for (auto const& slice : allSlices) {
197 
198  //Cretae a new slice
199  recob::Slice newSlice(*slice);
200  sliceCollection->push_back(newSlice);
201  art::Ptr<recob::Slice> newSlicePtr = slicePtrMaker(sliceCollection->size() - 1);
202 
203  // Get the pfps and hits associated to the slice
204  const std::vector<art::Ptr<recob::PFParticle>> slicePFPs = fmSlicePFP.at(slice.key());
205 
206  const std::map<art::Ptr<anab::T0>, bool> sliceT0CorrectMap =
207  getSliceT0s(evt, slicePFPs, pfpHandle, trackHandle, fmPFPTrack);
208 
209  const std::pair<art::Ptr<anab::T0>, bool> sliceT0CorrectPair =
210  getSliceBestT0(sliceT0CorrectMap);
211 
212  if (sliceT0CorrectPair.first.isNull() && !fCorrectNoT0Tag) { continue; }
213 
214  art::Ptr<anab::T0> newT0Ptr;
215  double t0Offset(0);
216  if (!sliceT0CorrectPair.first.isNull()) {
217  // Calculate the shift we need to apply for the t0
218  t0Offset = detProp.DriftVelocity() * sliceT0CorrectPair.first->Time() / 1e3;
219  // Create a new T0
220  t0Collection->push_back(*sliceT0CorrectPair.first);
221  newT0Ptr = t0PtrMaker(t0Collection->size() - 1);
222  }
223 
224  // Make an association with the new slice and the old hits
225  if (fmSliceHit.isValid()) {
226  const std::vector<art::Ptr<recob::Hit>> sliceHits = fmSliceHit.at(slice.key());
227  for (const art::Ptr<recob::Hit>& hitPtr : sliceHits) {
228  sliceHitAssn->addSingle(newSlicePtr, hitPtr);
229  }
230  }
231 
232  // Correct all PFPs in the slice
233  for (auto const& pfp : slicePFPs) {
234 
235  // Create new PFPs and associate them to the slice
236  recob::PFParticle newPFP(*pfp);
237  pfpCollection->push_back(newPFP);
238  art::Ptr<recob::PFParticle> newPFPPtr = pfpPtrMaker(pfpCollection->size() - 1);
239  pfpSliceAssn->addSingle(newPFPPtr, newSlicePtr);
240 
241  if (!newT0Ptr.isNull()) { t0PFPAssn->addSingle(newT0Ptr, newPFPPtr); }
242 
243  std::vector<art::Ptr<recob::SpacePoint>> pfpSPs = fmPFPSP.at(pfp.key());
244  // Get the vertex associated to the PFP
245  if (fmPFPVertex.isValid()) {
246  std::vector<art::Ptr<recob::Vertex>> pfpVertices = fmPFPVertex.at(pfp.key());
247  for (auto const& pfpVertex : pfpVertices) {
248 
249  geo::Point_t vtxPos(pfpVertex->position());
250  //Find the closest SP to the vertex
251  // If the PFP has no space points, look in the whole event
252  std::vector<art::Ptr<recob::SpacePoint>> vtxSPs = pfpSPs.size() ? pfpSPs : allSpacePoints;
253 
254  double minVtxSPDist = std::numeric_limits<double>::max();
256  for (auto const& sp : vtxSPs) {
257  geo::Point_t spPos(sp->XYZ()[0], sp->XYZ()[1], sp->XYZ()[2]);
258  geo::Vector_t vtxSPDiff = vtxPos - spPos;
259  if (vtxSPDiff.Mag2() < minVtxSPDist) {
260  spPtr = sp;
261  minVtxSPDist = vtxSPDiff.Mag2();
262  }
263  }
264 
265  if (spPtr.isNull()) continue;
266 
267  // Get the hit and TPC Id associated to closest SP
268  art::Ptr<recob::Hit> spHitPtr = fmSPHit.at(spPtr.key()).front();
269  geo::TPCID tpcId = spHitPtr->WireID().asTPCID();
270 
271  if (!sliceT0CorrectPair.first.isNull() && sliceT0CorrectPair.second) {
272  geo::Vector_t posOffset = applyT0Shift(t0Offset, tpcId);
273  vtxPos += posOffset;
274  }
275 
277  geo::Vector_t posOffset = fSCE->GetCalPosOffsets(vtxPos, tpcId.TPC);
278  if (fSCEXCorrFlip) { posOffset.SetX(-posOffset.X()); }
279  vtxPos += posOffset;
280  }
281 
282  // Create a new vertex and associate it to the PFP
283  recob::Vertex newVtx(
284  vtxPos, pfpVertex->covariance(), pfpVertex->chi2(), pfpVertex->ndof(), pfpVertex->ID());
285  vtxCollection->push_back(newVtx);
286  art::Ptr<recob::Vertex> newVtxPtr = vtxPtrMaker(vtxCollection->size() - 1);
287  pfpVtxAssn->addSingle(newPFPPtr, newVtxPtr);
288  }
289  }
290 
291  for (auto const& sp : pfpSPs) {
292 
293  //Get the spacepoint position in a nicer form
294  geo::Point_t spPos(sp->XYZ()[0], sp->XYZ()[1], sp->XYZ()[2]);
295 
296  // Get the hit so we know what TPC the sp was in
297  // N.B. We can't use SP position to infer the TPC as it could be
298  // shifted into another TPC
299  art::Ptr<recob::Hit> spHitPtr = fmSPHit.at(sp.key()).front();
300  geo::TPCID tpcId = spHitPtr->WireID().asTPCID();
301 
302  if (!sliceT0CorrectPair.first.isNull() && sliceT0CorrectPair.second) {
303  geo::Vector_t posOffset = applyT0Shift(t0Offset, tpcId);
304  spPos += posOffset;
305  }
306 
308  geo::Vector_t posOffset = fSCE->GetCalPosOffsets(spPos, tpcId.TPC);
309  if (fSCEXCorrFlip) { posOffset.SetX(-posOffset.X()); }
310  spPos += posOffset;
311  }
312 
313  // Create new spacepoint and associate it to the pfp and hit
314  Double32_t spXYZ[3] = {spPos.X(), spPos.Y(), spPos.Z()};
315  recob::SpacePoint correctedSP(spXYZ, sp->ErrXYZ(), sp->Chisq(), sp->ID());
316 
317  spCollection->push_back(correctedSP);
318  art::Ptr<recob::SpacePoint> spPtr = spPtrMaker(spCollection->size() - 1);
319  pfpSPAssn->addSingle(newPFPPtr, spPtr);
320  spHitAssn->addSingle(spPtr, spHitPtr);
321  } // pspSPs
322 
323  // Create new clusters and associations
324  if (fmPFPCluster.isValid() && fmClusterHit.isValid()) {
325  std::vector<art::Ptr<recob::Cluster>> pfpClusters = fmPFPCluster.at(pfp.key());
326  for (auto const& pfpCluster : pfpClusters) {
327  recob::Cluster newCluster(*pfpCluster);
328  clusterCollection->push_back(newCluster);
329  art::Ptr<recob::Cluster> newClusterPtr = clusterPtrMaker(clusterCollection->size() - 1);
330 
331  std::vector<art::Ptr<recob::Hit>> clusterHits = fmClusterHit.at(pfpCluster.key());
332  pfpClusterAssn->addSingle(newPFPPtr, newClusterPtr);
333  for (auto const& clusterHit : clusterHits) {
334  clusterHitAssn->addSingle(newClusterPtr, clusterHit);
335  }
336  }
337  }
338 
339  // Create new PFParticle Metadata objects and associations
340  if (fmPFPMeta.isValid()) {
341  const std::vector<art::Ptr<larpandoraobj::PFParticleMetadata>> pfpMetas =
342  fmPFPMeta.at(pfp.key());
343  for (const art::Ptr<larpandoraobj::PFParticleMetadata>& pfpMeta : pfpMetas) {
344  larpandoraobj::PFParticleMetadata newPFPMeta(*pfpMeta);
345  pfpMetaCollection->push_back(newPFPMeta);
347  pfpMetaPtrMaker(pfpMetaCollection->size() - 1);
348  pfpMetaAssn->addSingle(newPFPPtr, newPFPMetaPtr);
349  }
350  }
351  } // slicePFPs
352  } // slice
353 
354  // Put all the things we just produced into the event
355  evt.put(std::move(t0Collection));
356  evt.put(std::move(sliceCollection));
357  evt.put(std::move(clusterCollection));
358  evt.put(std::move(pfpCollection));
359  evt.put(std::move(spCollection));
360  evt.put(std::move(vtxCollection));
361  evt.put(std::move(pfpMetaCollection));
362 
363  evt.put(std::move(t0PFPAssn));
364  evt.put(std::move(sliceHitAssn));
365  evt.put(std::move(pfpSPAssn));
366  evt.put(std::move(spHitAssn));
367  evt.put(std::move(pfpVtxAssn));
368  evt.put(std::move(pfpSliceAssn));
369  evt.put(std::move(pfpClusterAssn));
370  evt.put(std::move(clusterHitAssn));
371  evt.put(std::move(pfpMetaAssn));
372 }
373 
375  const geo::TPCID& tpcId) const
376 {
377  auto const [axis, sign] = fGeom->TPC(tpcId).DriftAxisWithSign();
378  switch (axis) {
379  case geo::Coordinate::X: return geo::Vector_t{t0Offset * to_int(sign), 0, 0};
380  case geo::Coordinate::Y: return geo::Vector_t{0, t0Offset * to_int(sign), 0};
381  case geo::Coordinate::Z: return geo::Vector_t{0, 0, t0Offset * to_int(sign)};
382  }
383  return {}; // unreachable
384 }
385 
386 std::map<art::Ptr<anab::T0>, bool> sce::SCECorrection::getSliceT0s(
387  const art::Event& evt,
388  const std::vector<art::Ptr<recob::PFParticle>>& slicePFPs,
389  const art::Handle<std::vector<recob::PFParticle>>& pfpHandle,
390  const art::Handle<std::vector<recob::Track>>& trackHandle,
391  const art::FindManyP<recob::Track>& fmPFPTrack) const
392 {
393 
394  std::map<art::Ptr<anab::T0>, bool> pfpT0CorrectMap;
395  // Loop over all of the PFPs in the slice
396  for (auto const& pfp : slicePFPs) {
397 
398  // Loop over all of the T0 labels
399  // We will take the first label to have a T0, so the order matters
400  for (unsigned int i = 0; i < fT0Labels.size(); i++) {
401  std::string t0Label = fT0Labels.at(i);
402 
403  // Get the T0
404  art::FindManyP<anab::T0> fmPFPT0(pfpHandle, evt, t0Label);
405  if (fmPFPT0.isValid()) {
406  std::vector<art::Ptr<anab::T0>> pfpT0s = fmPFPT0.at(pfp.key());
407  if (pfpT0s.size() == 1) {
408  pfpT0CorrectMap[pfpT0s.front()] = fT0LabelsCorrectT0.at(i);
409  break;
410  }
411  }
412  // If not, Check the track associated to the PFP
413  if (!fmPFPTrack.isValid()) continue;
414  std::vector<art::Ptr<recob::Track>> pfpTracks = fmPFPTrack.at(pfp.key());
415  if (pfpTracks.size() != 1) { continue; }
416  art::Ptr<recob::Track> pfpTrack = pfpTracks.front();
417 
418  // Check if the track has a T0
419  art::FindManyP<anab::T0> fmTrackT0(trackHandle, evt, t0Label);
420  if (fmTrackT0.isValid()) {
421  std::vector<art::Ptr<anab::T0>> trackT0s = fmTrackT0.at(pfpTrack.key());
422  if (trackT0s.size() == 1) {
423  pfpT0CorrectMap[trackT0s.front()] = fT0LabelsCorrectT0.at(i);
424  break;
425  }
426  }
427  } // fT0Labels
428  } // slicePFPs
429  return pfpT0CorrectMap;
430 }
431 
432 std::pair<art::Ptr<anab::T0>, bool> sce::SCECorrection::getSliceBestT0(
433  const std::map<art::Ptr<anab::T0>, bool>& sliceT0CorrectMap) const
434 {
435 
436  if (!sliceT0CorrectMap.size()) { return std::pair<art::Ptr<anab::T0>, bool>(); }
437 
438  double minT0 = std::numeric_limits<double>::max();
439  std::pair<art::Ptr<anab::T0>, bool> sliceT0CorrectPair;
440  for (auto const& sliceT0CorrectIter : sliceT0CorrectMap) {
441  double t0Time = abs(sliceT0CorrectIter.first->Time());
442  if (t0Time < minT0) {
443  minT0 = t0Time;
444  sliceT0CorrectPair = sliceT0CorrectIter;
445  }
446  }
447  return sliceT0CorrectPair;
448 }
449 
code to link reconstructed objects back to the MC truth information
SCECorrection(fhicl::ParameterSet const &p)
Utilities related to art service access.
ROOT::Math::DisplacementVector3D< ROOT::Math::Cartesian3D< double >, ROOT::Math::GlobalCoordinateSystemTag > Vector_t
Type for representation of momenta in 3D space.
Definition: geo_vectors.h:160
virtual geo::Vector_t GetCalPosOffsets(geo::Point_t const &point, int const &TPCid) const =0
Declaration of signal hit object.
geo::Vector_t applyT0Shift(const double &t0, const geo::TPCID &tpcId) const
EDProducer(fhicl::ParameterSet const &pset)
Definition: EDProducer.cc:6
constexpr auto abs(T v)
Returns the absolute value of the argument.
Set of hits with a 2D structure.
Definition: Cluster.h:69
geo::WireID const & WireID() const
Initial tdc tick for hit.
Definition: Hit.h:290
DriftAxis DriftAxisWithSign() const
Returns the expected drift direction based on geometry.
Definition: TPCGeo.h:78
Definition of vertex object for LArSoft.
Definition: Vertex.h:35
void produce(art::Event &evt) override
spacecharge::SpaceCharge const * fSCE
PutHandle< PROD > put(std::unique_ptr< PROD > &&edp, std::string const &instance={})
Definition: Event.h:77
auto vector(Vector const &v)
Returns a manipulator which will print the specified array.
Definition: DumpUtils.h:289
std::map< art::Ptr< anab::T0 >, bool > getSliceT0s(const art::Event &evt, const std::vector< art::Ptr< recob::PFParticle >> &slicePFPs, const art::Handle< std::vector< recob::PFParticle >> &pfpHandle, const art::Handle< std::vector< recob::Track >> &trackHandle, const art::FindManyP< recob::Track > &fmPFPTrack) const
#define DEFINE_ART_MODULE(klass)
Definition: ModuleMacros.h:65
Metadata associated to PFParticles.
const std::string fPFPLabel
const std::vector< bool > fT0LabelsCorrectT0
key_type key() const noexcept
Definition: Ptr.h:166
bool isNull() const noexcept
Definition: Ptr.h:211
constexpr int to_int(Coordinate const coord) noexcept
Enumerate the possible plane projections.
Definition: geo_types.h:124
std::pair< art::Ptr< anab::T0 >, bool > getSliceBestT0(const std::map< art::Ptr< anab::T0 >, bool > &sliceT0CorrectMap) const
The data type to uniquely identify a TPC.
Definition: geo_types.h:306
Declaration of cluster object.
const std::string fTrackLabel
int sign(double val)
Definition: UtilFunc.cxx:104
ROOT::Math::PositionVector3D< ROOT::Math::Cartesian3D< double >, ROOT::Math::GlobalCoordinateSystemTag > Point_t
Type for representation of position in physical 3D space.
Definition: geo_vectors.h:180
virtual bool EnableCalSpatialSCE() const =0
Hierarchical representation of particle flow.
Definition: PFParticle.h:44
bool getByLabel(std::string const &label, std::string const &instance, Handle< PROD > &result) const
Utility object to perform functions of association.
Provides recob::Track data product.
art::ServiceHandle< geo::Geometry > fGeom
TCEvent evt
Definition: DataStructs.cxx:8
void fill_ptr_vector(std::vector< Ptr< T >> &ptrs, H const &h)
Definition: Ptr.h:306
TPCID_t TPC
Index of the TPC within its cryostat.
Definition: geo_types.h:315
TPCGeo const & TPC(TPCID const &tpcid=details::tpc_zero) const
Returns the specified TPC.
Definition: GeometryCore.h:448
art framework interface to geometry description
const std::vector< std::string > fT0Labels
cet::coded_exception< error, detail::translate > exception
Definition: exception.h:33
SCECorrection & operator=(SCECorrection const &)=delete
constexpr TPCID const & asTPCID() const
Conversion to PlaneID (for convenience of notation).
Definition: geo_types.h:409