The geometry of one entire detector (near, far, ipnd) More...
#include "/cvmfs/nova-development.opensciencegrid.org/novasoft/releases/N21-01-18/Geometry/Geometry.h"
Public Types | |
using | Parameters = art::ServiceTable< GeometryBase::Params > |
template<class T > | |
using | Atom = fhicl::Atom< T > |
template<class T > | |
using | Table = fhicl::Table< T > |
using | Comment = fhicl::Comment |
using | Name = fhicl::Name |
Public Member Functions | |
Geometry (const Parameters ¶ms, art::ActivityRegistry ®) | |
~Geometry () | |
void | preBeginRun (art::Run const &run) |
bool | calculateMassesLong (const unsigned int number_of_points) const |
TVector3 | getDirectionInBeamCoordinates (TVector3 const &startPos, TVector3 const &dir) const |
Get direction of the Prong in the beam coordinates. More... | |
const PlaneGeo * | Plane (unsigned int i) const |
const std::set< unsigned int > & | GetPlanesByView (View_t v=kXorY) const |
const unsigned int | NextPlaneInView (unsigned int p, int d=+1) const |
const unsigned int | NextPlaneOtherView (unsigned int p, int d=+1) const |
const unsigned int | FirstPlaneInMuonCatcher () const |
Returns the index of the first plane contained in the muon catcher. More... | |
double | CellTpos (unsigned int ip, unsigned int ic, double w=0.0) const |
void | CellInfo (unsigned int ip, unsigned int ic, View_t *view=0, double *pos=0, double *dpos=0) const |
const CellGeo * | IdToCell (const CellUniqueId &id, int *iplane, int *icell) const |
const PlaneGeo * | IdToPlane (const CellUniqueId &id, int *iplane) const |
int | getPlaneID (const CellUniqueId &id) const |
int | getPlaneID (const double &x, const double &y, const double &z) const |
int | getCellID (const CellUniqueId &id) const |
int | getCellID (const double &x, const double &y, const double &z) const |
bool | getPlaneAndCellID (const CellUniqueId &id, int &plane, int &cell) const |
bool | getPlaneAndCellID (const double &x, const double &y, const double &z, int &plane, int &cell) const |
void | CountCellsOnLine (double X1, double Y1, double Z1, double X2, double Y2, double Z2, std::vector< OfflineChan > &Xhitsonline, std::vector< OfflineChan > &Yhitsonline) |
void | CountCellsOnLine (TVector3 r1, TVector3 r2, std::vector< OfflineChan > &Xhitsonline, std::vector< OfflineChan > &Yhitsonline) |
void | CountCellsOnLine (double X1, double Y1, double Z1, double X2, double Y2, double Z2, std::vector< CellOnLine > &Xhitsonline, std::vector< CellOnLine > &Yhitsonline) |
Make list of cells in each view traversed by a line segment and the entry and exit points into each cell. More... | |
void | CountCellsOnLine (TVector3 r1, TVector3 r2, std::vector< CellOnLine > &Xhitsonline, std::vector< CellOnLine > &Yhitsonline) |
void | CountCellsOnLineFast (double x1, double y1, double z1, double x2, double y2, double z2, std::vector< OfflineChan > &Xhitsonline, std::vector< OfflineChan > &Yhitsonline) |
Make list of cells in each view traversed by a line segment. More... | |
void | CountCellsOnLineFast (TVector3 r1, TVector3 r2, std::vector< OfflineChan > &Xhitsonline, std::vector< OfflineChan > &Yhitsonline) |
void | CountCellsOnLineFast (geo::View_t view, double v1, double z1, double v2, double z2, std::vector< OfflineChan > &hitsonline) |
2D version More... | |
unsigned int | NPlanes () const |
double | DetHalfWidth () const |
double | DetHalfHeight () const |
double | DetLength () const |
double | SurfaceY () const |
TVector3 | NuMIBeamDirection () const |
Direction of neutrinos from the NuMI beam (unit vector) More... | |
TVector3 | BoosterBeamDirection () const |
Direction of neutrinos from the Booster beam (unit vector) More... | |
double | DistToElectronics (double localz, const CellGeo &cell) const |
get distance from local z position in cell to apd in cm, including pigtail More... | |
double | GetPigtail (const CellUniqueId &id) const |
Return length of fiber in cm from end of cell to apd. More... | |
void | WorldBox (double *xlo_cm, double *xhi_cm, double *ylo_cm, double *yhi_cm, double *zlo_cm, double *zhi_cm) const |
void | DetectorEnclosureBox (double *xlo_cm, double *xhi_cm, double *ylo_cm, double *yhi_cm, double *zlo_cm, double *zhi_cm) const |
void | DetectorBigBox (double *xlo_cm, double *xhi_cm, double *ylo_cm, double *yhi_cm, double *zlo_cm, double *zhi_cm) const |
bool | IntersectsDetector (double *xyz_cm, double *dxyz) const |
bool | IntersectsBigBox (double *xyz_cm, double *dxyz) const |
bool | isDetectorBigBoxUsed () const |
Do we use the Detector Big Box. More... | |
bool | isInsideDetectorBigBox (const double x_cm, const double y_cm, const double z_cm) const |
Is the particle inside the detector Big Box? More... | |
bool | isInsideFiducialVolume (const double x_cm, const double y_cm, const double z_cm) const |
Is the particle inside the detector Fiducial Volume? More... | |
bool | isInsideFiducialVolume (const double *xyz_dimensionless) const |
void | FiducialBox (TVector3 &r0, TVector3 &r1) const |
int | CurrentCell (int *ip, int *ic) const |
const CellUniqueId | CurrentCellId () const |
const CellUniqueId | CellId (const double &x, const double &y, const double &z, double dxds=0., double dyds=0., double dzds=1., double step=0.01) const |
TGeoMaterial * | Material (double x, double y, double z) const |
bool | IsActive (const TGeoMaterial *m) const |
double | TotalMass (const char *volume="vDetEnclosure") const |
double | MassBetweenPoints (double *p1, double *p2) const |
void | MaterialsBetweenPoints (const double *p1, const double *p2, std::vector< double > &ds, std::vector< const TGeoMaterial * > &mat) const |
void | MaterialsBetweenPoints (TVector3 v1, TVector3 v2, std::vector< double > &ds, std::vector< const TGeoMaterial * > &mat) const |
bool | calculateMassesLong (const unsigned int number_of_points, CLHEP::HepRandomEngine &engine) const |
double | DEdge (const double *x0, const double *dx, double *exitp=0) const |
double | ClosestApproach (unsigned int ip, unsigned int ic, const TVector3 &vtx, const TVector3 &dir, double dx=0.0, double dy=0.0, double *w=0, double *s=0, TVector3 *point_in_cell=0, TVector3 *point_on_track=0) const |
Find the distance of closest approach between a cell and a track. More... | |
std::string | GDMLFile () const |
std::string | ROOTFile () const |
std::string | GDMLFromFCL () const |
std::string | FileBaseName () const |
int | Run () const |
TGeoManager * | ROOTGeoManager () const |
novadaq::cnv::DetId | DetId () const |
Prefer ds::DetectorService::DetId() instead. More... | |
CoordinateTransformation * | getCoordinateTransformation () const |
std::string | ExtractGDML () const |
Extract contents from fGDMLFile and return as a string. More... | |
Static Public Member Functions | |
static std::string | ExtractGDML (std::string fname, bool fullpath) |
Extract contents from fname and return as a string. More... | |
Protected Types | |
typedef std::unordered_map< CellUniqueId, OfflineChan > | UIDMap |
Protected Member Functions | |
virtual void | setDetectorID (novadaq::cnv::DetId) override |
Method to set DetectorID. More... | |
geo::OfflineChan | getPlaneCellMap (const CellUniqueId &id) const |
void | setDetectorBigBox (double detector_bigbox_range) |
void | FindPlanes (std::vector< const TGeoNode * > &n, unsigned int depth, bool inMuonCatcher=false) |
void | MakePlane (std::vector< const TGeoNode * > &n, unsigned int depth, bool inMuonCatcher) |
void | SetDrawOptions () |
void | BuildMaps () |
void | SetDetectorSize () |
bool | LoadGeometryFile (std::string gdmlfile, novadaq::cnv::DetId det_id=novadaq::cnv::kUNKNOWN_DET) |
In case of unknown ID, guesses from the filename. More... | |
int | MakeTmpFile (std::string gdmlInfo) |
void | RemoveTmpFile (std::string fileName) |
Method to remove temporary file that holds detector geometry file. More... | |
Static Protected Member Functions | |
static std::string | FindGDMLFile (std::string fname) |
Search for Geometry/gdml/fname in FW_SEARCH_PATH, return full path. More... | |
The geometry of one entire detector (near, far, ipnd)
Definition at line 23 of file Geometry.h.
|
inherited |
Definition at line 51 of file GeometryBase.h.
|
inherited |
Definition at line 53 of file GeometryBase.h.
|
inherited |
Definition at line 54 of file GeometryBase.h.
Definition at line 27 of file Geometry.h.
|
inherited |
Definition at line 52 of file GeometryBase.h.
|
protectedinherited |
Definition at line 255 of file GeometryBase.h.
geo::Geometry::Geometry | ( | const Parameters & | params, |
art::ActivityRegistry & | reg | ||
) |
Definition at line 30 of file Geometry_service.cc.
References geo::GeometryBase::fDetId, preBeginRun(), setDetectorID(), and art::ActivityRegistry::sPreBeginRun.
geo::Geometry::~Geometry | ( | ) |
Definition at line 46 of file Geometry_service.cc.
References geo::GeometryBase::fGDMLFile, and geo::GeometryBase::RemoveTmpFile().
|
inherited |
Direction of neutrinos from the Booster beam (unit vector)
Definition at line 557 of file GeometryBase.cxx.
References e, geo::GeometryBase::fDetId, novadaq::cnv::kNDOS, and novadaq::cnv::kNEARDET.
|
protectedinherited |
Build maps used for quick access to the geometry
Definition at line 996 of file GeometryBase.cxx.
References plot_validation_datamc::c, geo::PlaneGeo::Cell(), geo::GeometryBase::fAllPlanes, geo::GeometryBase::fIdMap, geo::GeometryBase::fPlanes, geo::GeometryBase::fXplanes, geo::GeometryBase::fYplanes, MECModelEnuComparisons::i, geo::CellGeo::Id(), calib::j, geo::kX, geo::kY, geo::PlaneGeo::Ncells(), and geo::GeometryBase::Plane().
Referenced by geo::GeometryBase::LoadGeometryFile().
bool geo::Geometry::calculateMassesLong | ( | const unsigned int | number_of_points | ) | const |
Definition at line 143 of file Geometry_service.cc.
References geo::GeometryBase::calculateMassesLong(), and art::RandomNumberGenerator::getEngine().
|
inherited |
Method to calculate masses of the detector
Definition at line 1068 of file GeometryBase.cxx.
References CLHEP::cm, CLHEP::cm3, om::cout, barite::density, geo::GeometryBase::fDetHalfHeight, geo::GeometryBase::fDetHalfWidth, geo::GeometryBase::fDetLength, CLHEP::RandFlat::fire(), CLHEP::g, geo::GeometryBase::isInsideFiducialVolume(), CLHEP::kg, CLHEP::m3, geo::GeometryBase::Material(), geo::GeometryBase::ROOTGeoManager(), string, submit_syst::x, submit_syst::y, and test::z.
Referenced by calculateMassesLong().
|
inherited |
Return the unique cel id for a specified location and direction in the detector
x | - x position coordinate (cm, world coordinates) |
y | - y position coordinate (cm, world coordinates) |
z | - z position coordinate (cm, world coordinates) |
dxds | - dxds direction in which to explore a step |
dyds | - dyds direction in which to explore a step |
dzds | - dzds direction in which to explore a step |
step | - step size to take |
For the sake of efficiency, this method does no checking to ensure that the location is in fact inside a cell. The user is expected to perform that check before using the position (x,y,z).
Note further, that this uses the gGeoManager->InitTrack method and will disrupt TGeo-based tracking and should be called once any TGeo-based tracking is completed.
Definition at line 396 of file GeometryBase.cxx.
References geo::GeometryBase::CurrentCellId(), E, e, and std::max().
Referenced by fuzz::FuzzyKVertex::AddProng(), calib::MuondEdx::filter(), calib::MuonTrackHits::filter(), calib::MuondEdxAna::filter(), lem::FindCellRobust(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), trk::KalmanGeoHelper::MatchTrajectoryToPlane(), slid::Recluster::produce(), jmshower::RecoJMShower::RecoShowers(), g4n::FLSHitListAction::SteppingAction(), geo::GeometryTest::testCellId(), geo::GeometryTest::testCellIdFromPos(), and slid::NuEEnergyAlg::VertexEnergy().
|
inherited |
Given a plane and cell number, return which view the cell measures, its nominal center position, and nominal size about that center position.
ip | - plane number |
ic | - cell number |
view | - on return, the view this cell measures in |
pos | - the nominal (xyz) center position of this cell (cm) |
dpos | - half-dimensions of the cell in xyz (cm) |
geo::Exception |
Definition at line 813 of file GeometryBase.cxx.
References plot_validation_datamc::c, geo::PlaneGeo::Cell(), geo::CellGeo::GetCenter(), geo::CellGeo::HalfD(), geo::CellGeo::HalfL(), geo::CellGeo::HalfW(), geo::kX, geo::kY, geo::PlaneGeo::Ncells(), geo::GeometryBase::NPlanes(), geo::GeometryBase::Plane(), and geo::PlaneGeo::View().
Referenced by tbana::DetectorRateShutOff::analyze(), htk::HoughTrack::analyze(), comi::Leana::AnaNHit(), noe::build_cell_lookup_table(), noe::cart_to_cp(), evd::HitTower::Draw(), evd::RawDataDrawer::Draw3DHitBoxes(), skim::CosmicBeamComparison::FillNumuHistograms(), tut::TutProducer::FitPhoton(), evd::RecoBaseDrawer::GetClusterOutlines(), evd::GeometryDrawer::GetDCMBoxes(), evd::SimulationDrawer::GetLimits(), mono::MonopoleTrack::hit_is_on_track(), mono::operator<<(), earms::ElasticArmsHS::produce(), htk::Track3D::time_fit(), mono::Track3D::time_fit(), and dt::ViewMerger::ZipVerticalTracks().
|
inherited |
Return the transverse position of the cell in which ever view its in
ip | - plane number |
ic | - cell number |
w | - optional position along the local cell z-axis |
- | geo::Exception is plane, cell, or view are out of range |
Definition at line 772 of file GeometryBase.cxx.
References plot_validation_datamc::c, geo::PlaneGeo::Cell(), geo::CellGeo::GetCenter(), geo::kX, geo::kY, geo::PlaneGeo::Ncells(), geo::GeometryBase::NPlanes(), geo::GeometryBase::Plane(), elec2geo::pos, and geo::PlaneGeo::View().
Referenced by mono::operator<<(), htk::Track3D::time_fit(), and mono::Track3D::time_fit().
|
inherited |
Find the distance of closest approach between a cell and a track.
ip | - plane number |
ic | - cell number |
vtx | - track start point |
dir | - track direction |
dx | - offset within the cell (in cm, dx=0 is center of cell) |
dy | - offset within the cell (in cm, dy=0 is center of cell) |
w | - Distance from read-out end where the closest approach occurs (cm) |
s | - Distance down the track where the closest approach occurs (cm) |
point_in_cell | - Point inside the cell where the closest approach occurs |
point_on_track | - Point on track where the closest approach occurs |
Definition at line 1462 of file GeometryBase.cxx.
References getBrightness::cell, geo::PlaneGeo::Cell(), geo::ClosestApproach(), dir, dx, dy, dz, geo::CellGeo::GetCenter(), geo::CellGeo::HalfL(), geo::kX, geo::kY, PandAna.Demos.pi0_spectra::p0, geo::GeometryBase::Plane(), NDAPDHVSetting::plane, POTSpillRate::view, and geo::PlaneGeo::View().
Referenced by fuzz::ViewMatchAlg::CalcEnergyProfile(), and nerd::ViewMatchAlg::CalcEnergyProfile().
|
inherited |
Method to count the number of cells passed through by a line segment between two points in the detector.
Definition at line 1556 of file GeometryBase.cxx.
References plot_validation_datamc::c.
Referenced by calib::HitEfficiency::analyze(), bpfit::dEdxCalculator::computeDEDX(), and geo::GeometryBase::CountCellsOnLine().
|
inherited |
Method to count the number of cells passed through by a line segment between two points in the detector.
Definition at line 1572 of file GeometryBase.cxx.
References geo::GeometryBase::CountCellsOnLine().
|
inherited |
Make list of cells in each view traversed by a line segment and the entry and exit points into each cell.
Method to count the number of cells passed through by a line segment between two points in the detector and keep track of the entry and exit points of the line on the cells
Definition at line 1586 of file GeometryBase.cxx.
References getBrightness::cell, geo::CellOnLine::chan, col, geo::GeometryBase::CurrentCellId(), d, geo::CellOnLine::entry, geo::CellOnLine::exit, geo::GeometryBase::IdToCell(), geo::kX, geo::kY, geo::OfflineChan::Plane(), geo::GeometryBase::Plane(), NDAPDHVSetting::plane, elec2geo::pos, util::pythag(), POTSpillRate::view, x1, and y1.
|
inherited |
Method to count the number of cells passed through by a line segment between two points in the detector and keep track of the entry and exit points of the line on the cells
Definition at line 1661 of file GeometryBase.cxx.
References geo::GeometryBase::CountCellsOnLine().
|
inherited |
Make list of cells in each view traversed by a line segment.
Unlike CountCellsOnLine, which uses the full geometry, here we make some assumptions about cuboidal cells and the effects of alignment. For this loss in accuracy we gain a lot of speed.
Fast method to count the number of cells passed through by a line segment between two points in the detector.
Definition at line 1693 of file GeometryBase.cxx.
Referenced by chaninfo::CosmicEff::analyze(), hough::HoughValidate::analyze(), geo::LiveGeometry::CellsToEdgeInMC(), geo::GeometryBase::CountCellsOnLineFast(), dt::ViewMerger::CountUnexplainedOnLine(), chaninfo::FindSwappedChannels::filter(), geo::LiveGeometry::ProjectedCellsInMC(), geo::LiveGeometry::ProjectedCellsToEdge(), geo::LiveGeometry::ProjectedCellsToNextBadRegion(), and geo::LiveGeometry::ProjectedLiveCellsToEdge().
|
inherited |
Fast method to count the number of cells passed through by a line segment between two points in the detector.
Definition at line 1707 of file GeometryBase.cxx.
References getBrightness::cell, geo::PlaneGeo::Cell(), geo::ClampRayToDetectorVolume(), dz, geo::GeometryBase::fPlanes, geo::CellGeo::GetCenter(), geo::CellGeo::HalfD(), geo::CellGeo::HalfW(), geo::kX, geo::kY, std::max(), std::min(), geo::PlaneGeo::Ncells(), NDAPDHVSetting::plane, std::swap(), POTSpillRate::view, and geo::PlaneGeo::View().
|
inherited |
2D version
Fast method to count the number of cells passed through by a line segment between two points in the detector.
Definition at line 1674 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::CountCellsOnLineFast(), geo::kX, and geo::kY.
Return the plane and cell number for the current tracking position held by the gGeoManager
planeid | : pointer to plane number, >=0 on success, -1 on failure |
cellid | : pointer to cell number, >=0 on success, -1 on failure |
Definition at line 333 of file GeometryBase.cxx.
References geo::GeometryBase::CurrentCellId(), and geo::GeometryBase::IdToCell().
Referenced by geo::GeometryTest::testFindCell().
|
inherited |
Return the unique cell id for the current cell – zero if not in any cell
Definition at line 348 of file GeometryBase.cxx.
References allTimeWatchdog::endl, MECModelEnuComparisons::i, LOG_DEBUG, geo::NodesToUniqueId(), ns, path, and string.
Referenced by geo::GeometryBase::CellId(), geo::GeometryBase::CountCellsOnLine(), and geo::GeometryBase::CurrentCell().
|
inherited |
Compute the distance from a point to the detector wall along a particular direction.
x0 | - Input, [x,y,z] start point (cm) |
dx | - Input, direction vector |
exitp | - Ouput, Calculated [x,y,z] of exit point (cm) |
Definition at line 1427 of file GeometryBase.cxx.
References geo::GeometryBase::fDetHalfHeight, geo::GeometryBase::fDetHalfWidth, geo::GeometryBase::fDetLength, geo::ProjectToBoxEdge(), and util::pythag().
Referenced by bpfit::Path::FindLayers(), comi::Cana::produce(), and crvtx::CosmicRayVertex::produce().
|
inherited |
Return the ranges of x,y and z for the "Detector volume" that the entire geometry lives in. If any pointers are 0, then those coordinates are ignored.
xlo | : On return, lower bound on x positions |
xhi | : On return, upper bound on x positions |
ylo | : On return, lower bound on y positions |
yhi | : On return, upper bound on y positions |
zlo | : On return, lower bound on z positions |
zhi | : On return, upper bound on z positions |
Definition at line 658 of file GeometryBase.cxx.
References geo::GeometryBase::fDetectorBigBoxXHi, geo::GeometryBase::fDetectorBigBoxXLo, geo::GeometryBase::fDetectorBigBoxYHi, geo::GeometryBase::fDetectorBigBoxYLo, geo::GeometryBase::fDetectorBigBoxZHi, and geo::GeometryBase::fDetectorBigBoxZLo.
Referenced by evgen::CosmicsGen::DetectorBigBoxCut(), evgen::CORSIKAGen::DetectorBigBoxCut(), evgen::CORSIKAGen::populateNShowers(), and evgen::CosmicsGen::ProjectMuonsToDetectorBigBox().
|
inherited |
Return the ranges of x,y and z for the "Detector volume" that the entire geometry lives in. If any pointers are 0, then those coordinates are ignored.
xlo | : On return, lower bound on x positions |
xhi | : On return, upper bound on x positions |
ylo | : On return, lower bound on y positions |
yhi | : On return, upper bound on y positions |
zlo | : On return, lower bound on z positions |
zhi | : On return, upper bound on z positions |
Definition at line 627 of file GeometryBase.cxx.
References ana::assert(), x1, submit_syst::x2, y1, and submit_syst::y2.
Referenced by g4n::FLSHitListAction::ParticleProjection(), and geo::GeometryBase::setDetectorBigBox().
|
inherited |
Definition at line 474 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fDetHalfHeight, geo::GeometryBase::fDetId, and novadaq::cnv::kUNKNOWN_DET.
Referenced by caf::AddCosmicTruthToVec(), caf::CAFMaker::AddMCTruthToVec(), fuzz::FuzzyKVertex::AddProng(), geo::GeometryTest::analyze(), calib::HitEfficiency::analyze(), mcchk::LeptonAna::analyze(), earms::ElasticArmsValidate::analyze(), mcchk::DetSimAna::analyze(), air::AirKalmanAna::analyze(), slid::LIDTraining::analyze(), trk::CosmicTrackAna::analyze(), mcchk::NeutrinoAna::AnalyzeNeutrinoInteraction(), calib::CosmicCalib::beginRun(), mcchk::CosmicAna::beginRun(), mcchk::NeutrinoAna::beginRun(), calib::MakeAttenuationProfiles::beginRun(), numue::NumuEAna::beginRun(), mcchk::LeptonAna::beginRun(), calib::AttenFit::beginRun(), calib::StopperThreshold::beginRun(), calib::AttenuationFit::beginRun(), trk::KalmanTrackMerge::CanJoinTracks(), geo::ClampRayToDetectorVolume(), bpfit::BreakPoint::ClampToDetector(), trk::KalmanTrackAna::Containment(), trk::KalmanGeoHelper::CountMissedCellsOnLine(), evd::Display3DPad::Draw(), evd::HitTower::Draw(), evd::RawDataDrawer::Draw3DHitBoxes(), evd::RecoBaseDrawer::DrawHoughResults2D(), calib::AttenFit::expFit(), calib::AttenuationFit::expFit(), calib::StopperThreshold::FillHist(), calib::CosmicTrends::FillHistograms(), calib::StopperThreshold::FillTree(), filter::Filter::FillTruthVariables(), trk::KalmanTrack::FilterTracker(), vdt::VertexDT::FindMinMax(), calib::AttenFit::fit_channel_prof(), calib::AttenuationFit::fit_channel_prof(), evgen::GENIENeutronOscGen::GENIENeutronOscGen(), evd::SliceNavigator::GetBounds(), evd::SliceNavigator::GetBox(), nuesand::FillNueSandbox::GetECF(), jmshower::RecoJMShower::GetInterCellTransDedxProb(), jmshower::RecoJMShower::GetInterPlaneDedxProb(), hough::HoughValidate::HoughLineToDetector(), bsf::BremShowerFilter::inFiducial(), dif::DiFShowerFinder::inFiducial(), g4n::NeutronSubstitutionProcess::InsideDetector(), calib::RockMuonStopperSelection::IsContainedStopper(), comi::CosmicMetrics::IsEntering(), align::AlignInspect::IsGoodTrack(), align::Alignment::IsGoodTrack(), comi::Leana::IsPointOnEdge(), calib::RockMuonStopperSelection::IsTrulyContainedStopper(), calib::RockMuonStopperSelection::IsTrulyInFiducial(), calib::ThroughgoingSelection::IsTrulyUncontained(), calib::ThroughgoingSelection::IsUncontained(), evd::TZProjPad::LayoutHisto(), calib::AttenFit::lowessFit(), calib::AttenuationFit::lowessFit(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), trk::KalmanGeoHelper::MatchTrajectoryToPlane(), numue::NumuEAlg::NumuEAlg(), cheat::TrackCheater::produce(), jmshower::JMTrackMerge::produce(), calib::FiberCalibration::produce(), earms::ElasticArmsHS::produce(), comi::Cana::produce(), evgen::GENIERockGen::produce(), crvtx::CosmicRayVertex::produce(), cheat::MCCheater::produce(), remid::RecoMuon::produce(), evd::RawDataDrawer::RawDigit3D(), trk::RLFit::RLFit(), calib::AttenFit::rolloffFit(), calib::AttenuationFit::rolloffFit(), evd::TZProjPad::ShowFull(), evd::TZProjPad::ShowPartial(), numue::NumuEAna::TotalLengthInDetector(), cheat::RecoCheckAna::TotalLengthInDetector(), and trk::KalmanTrackAna::TotalLengthInDetector().
|
inherited |
Definition at line 467 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fDetHalfWidth, geo::GeometryBase::fDetId, and novadaq::cnv::kUNKNOWN_DET.
Referenced by caf::AddCosmicTruthToVec(), caf::CAFMaker::AddMCTruthToVec(), fuzz::FuzzyKVertex::AddProng(), geo::GeometryTest::analyze(), calib::HitEfficiency::analyze(), mcchk::LeptonAna::analyze(), earms::ElasticArmsValidate::analyze(), mcchk::DetSimAna::analyze(), air::AirKalmanAna::analyze(), slid::LIDTraining::analyze(), trk::CosmicTrackAna::analyze(), mcchk::NeutrinoAna::AnalyzeNeutrinoInteraction(), calib::CosmicCalib::beginRun(), mcchk::CosmicAna::beginRun(), mcchk::NeutrinoAna::beginRun(), numue::NumuEAna::beginRun(), calib::MakeAttenuationProfiles::beginRun(), mcchk::LeptonAna::beginRun(), calib::AttenFit::beginRun(), calib::StopperThreshold::beginRun(), calib::AttenuationFit::beginRun(), trk::KalmanTrackMerge::CanJoinTracks(), geo::ClampRayToDetectorVolume(), bpfit::BreakPoint::ClampToDetector(), trk::KalmanTrackAna::Containment(), trk::KalmanGeoHelper::CountMissedCellsOnLine(), evd::Display3DPad::Draw(), evd::HitTower::Draw(), evd::RawDataDrawer::Draw3DHitBoxes(), evd::RecoBaseDrawer::DrawHoughResults2D(), calib::SystematicUncertaintyScaleAna::endJob(), calib::AttenFit::expFit(), calib::AttenuationFit::expFit(), calib::StopperThreshold::FillHist(), calib::CosmicTrends::FillHistograms(), calib::StopperThreshold::FillTree(), filter::Filter::FillTruthVariables(), trk::KalmanTrack::FilterTracker(), vdt::VertexDT::FindMinMax(), calib::AttenFit::fit_channel_prof(), calib::AttenuationFit::fit_channel_prof(), evgen::GENIENeutronOscGen::GENIENeutronOscGen(), evd::SliceNavigator::GetBounds(), evd::SliceNavigator::GetBox(), nuesand::FillNueSandbox::GetECF(), airshower::AirSlicer::GetHoughAngles(), airshower::AirSlicer::GetHoughMap(), airshower::AirSlicer::GetHoughRhos(), jmshower::RecoJMShower::GetInterCellTransDedxProb(), jmshower::RecoJMShower::GetInterPlaneDedxProb(), hough::HoughValidate::HoughLineToDetector(), bsf::BremShowerFilter::inFiducial(), dif::DiFShowerFinder::inFiducial(), g4n::NeutronSubstitutionProcess::InsideDetector(), calib::RockMuonStopperSelection::IsContainedStopper(), comi::CosmicMetrics::IsEntering(), align::AlignInspect::IsGoodTrack(), align::Alignment::IsGoodTrack(), comi::Leana::IsPointOnEdge(), calib::RockMuonStopperSelection::IsTrulyContainedStopper(), calib::RockMuonStopperSelection::IsTrulyInFiducial(), calib::ThroughgoingSelection::IsTrulyUncontained(), calib::ThroughgoingSelection::IsUncontained(), evd::TZProjPad::LayoutHisto(), calib::AttenFit::lowessFit(), calib::AttenuationFit::lowessFit(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), trk::KalmanGeoHelper::MatchTrajectoryToPlane(), numue::NumuEAlg::NumuEAlg(), cheat::TrackCheater::produce(), jmshower::JMTrackMerge::produce(), calib::FiberCalibration::produce(), earms::ElasticArmsHS::produce(), comi::Cana::produce(), evgen::GENIERockGen::produce(), crvtx::CosmicRayVertex::produce(), cheat::MCCheater::produce(), remid::RecoMuon::produce(), evd::RawDataDrawer::RawDigit3D(), trk::RLFit::RLFit(), calib::AttenFit::rolloffFit(), calib::AttenuationFit::rolloffFit(), evd::TZProjPad::ShowFull(), evd::TZProjPad::ShowPartial(), numue::NumuEAna::TotalLengthInDetector(), cheat::RecoCheckAna::TotalLengthInDetector(), and trk::KalmanTrackAna::TotalLengthInDetector().
|
inlineinherited |
Prefer ds::DetectorService::DetId() instead.
Definition at line 243 of file GeometryBase.h.
Referenced by calib::ADCShapeFitAna::analyze(), geo::GeometryTest::analyze(), align::SplitTracks::analyze(), comi::DataCheck::analyze(), bpfit::BPFTmvaTrainer::analyze(), LightLevels::analyze(), CerenkovResponse::analyze(), util::StoreGDML::beginRun(), calib::ThresholdAna::beginRun(), slicer::Slicer4D::beginRun(), presel::RockPresel::beginRun(), presel::CosmicVeto::beginRun(), wsnumu::WSNumu::beginRun(), presel::CosmicCVNVeto::beginRun(), presel::NuePresel::beginRun(), mcchk::CloseInTime::beginRun(), dprf::ChannelPlots::beginRun(), comi::NumiFiltering::beginRun(), mcchk::DetAna::beginRun(), calib::CosmicCalib::beginRun(), dprf::TrackPlots::beginRun(), calib::FiberCalibration::beginRun(), evgen::CosmicsGen::beginRun(), evgen::CosmicPionGen::beginRun(), numue::NumuEAna::beginRun(), calib::MakeAttenuationProfiles::beginRun(), evgen::IsoGen::beginRun(), supernova::SnovaGen::beginRun(), comi::NumiFilteringAna::beginRun(), evgen::GENIERockGen::beginRun(), evgen::SupernovaGen::beginRun(), calib::TimingCalibration::beginRun(), evgen::SingleGen::beginRun(), remid::ReMIdDedx::beginRun(), chaninfo::BadChanValidate::beginRun(), dif::DiFShowerFinder::beginRun(), calib::DriftResponseCalc::beginRun(), calib::PEResponse::beginRun(), evgen::CORSIKAGen::beginRun(), evgen::GENIEGen::beginRun(), calib::AttenFit::beginRun(), jmshower::NueSel::beginRun(), jmshower::NueSelLID::beginRun(), slid::SPIDBuilder::beginRun(), comi::NearlineAna::beginRun(), remid::ReMIdDedxRock::beginRun(), murem::MuonRemove::beginRun(), photrans::ImprovedTransport::beginRun(), remid::ReMIdDedxFD::beginRun(), remid::ReMIdDedxStudies::beginRun(), calib::AttenuationFit::beginRun(), calib::DCMTimingOffset::beginRun(), rsim::ReadoutSim::beginRun(), evgen::GENIENeutronOscGen::beginRun(), slid::LIDTraining::beginRun(), jmshower::RecoJMShower::beginRun(), slicemergeviews::SliceMergeViews::beginRun(), evgen::TextFileGen::beginRun(), tdslicer::TDSlicer::beginRun(), caf::CAFMaker::beginRun(), DataCheck::HardwareStatusCheck::beginSubRun(), comi::DataCheck::beginSubRun(), slicer::Slicer::BlockSlice(), slid::NuEEnergyAlg::CellADCToGeV(), slid::NuEEnergyAlg::CellEDataMC(), slid::NuEEnergyAlg::CellEnergy(), geo::LiveGeometry::CellsToEdgeInMC(), calib::AttenFit::ConsolidateViews(), calib::AttenuationFit::ConsolidateViews(), remid::ReMIdTrain::ContainedEvent(), chaninfo::BadChanList::CountDCMHits(), rsim::ReadoutSim::CreateRawDigits(), evgen::CosmicsGen::DetectorBigBoxCut(), evgen::CORSIKAGen::DetectorBigBoxCut(), geo::LiveGeometry::DistanceToEdgeInMC(), geo::LiveGeometry::DistToClosestBadRegion(), geo::LiveGeometry::DoWeEnterMC(), evd::HardwarePad::Draw(), evd::GeometryDrawer::DrawCells2D(), calib::SystematicUncertaintyScaleAna::endJob(), comi::CosmicMetrics::endJob(), comi::DataCheck::endJob(), calib::AttenFit::endJob(), calib::DCMTimingOffset::endJob(), calib::Calibrator::EnsureTimingCacheVldTime(), calib::AttenFit::expFit(), calib::AttenuationFit::expFit(), geo::LiveGeometry::FillBadBoxes(), dqsf::DQSpillFlags::FillCountVars(), meta::Metadata::FillMetadata(), calib::CosmicCalib::FillPathLengthInfo(), calib::MakeAttenuationProfiles::FillPathLengthInfo(), util::RemoveBeamSpills::filter(), util::RemoveBeamSpillsPrecise::filter(), comi::NumiFiltering::filter(), calib::MuondEdx::filter(), calib::MuonTrackHits::filter(), calib::MuondEdxAna::filter(), calib::AttenFit::fit_channel_prof(), calib::AttenuationFit::fit_channel_prof(), geo::LiveGeometry::FullNDProjectedCells(), calib::Calibrator::GetAdcPerPE(), calib::Calibrator::GetAttenCurve(), calib::Calibrator::GetAttenScale(), geo::LiveGeometry::GetBCInfo(), LSTME::SliceVars::getCoarseTiming(), evd::GeometryDrawer::GetDCMBoxes(), geo::LiveGeometry::GetDetectorEdges(), skim::ParametersNumu::GetDetectorEdges(), LSTME::SliceVars::getLowGain(), numusand::NumuSandFxs::getMissingE(), calib::Calibrator::GetPECorrToGeVScale(), geo::GeometryBase::GetPigtail(), photrans::ImprovedTransport::GetPosCorr(), geo::LiveGeometry::GetRHInfo(), calib::Calibrator::GetTimeRes(), calib::Calibrator::GetTimingOffset(), calib::Calibrator::GetTNS(), calib::ThresholdAna::GetView(), calib::CosmicCalib::GetView(), calib::MakeAttenuationProfiles::GetView(), calib::AttenFit::GetView(), calib::AttenuationFit::GetView(), calib::AttenCache::GetView(), chaninfo::BadChanList::InDroppedDCM(), mcdatadaq::Configuration::init(), qeef::QeFinder::Init(), remid::RecoMuon::Init(), slid::SPIDAlg::Initialize(), slid::LIDAlg::Initialize(), geo::LiveGeometry::InMuonCatcher(), geo::LiveGeometry::InstrumentedDetBack(), geo::LiveGeometry::InstrumentedDetEnds(), geo::LiveGeometry::InstrumentedDetFront(), geo::LiveGeometry::InstrumentedDetLength(), chaninfo::BadChanList::IsBadUncached(), calib::RockMuonStopperSelection::IsContainedStopper(), calib::StopperSelection::IsContainedStopper(), remid::RecoMuon::IsTrackContained(), filter::Filter::isVertexInFiducial(), evd::TZProjPad::LayoutHisto(), calib::AttenCache::LoadFromDatabase(), calib::AttenCache::LoadFromDatabaseUncalibratedMask(), chaninfo::BadChanList::LoadNewData(), calib::AttenFit::lowessFit(), calib::AttenuationFit::lowessFit(), calib::Calibrator::MakeCellHit(), evtsum::EventSummary::MakeOutput(), chaninfo::BadChanList::NBadInSubRun(), slicer::Slicer::NeighborSlice(), numue::NumuEAlg::NumuEAlg(), trk::CosmicTrackUtilities::PointInDetector(), calib::Calibrator::postBeginRun(), preBeginRun(), SliceLID::FillSliceLID::predict(), LSTME::FillLSTME::predictEnergy(), wsnumu::WSNumu::produce(), calib::ResizeDetector::produce(), calib::FiberCalibration::produce(), cosrej::CosRej::produce(), numue::NumuEnergy::produce(), calib::TimingCalibration::produce(), calib::DriftResponseCalc::produce(), rwgt::MakeGENIEReweightTable::produce(), slid::LIDBuilder::produce(), dqsf::DQSpillFlags::produce(), bpfit::BPFEnergyEstimator::produce(), remid::RecoMuon::produce(), bpfit::BPFPIdMaker::produce(), g4rwgt::MakeG4WeightTable::produce(), rsim::ReadoutSim::produce(), evgen::CosmicsGen::ProjectCosmicsToSurface(), geo::LiveGeometry::ProjectedAirDist(), geo::LiveGeometry::ProjectedCellsInMC(), geo::LiveGeometry::ProjectedDistanceInMC(), geo::LiveGeometry::ProjectedSteelDist(), evgen::CosmicsGen::ProjectMuonsToDetectorBigBox(), evgen::CosmicsGen::ProjectToSurface(), evd::RawDataDrawer::RawDigitHardware(), lem::GenFromLib::readNext(), cheat::BackTracker::Rebuild(), calib::AttenCache::RepresentativePlane(), calib::AttenFit::rolloffFit(), calib::AttenuationFit::rolloffFit(), LSTME::FillLSTME::selectModel(), geo::LiveGeometry::SetInstrumentation(), trk::KalmanGeoHelper::SetupHelper(), geo::LiveGeometry::SetupLiveGeo(), photrans::ImprovedTransport::StepAlongHit(), calib::Calibrator::SystematicUncertaintyScale(), calib::AttenCache::TranslateChannelData(), calib::AttenCache::TranslateChannelMC(), evd::TZProjPad::TZProjPad(), slid::NuEEnergyAlg::VertexEnergy(), rb::Cluster::W(), rb::Prong::W(), rb::Track::W(), calib::AttenuationFit::WriteDummyCSVRow(), calib::AttenuationFit::writeResults(), geo::LiveGeometry::XPositionAtTransition(), and geo::LiveGeometry::YPositionAtTransition().
|
inherited |
Definition at line 481 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fDetId, geo::GeometryBase::fDetLength, and novadaq::cnv::kUNKNOWN_DET.
Referenced by caf::AddCosmicTruthToVec(), caf::CAFMaker::AddMCTruthToVec(), fuzz::FuzzyKVertex::AddProng(), mcchk::CosmicAna::analyze(), mcchk::LeptonAna::analyze(), earms::ElasticArmsValidate::analyze(), mcchk::DetSimAna::analyze(), air::AirKalmanAna::analyze(), slid::LIDTraining::analyze(), trk::CosmicTrackAna::analyze(), mcchk::NeutrinoAna::AnalyzeNeutrinoInteraction(), mcchk::CosmicAna::beginRun(), mcchk::NeutrinoAna::beginRun(), numue::NumuEAna::beginRun(), mcchk::LeptonAna::beginRun(), geo::ClampRayToDetectorVolume(), bpfit::BreakPoint::ClampToDetector(), trk::KalmanTrackAna::Containment(), trk::KalmanGeoHelper::CountMissedCellsOnLine(), evd::Display3DPad::Draw(), evd::RecoBaseDrawer::DrawHoughResults2D(), calib::CosmicTrends::FillHistograms(), filter::Filter::FillTruthVariables(), trk::KalmanTrack::FilterTracker(), vdt::VertexDT::FindMinMax(), evgen::GENIENeutronOscGen::GENIENeutronOscGen(), evd::SliceNavigator::GetBounds(), evd::SliceNavigator::GetBox(), nuesand::FillNueSandbox::GetECF(), airshower::AirSlicer::GetHoughMap(), airshower::AirSlicer::GetHoughRhos(), hough::HoughValidate::HoughLineToDetector(), g4n::NeutronSubstitutionProcess::InsideDetector(), calib::RockMuonStopperSelection::IsContainedStopper(), comi::CosmicMetrics::IsEntering(), align::AlignInspect::IsGoodTrack(), align::Alignment::IsGoodTrack(), calib::RockMuonStopperSelection::IsTrulyContainedStopper(), calib::ThroughgoingSelection::IsTrulyUncontained(), calib::ThroughgoingSelection::IsUncontained(), evd::TZProjPad::LayoutHisto(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), numue::NumuEAlg::NumuEAlg(), cheat::TrackCheater::produce(), evgen::CosmicsGen::produce(), earms::ElasticArmsHS::produce(), evgen::CosmicPionGen::produce(), comi::Cana::produce(), evgen::GENIERockGen::produce(), vdt::VertexDT::produce(), crvtx::CosmicRayVertex::produce(), cheat::MCCheater::produce(), remid::RecoMuon::produce(), geo::LiveGeometry::ProjectedWall(), trk::RLFit::RLFit(), evd::TZProjPad::ShowFull(), evd::TZProjPad::ShowPartial(), numue::NumuEAna::TotalLengthInDetector(), cheat::RecoCheckAna::TotalLengthInDetector(), trk::KalmanTrackAna::TotalLengthInDetector(), and dt::Chain::ToTrack().
|
inherited |
get distance from local z position in cell to apd in cm, including pigtail
Return distance from a point in the cell to readout electronics, including pigtail
localz | : Z position in cm in local cell frame |
Definition at line 1771 of file GeometryBase.cxx.
References geo::GeometryBase::GetPigtail(), geo::CellGeo::HalfL(), and geo::CellGeo::Id().
Referenced by calib::HitEfficiency::analyze(), jmshower::RecoJMShower::GetTrkHitPos(), calib::GetXYZD(), and slid::NuEEnergyAlg::VertexEnergy().
|
inherited |
Extract contents from fGDMLFile and return as a string.
Definition at line 180 of file GeometryBase.cxx.
References geo::GeometryBase::fGDMLFile.
Referenced by util::StoreGDML::beginRun(), evgen::CosmicsGen::beginRun(), evgen::CosmicPionGen::beginRun(), evgen::IsoGen::beginRun(), supernova::SnovaGen::beginRun(), evgen::SupernovaGen::beginRun(), evgen::SingleGen::beginRun(), evgen::CORSIKAGen::beginRun(), evgen::GENIEGen::beginRun(), evgen::GENIENeutronOscGen::beginRun(), daq2raw::NOvARawInputDriver::readNext(), and daq2raw::TestBeamRawInputDriver::readNext().
|
staticinherited |
Extract contents from fname and return as a string.
fullpath | If false, search for the file in FW_SEARCH_PATH |
Definition at line 186 of file GeometryBase.cxx.
References geo::GeometryBase::FindGDMLFile(), make_syst_table_plots::line, and string.
|
inherited |
|
inherited |
Method to extract gdml file basename and store as an std::string
Definition at line 307 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fGDMLFile, and string.
Referenced by geo::GeometryTest::analyze(), util::StoreGDML::beginRun(), evgen::CosmicsGen::beginRun(), evgen::CosmicPionGen::beginRun(), supernova::SnovaGen::beginRun(), evgen::IsoGen::beginRun(), evgen::SupernovaGen::beginRun(), evgen::GENIERockGen::beginRun(), evgen::SingleGen::beginRun(), evgen::CORSIKAGen::beginRun(), evgen::GENIEGen::beginRun(), evgen::GENIENeutronOscGen::beginRun(), evgen::TextFileGen::beginRun(), and lem::GenFromLib::readNext().
|
staticprotectedinherited |
Search for Geometry/gdml/fname in FW_SEARCH_PATH, return full path.
Definition at line 208 of file GeometryBase.cxx.
References cet::search_path::find_file(), runNovaSAM::ret, and string.
Referenced by geo::GeometryBase::ExtractGDML(), and preBeginRun().
|
protectedinherited |
Recursively search for planes in the geometry
n | - Array holding the path of nodes traversed |
depth | - Depth of the search to this point |
inMuonCatcher | - internal flag, recursed into the muon catcher? |
geo::Exception | is maximum depth is exceeded. |
Definition at line 703 of file GeometryBase.cxx.
References MECModelEnuComparisons::i, geo::GeometryBase::MakePlane(), nd, Munits::nm, and registry_explorer::v.
Referenced by geo::GeometryBase::LoadGeometryFile().
|
inherited |
Returns the index of the first plane contained in the muon catcher.
Or kPLANE_NOT_FOUND if there is no muon catcher
Definition at line 979 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fPlanes, geo::GeometryBase::fPlanesInMuonCatcher, it, and geo::kPLANE_NOT_FOUND.
Referenced by LightLevels::analyze(), CerenkovResponse::analyze(), calib::SystematicUncertaintyScaleAna::endJob(), calib::AttenuationFit::expFit(), dqsf::DQSpillFlags::FillCountVars(), calib::MuondEdx::filter(), calib::MuonTrackHits::filter(), calib::MuondEdxAna::filter(), calib::AttenuationFit::fit_channel_prof(), calib::Calibrator::GetAttenCurve(), calib::ThresholdAna::GetView(), calib::CosmicCalib::GetView(), calib::MakeAttenuationProfiles::GetView(), calib::AttenFit::GetView(), calib::AttenuationFit::GetView(), calib::AttenCache::GetView(), remid::RecoMuon::IsTrackContained(), calib::AttenCache::LoadFromDatabase(), calib::AttenuationFit::lowessFit(), numue::NumuEAlg::NumuEAlg(), calib::AttenCache::RepresentativePlane(), calib::AttenuationFit::rolloffFit(), photrans::ImprovedTransport::StepAlongHit(), calib::Calibrator::SystematicUncertaintyScale(), calib::AttenCache::TranslateChannelMC(), calib::AttenuationFit::WriteDummyCSVRow(), and calib::AttenuationFit::writeResults().
|
inlineinherited |
Definition at line 235 of file GeometryBase.h.
Referenced by geo::GeometryTest::analyze(), g4n::G4Alg::G4Alg(), and rawp::CheckDAQChannelMap::Reco().
|
inlineinherited |
Definition at line 237 of file GeometryBase.h.
References string.
|
inherited |
Definition at line 888 of file GeometryBase.cxx.
References geo::OfflineChan::Cell(), and geo::GeometryBase::getPlaneCellMap().
|
inlineinherited |
Definition at line 107 of file GeometryBase.h.
References geo::GeometryBase::getCellID().
Referenced by geo::GeometryBase::getCellID().
|
inlineinherited |
Definition at line 245 of file GeometryBase.h.
References plot_validation_datamc::fname, submit_nova_art::fullpath, and string.
Referenced by mcchk::NeutrinoAna::AnalyzeNeutrinoInteraction(), and getDirectionInBeamCoordinates().
TVector3 geo::Geometry::getDirectionInBeamCoordinates | ( | TVector3 const & | startPos, |
TVector3 const & | dir | ||
) | const |
Get direction of the Prong in the beam coordinates.
x0 in Detector coordinates. All dimensions are in cm
Small displacement in the Prong's direction
x1 in Detector coordinates. All dimensions are in cm
x0, x1 in Detector coordinates. All dimensions are CLHEP
x0 and x1 in beam coordinates
Calculate beam coordinates for x0 and x1
Transform into a vector class
Direction in beam coordinates. Not normalized
return Unit vector
Definition at line 152 of file Geometry_service.cc.
References CLHEP::cm, geo::GeometryBase::getCoordinateTransformation(), and geo::CoordinateTransformation::transformDetectorToBeamCoordinates().
|
inherited |
Return length of fiber in cm from end of cell to apd.
Definition at line 1777 of file GeometryBase.cxx.
References geo::GeometryBase::DetId(), geo::GeometryBase::IdToCell(), geo::GeometryBase::IdToPlane(), novadaq::cnv::kTESTBEAM, geo::kY, and POTSpillRate::view.
Referenced by geo::GeometryBase::DistToElectronics(), photrans::PhotonTransport::produce(), jmshower::RecoJMShower::RecoShowers(), and photrans::ImprovedTransport::StepAlongHit().
|
inherited |
Definition at line 892 of file GeometryBase.cxx.
References geo::OfflineChan::Cell(), geo::GeometryBase::getPlaneCellMap(), makeTrainCVSamples::int, and geo::OfflineChan::Plane().
|
inlineinherited |
Definition at line 108 of file GeometryBase.h.
References geo::GeometryBase::getPlaneAndCellID(), ana::NuMIBeamDirection(), POTSpillRate::view, x1, X1, submit_syst::x2, X2, y1, Y1, submit_syst::y2, Y2, Z1, and Z2.
Referenced by geo::GeometryBase::getPlaneAndCellID().
|
protectedinherited |
Definition at line 899 of file GeometryBase.cxx.
References geo::GeometryBase::fIdMap.
Referenced by geo::GeometryBase::getCellID(), geo::GeometryBase::getPlaneAndCellID(), geo::GeometryBase::getPlaneID(), geo::GeometryBase::IdToCell(), and geo::GeometryBase::IdToPlane().
|
inherited |
Same as IdToCell and IdToPlane, but doesn't calculate CellGeo (PlaneGeo), just the global plane number or cell number
Definition at line 884 of file GeometryBase.cxx.
References geo::GeometryBase::getPlaneCellMap(), and geo::OfflineChan::Plane().
Referenced by fuzz::FuzzyKVertex::AddProng(), calib::MuondEdx::filter(), calib::MuonTrackHits::filter(), calib::MuondEdxAna::filter(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), slid::Recluster::produce(), jmshower::RecoJMShower::RecoShowers(), and slid::NuEEnergyAlg::VertexEnergy().
|
inlineinherited |
Definition at line 106 of file GeometryBase.h.
References geo::GeometryBase::getPlaneID().
Referenced by geo::GeometryBase::getPlaneID().
|
inherited |
Return list of planes which measure the requested projection
v | : X/Y or All (see View_t typedef in PlaneGeo.h) |
geo::Exception if initialization fails |
Definition at line 918 of file GeometryBase.cxx.
References geo::GeometryBase::fAllPlanes, geo::GeometryBase::fXplanes, geo::GeometryBase::fYplanes, geo::kX, and geo::kY.
Referenced by mcchk::CosmicAna::analyze(), htk::HoughTrack::analyze(), dprf::ChannelPlots::beginRun(), dprf::TrackPlots::beginRun(), mcchk::DetAna::beginRun(), calib::DriftResponseCalc::beginRun(), calib::CosmicTrends::beginRun(), calib::DriftResponseCalc::endRun(), rsim::RecordNoiseSpectrumFile::endSubRun(), LightLevels::endSubRun(), calib::AttenCache::RepresentativePlane(), chaninfo::BadChanList::SetRandomBadChannels(), geo::GeometryTest::testFindPlanes(), and dt::View::View().
|
inherited |
Given a unique cell identifier, look up the plane and cell numbers.
id | : Cell identifier |
iplane | : pointer to return plane number |
icell | : pointer to return cell number |
geo::Exception | if id is not found |
Definition at line 859 of file GeometryBase.cxx.
References geo::OfflineChan::Cell(), geo::PlaneGeo::Cell(), geo::GeometryBase::getPlaneCellMap(), makeTrainCVSamples::int, geo::OfflineChan::Plane(), and geo::GeometryBase::Plane().
Referenced by geo::GeometryBase::CountCellsOnLine(), geo::GeometryBase::CurrentCell(), geo::GeometryBase::GetPigtail(), photrans::ImprovedTransport::GetPosCorr(), g4n::FLSHitListAction::SteppingAction(), geo::GeometryTest::testUniqueId(), and lem::VertexToPlaneAndCell().
|
inherited |
Given a unique cell identifier, look up the plane number.
id | : Cell identifier |
iplane | : optional, pointer to return plane number |
geo::Exception | if id is not found |
Definition at line 879 of file GeometryBase.cxx.
References geo::GeometryBase::getPlaneCellMap(), geo::OfflineChan::Plane(), and geo::GeometryBase::Plane().
Referenced by geo::GeometryBase::GetPigtail(), and trk::KalmanGeoHelper::MatchTrajectoryToPlane().
|
inherited |
Definition at line 682 of file GeometryBase.cxx.
References geo::GeometryBase::fDetectorBigBoxXHi, geo::GeometryBase::fDetectorBigBoxXLo, geo::GeometryBase::fDetectorBigBoxYHi, geo::GeometryBase::fDetectorBigBoxYLo, geo::GeometryBase::fDetectorBigBoxZHi, geo::GeometryBase::fDetectorBigBoxZLo, and geo::IntersectsBox().
|
inherited |
Definition at line 674 of file GeometryBase.cxx.
References geo::GeometryBase::fDetHalfHeight, geo::GeometryBase::fDetHalfWidth, geo::GeometryBase::fDetLength, and geo::IntersectsBox().
Referenced by crvtx::CosmicRayVertex::produce().
|
inherited |
Is the material m an active or passive material?
Definition at line 453 of file GeometryBase.cxx.
References string.
Referenced by bpfit::Path::FindLayers().
|
inlineinherited |
Do we use the Detector Big Box.
Definition at line 190 of file GeometryBase.h.
References geo::ClosestApproach(), dir, dx, dy, CLHEP::m, plot_validation_datamc::p1, plot_validation_datamc::p2, fillBadChanDBTables::step, w, submit_syst::x, submit_syst::y, and test::z.
Referenced by g4n::FLSHitListAction::SteppingAction().
|
inherited |
Is the particle inside the detector Big Box?
Definition at line 1371 of file GeometryBase.cxx.
References geo::GeometryBase::fDetectorBigBoxXLo, geo::GeometryBase::fDetectorBigBoxYLo, and geo::GeometryBase::fDetectorBigBoxZLo.
Referenced by nuesand::FillNueSandbox::FillTruthVars(), cheat::BackTracker::InterceptsDetector(), g4n::ParticleListAction::PostTrackingAction(), rwgt::MakeGENIEReweightTable::produce(), RockFilter_A(), RockFilter_B(), RockFilter_C(), RockFilter_D(), g4n::ParticleListAction::SteppingAction(), and g4n::FLSHitListAction::SteppingAction().
|
inherited |
Is the particle inside the detector Fiducial Volume?
Is the particle inside the fiducial volume?
x_cm | : x coordinate in cm |
y_cm | : y coordinate in cm |
z_cm | : z coordinate in cm |
Definition at line 1389 of file GeometryBase.cxx.
References geo::GeometryBase::fFiducialVolumeXLo, geo::GeometryBase::fFiducialVolumeYLo, and geo::GeometryBase::fFiducialVolumeZLo.
Referenced by geo::GeometryBase::calculateMassesLong(), filter::Filter::FillTruthVariables(), bsf::BremShowerFilter::findShowerByTruth(), geo::GeometryBase::isInsideFiducialVolume(), nuesand::FillNueSandbox::produce(), presel::NuePresel::produce(), and lem::Preselection::produce().
|
inherited |
Is the particle inside the fiducial volume?
xyz | : pointer to array holding xyz in world coordinates |
Definition at line 1402 of file GeometryBase.cxx.
References CLHEP::cm, and geo::GeometryBase::isInsideFiducialVolume().
|
protectedinherited |
In case of unknown ID, guesses from the filename.
Method to load detector geometry file
Definition at line 229 of file GeometryBase.cxx.
References geo::GeometryBase::BuildMaps(), geo::CellGeo::clear(), geo::GeometryBase::fBigBoxRange, geo::GeometryBase::fDetectorBigBoxXHi, geo::GeometryBase::fDetectorBigBoxXLo, geo::GeometryBase::fDetectorBigBoxYHi, geo::GeometryBase::fDetectorBigBoxYLo, geo::GeometryBase::fDetectorBigBoxZHi, geo::GeometryBase::fDetectorBigBoxZLo, geo::GeometryBase::fDetHalfHeight, geo::GeometryBase::fDetHalfWidth, geo::GeometryBase::fDetLength, geo::GeometryBase::fIdMap, geo::GeometryBase::FindPlanes(), geo::GeometryBase::fIsDetectorBigBoxUsed, geo::GeometryBase::fPlanes, geo::GeometryBase::fPlanesInMuonCatcher, MECModelEnuComparisons::i, novadaq::cnv::kFARDET, novadaq::cnv::kNDOS, novadaq::cnv::kNEARDET, novadaq::cnv::kTESTBEAM, novadaq::cnv::kUNKNOWN_DET, getGoodRuns4SAM::n, geo::plane_sort(), geo::GeometryBase::setDetectorBigBox(), geo::GeometryBase::setDetectorID(), geo::GeometryBase::SetDetectorSize(), and geo::GeometryBase::SetDrawOptions().
Referenced by geo::GeometryBase::GeometryBase(), and preBeginRun().
|
protectedinherited |
Definition at line 731 of file GeometryBase.cxx.
References geo::GeometryBase::fPlanes, and geo::GeometryBase::fPlanesInMuonCatcher.
Referenced by geo::GeometryBase::FindPlanes().
|
protectedinherited |
Method to make a temporary file holding Detector geometry (gdml) file
Definition at line 102 of file GeometryBase.cxx.
References om::cerr, allTimeWatchdog::endl, fclose(), geo::GeometryBase::fGDMLFile, geo::GeometryBase::fParams, geo::GeometryBase::Params::StoreTempGeo, string, and tmp.
Referenced by preBeginRun().
|
inherited |
Return the column density between 2 points in gm/cm^2
p1 | : pointer to array holding xyz of first point in world coordinates |
p2 | : pointer to array holding xyz of second point in world coordinates |
Definition at line 1155 of file GeometryBase.cxx.
References E, demo0::length, geo::GeometryBase::MaterialsBetweenPoints(), file_size_ana::node, and util::pythag().
|
inherited |
Method to obtain current detector material at given (x,y,z) coordinates
Definition at line 444 of file GeometryBase.cxx.
References file_size_ana::node.
Referenced by geo::GeometryBase::calculateMassesLong(), and calib::EnergyStandardCandles::FillTrueMichelInfo().
|
inherited |
Definition at line 1208 of file GeometryBase.cxx.
References om::cerr, d, E, e, allTimeWatchdog::endl, file_size_ana::node, make_associated_cosmic_defs::p3, util::pythag(), and fillBadChanDBTables::step.
Referenced by calib::EnergyStandardCandles::FillTrueMichelInfo(), bpfit::Path::FindLayers(), bpfit::Path::IntegrateLeg(), geo::GeometryBase::MassBetweenPoints(), geo::GeometryBase::MaterialsBetweenPoints(), and geo::LiveGeometry::ProjectedSteelDist().
|
inherited |
Overloaded MaterialsBetweenPoints to for using TVector3 instead of arrays because rb::Track trajectory points are TVector3 and there is a desire to track a 'track' through the geometry. This will make that easier. Function is really just a wrapper around the array version
Definition at line 1258 of file GeometryBase.cxx.
References geo::GeometryBase::MaterialsBetweenPoints().
|
inherited |
Return the index of the next plane in a particular view
p1 | : Index of current plane |
d | : Direction to step in (>0 next down stream, <0 upstream) |
Asserts that p1 is in valid range |
Definition at line 936 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fPlanes, geo::kPLANE_NOT_FOUND, and plot_validation_datamc::p2.
Referenced by chaninfo::CosmicEff::analyze(), trk::KalmanTrack::FilterTracker(), calib::HasZAdjacents(), and geo::GeometryTest::testFindPlanes().
|
inherited |
Return the index of the next plane in a particular view
p1 | : Index of current plane |
d | : Direction to step in (>0 next down stream, <0 upstream) |
Asserts that p1 is in valid range |
Definition at line 960 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fPlanes, geo::kPLANE_NOT_FOUND, and plot_validation_datamc::p2.
Referenced by fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), lem::FindLEMMatches::MatchToVertex(), lem::LEM::MatchToVertex(), trk::KalmanGeoHelper::MatchTrajectoryToPlaneInView(), calib::AttenCache::RepresentativePlane(), geo::GeometryTest::testFindPlanes(), and lem::VertexToPlaneAndCell().
|
inherited |
Definition at line 460 of file GeometryBase.cxx.
References ana::assert(), geo::GeometryBase::fDetId, geo::GeometryBase::fPlanes, and novadaq::cnv::kUNKNOWN_DET.
Referenced by align::Alignment::analyze(), chaninfo::BadChanValidate::BadChansFromDB(), chaninfo::CosmicEff::beginRun(), dprf::ChannelPlots::beginRun(), dprf::TrackPlots::beginRun(), calib::HitEfficiency::beginRun(), rsim::ReadoutSim::beginRun(), calib::CosmicTrends::beginRun(), chaninfo::BadChanValidate::beginSubRun(), noe::build_cell_lookup_table(), geo::GeometryBase::CellInfo(), geo::GeometryBase::CellTpos(), trk::KalmanGeoHelper::CountMissedCellsOnLine(), LightLevels::CreateHistos(), rsim::ReadoutSim::CreateRawDigits(), lem::DefaultVertex(), evd::GeometryDrawer::DrawCells2D(), chaninfo::CosmicEff::endJob(), calib::AttenFit::endJob(), comi::ChanOcc::endSubRun(), rsim::IFPGAAlgorithm::FetchThresholds(), trk::KalmanGeoHelper::fillprivategeo(), trk::CosmicTrackUtilities::FindZBoundaries(), calib::FindZBoundaries(), evd::GeometryDrawer::GetBox(), evd::GeometryDrawer::GetDCMBoxes(), airshower::AirSlicer::GetHoughMap(), airshower::AirSlicer::GetHoughRhos(), calib::GetXYZD(), dt::DiscreteTracker::HighActivity(), calib::RockMuonStopperSelection::IsContainedStopper(), photrans::ImprovedTransport::LoadHistos(), chaninfo::BadChanList::LoadNewData(), lem::FindLEMMatches::MatchToVertex(), lem::LEM::MatchToVertex(), skim::ParametersNumu::ParametersNumu(), chaninfo::BadChanList::preBeginEvent(), trk::KalmanTrack::produce(), lem::AlignLibToVtx::produce(), cvn::RegCVNMapper::produce(), rsim::ReadoutSim::produce(), evd::RawDataDrawer::RawDigit2D(), lem::GenFromLib::readNext(), trk::KalmanGeoHelper::SetupHelper(), geo::GeometryTest::testCellId(), geo::GeometryTest::testCellIdFromPos(), dt::View::View(), and calib::AttenuationFit::writeResults().
|
inherited |
Direction of neutrinos from the NuMI beam (unit vector)
Because of the varying location of pion decays in the decay pipe, this can only be an average value in the ND and NDOS.
Definition at line 523 of file GeometryBase.cxx.
References e, geo::GeometryBase::fDetId, novadaq::cnv::kFARDET, novadaq::cnv::kNDOS, novadaq::cnv::kNEARDET, and novadaq::cnv::kTESTBEAM.
Referenced by cvn::CVNEventProngDump::analyze(), comi::NearlineAna::analyze(), slid::LIDTraining::analyze(), cosrej::CosRejFxs::getAngle(), numusand::NumuSandFxs::getAngle(), nuesand::FillNueSandbox::GetTrackAngle(), numue::NumuEAlg::NumuEAlg(), nussand::FillNusSandbox::produce(), slid::SliceLIDBuilder::produce(), cosrej::CosRej::produce(), comi::Cana::produce(), slid::LIDBuilder::produce(), jmshower::NueSel::produce(), slid::SPIDBuilder::produce(), jmshower::NueSelLID::produce(), cvn::CVNAddTrainingData::produce(), cosrej::MakeNueCosRej::produce(), jmshower::RecoJMShower::RecoShowers(), ncid::MakeNCCosRej::TransMomFraction(), ncid::NCNNKeras::TransMomFraction(), and cosrej::MakeNueCosRej::TransMomFraction().
Return the geometry description of the ith plane in the detector.
i | : input plane number, starting from 0 |
geo::Exception | if iplane is outside allowed range |
Definition at line 749 of file GeometryBase.cxx.
References geo::GeometryBase::fPlanes, and MECModelEnuComparisons::i.
Referenced by dif::DiFShowerFinder::adjustPlane(), dif::DiFShowerFinder::adjustPlane_end(), geo::GeometryTest::analyze(), mcchk::DetAna::analyze(), dprf::ChannelPlots::analyze(), zcl::SMMTriggerAna::analyze(), dprf::TrackPlots::analyze(), slicer::S4DParamCalc::analyze(), mcchk::CosmicAna::analyze(), mcchk::RockAna::analyze(), numue::NumuEAna::analyze(), align::Alignment::analyze(), sn::SNSlicerAna::analyze(), calib::AssessCalib::analyze(), calib::HitEfficiency::analyze(), mcchk::LeptonAna::analyze(), comi::NumiFilteringAna::analyze(), zcl::FmmTrackerAna::analyze(), zcl::FmmTrackerValidation::analyze(), trk::KalmanTrackAna::analyze(), showere::ShowerEnergyAna::analyze(), remid::ReMIdDedxRock::analyze(), remid::ReMIdDedxFD::analyze(), remid::ReMIdDedxStudies::analyze(), LightLevels::analyze(), calib::CosmicTrends::analyze(), htk::HoughTrack::analyze(), trk::CosmicTrackAna::analyze(), comi::Leana::AnaNHit(), calib::CalibAna::ApproximateHitPos(), chaninfo::BadChanValidate::BadChansFromDB(), trk::CosmicTrackAna::beginJob(), chaninfo::CosmicEff::beginRun(), dprf::ChannelPlots::beginRun(), mcchk::DetAna::beginRun(), dprf::TrackPlots::beginRun(), calib::DriftResponseCalc::beginRun(), rsim::ReadoutSim::beginRun(), calib::CosmicTrends::beginRun(), chaninfo::BadChanValidate::beginSubRun(), calib::BestPathEstimates(), noe::build_cell_lookup_table(), geo::GeometryBase::BuildMaps(), slid::ParticleIDAlg::CalcAsymIneria(), slid::ParticleIDAlg::CalcCellPlaneTransverseDedx(), slid::ParticleIDAlg::CalcPlaneTransverseDedx(), slid::ParticleIDAlg::CalcTrkHitPath(), trk::KalmanTrackMerge::CanJoinTracks(), evd::RecoBaseDrawer::CellHit2D(), evd::RecoBaseDrawer::CellHit3D(), geo::GeometryBase::CellInfo(), geo::GeometryBase::CellTpos(), murem::TrackCleanUpAlg::CleanUpTrack(), geo::GeometryBase::ClosestApproach(), dt::Cand::ClosestToEndCell(), sn::SNMichelAnalyzer::ClusterAroundTrackEnds(), remid::ReMIdTrain::ContainedEvent(), remid::ReMIdDedx::ContainedEvent(), remid::ReMIdDedxRock::ContainedEvent(), remid::ReMIdDedxStudies::ContainedEvent(), skim::SkimmingUtils::CopyProngs(), skim::SkimmingUtils::CopyShowers(), skim::SkimmingUtils::CopySlice(), skim::SkimmingUtils::CopyTracks(), geo::GeometryBase::CountCellsOnLine(), trk::KalmanGeoHelper::CountMissedCellsOnLine(), util::CountXY(), LightLevels::CreateHistos(), rsim::ReadoutSim::CreateRawDigits(), murem::TrackCleanUpAlg::DeDxInPlane(), lem::DefaultVertex(), dif::DiFShowerFinder::distancefromtrack(), sn::TrackActivityRemover::DistanceHitToPoint(), sn::SNMichelAnalyzer::DistanceHitToPoint(), sn::TrackActivityRemover::DistanceHitToTrackBody(), slid::DeconvolveAlg::DistanceToCore(), evd::GeometryDrawer::DrawCells2D(), evd::RecoBaseDrawer::DrawCluster2D(), evd::GeometryDrawer::DrawHighlightCell(), evd::RecoBaseDrawer::DrawTrack2D(), skim::ParametersNumu::EarliestLatestHitPos(), mcchk::ShowerAnaCheck::EMMoliereRadius(), mcchk::ShowerAnaCheck::EMShowerWidth(), chaninfo::CosmicEff::endJob(), calib::BetheBlochFit::endJob(), calib::AttenFit::endJob(), calib::FindOutliers::endRun(), comi::ChanOcc::endSubRun(), rsim::RecordNoiseSpectrumFile::endSubRun(), LightLevels::endSubRun(), dif::DiFShowerFinder::eparm(), calib::MakeAttenuationProfiles::event(), util::EventBox(), calib::AttenFit::expFit(), calib::AttenuationFit::expFit(), rsim::IFPGAAlgorithm::FetchThresholds(), geo::LiveGeometry::FillBadBoxes(), caf::FillHadClustVars(), calib::StopperThreshold::FillHist(), calib::CosmicTrends::FillHistograms(), bpfit::BreakPoint::FillHitList(), trk::KalmanGeoHelper::fillprivategeo(), caf::FillSliceInfo(), caf::FillSliceVars(), trk::CosmicTrackAna::FillTrackHistograms(), calib::StopperThreshold::FillTree(), calib::CosmicCalib::filter(), comi::NumiFiltering::filter(), bsf::BremShowerFilter::filter(), showere::ShowerEnergyFilterMC::filter(), calib::FindBelowThresholdCalibCandidates(), trk::WindowTrackingAlg::FindEndPoint(), bsf::BremShowerFilter::findShowerByReco(), dif::DiFShowerFinder::findShowerByReco(), trk::KalmanTrack::FindTracks(), trident::DimuonSliceAna::FindVertex(), bpfit::DimuonFitter::FindVertexZ(), trk::CosmicTrackUtilities::FindZBoundaries(), calib::FindZBoundaries(), bpfit::BreakPoint::FitTracks(), bpfit::DimuonFitter::FitView(), trk::WindowTrackingAlg::FitWindow(), evd::SimulationDrawer::FLSHit2D(), evd::SimulationDrawer::FLSHit3D(), align::SplitTracks::GeoEstimatePos(), mono::Monopole::get_position(), mono::SlowMonopoleAna::get_position(), numusand::NumuSandFxs::getActivity(), calib::Calibrator::GetAttenCurve(), cosrej::CosRejFxs::getBBC(), evd::SliceNavigator::GetBounds(), evd::GeometryDrawer::GetBox(), evd::SliceNavigator::GetBox(), jmshower::RecoJMShower::GetCellDistToPoint(), jmshower::RecoJMShower::GetCellDistToTrk(), align::SplitTracks::GetCellEndpoints(), slid::ParticleIDAlg::GetCellNodePos(), jmshower::RecoJMShower::GetCellNodePos(), jmshower::RecoJMShower::GetCellTransDedx(), jmshower::RecoJMShower::GetCentroid(), calib::CosmicCalib::GetChannelHists(), calib::MakeAttenuationProfiles::GetChannelHists(), evd::RecoBaseDrawer::GetClusterOutlinesConvexHull(), evd::GeometryDrawer::GetDCMBoxes(), nuesand::FillNueSandbox::GetdEdx(), geo::LiveGeometry::GetDetectorEdges(), skim::ParametersNumu::GetDetectorEdges(), cosrej::CosRejFxs::getFits(), airshower::AirSlicer::GetHitPos(), ndreco::NDRecoFxs::getProngActivity(), ndreco::NDRecoFxs::getProngDedx(), dt::Chunk::GetSegs(), ndreco::NDRecoFxs::getTrackActivity(), ndreco::NDRecoFxs::getTrackDedx(), jmshower::JMShower::GetTransHits(), jmshower::RecoJMShower::GetTrkCPlaneCell(), jmshower::RecoJMShower::GetTrkHitPath(), jmshower::RecoJMShower::GetTrkHitPos(), jmshower::RecoJMShower::GetTrkPlaneCell(), jmshower::RecoJMShower::GetTrkPlaneDistToEdge(), jmshower::RecoJMShower::GetTrkPlanePos(), calib::ThresholdAna::GetView(), calib::CosmicCalib::GetView(), calib::MakeAttenuationProfiles::GetView(), calib::AttenFit::GetView(), calib::AttenuationFit::GetView(), calib::AttenCache::GetView(), calib::GetXYZD(), slid::NuEEnergyAlg::HadronicDepEnergy(), calib::HasXYAdjacents(), dt::DiscreteTracker::HighActivity(), rb::HitList::HitList(), dt::Chunk::HitsOnLine(), nerd::NERDProng::HitToHitDistance(), me::MEFinder::HitToHitDistance(), geo::GeometryBase::IdToCell(), geo::GeometryBase::IdToPlane(), bsf::BremShowerFilter::inFiducial(), dif::DiFShowerFinder::inFiducial(), remid::RecoMuon::IsTrackContained(), trk::CosmicTrackAlg::IsTrackDownstreamFromTiming(), skim::EvaluatorNue::KeepSlice(), calib::AttenCache::LoadFromDatabase(), photrans::ImprovedTransport::LoadHistos(), chaninfo::BadChanList::LoadNewData(), trk::WindowTrackingAlg::LookForBremsstrahlungHits(), trk::WindowTrackingAlg::Make3DTrack(), calib::Calibrator::MakeCellHit(), evtsum::EventSummary::MakeOutput(), trk::CosmicTrackAlg::MakeTrack(), trk::WindowTrackingAlg::MakeTrack(), trk::WindowTrackingAlg::MakeViewTrack(), calib::MakeZBoundaryMap(), fuzz::ViewMatchAlg::Matching(), nerd::ViewMatchAlg::Matching(), lem::FindLEMMatches::MatchToVertex(), lem::LEM::MatchToVertex(), trk::KalmanGeoHelper::MatchTrajectoryToPlane(), trk::KalmanGeoHelper::MatchTrajectoryToPlaneInView(), rb::Cluster::MinMaxMeanXYZ(), zcl::SMMCluster::MissC(), dif::DiFShowerFinder::muonstub(), numue::NumuEAlg::NumuEAlg(), evd::RecoBaseDrawer::OfflineChans2D(), skim::ParametersNumu::ParametersNumu(), trk::CosmicTrackUtilities::PathLengthInCell(), calib::PathLengthInCell(), calib::CosmicCalib::PCHitPE(), calib::MakeAttenuationProfiles::PCHitPE(), rb::Track::PlaneDirMap(), slid::ParticleIDAlg::PlaneHitCell(), slid::ParticleIDAlg::PlaneHitXYZ(), slid::ParticleIDAlg::PlaneRadius(), chaninfo::BadChanList::preBeginEvent(), ddthelpers::print(), photrans::PhotonSystRewriter::produce(), hv::HoughVertex::produce(), trk::KalmanTrack::produce(), trk::KalmanTrackMerge::produce(), slid::Recluster::produce(), numusand::FillSandbox::produce(), jmshower::JMTrackMerge::produce(), lem::AlignLibToVtx::produce(), lem::MakeLibrary::produce(), zcl::SMMCluster::produce(), photrans::PhotonTransport::produce(), vdt::VertexDT::produce(), jmshower::NueSel::produce(), cvn::RegCVNMapper::produce(), jmshower::NueSelLID::produce(), cheat::MCCheater::produce(), remid::RecoMuon::produce(), rsim::ReadoutSim::produce(), caf::CAFMaker::produce(), slid::ParticleIDAlg::Radius(), evd::RawDataDrawer::RawDigit2D(), lem::GenFromLib::readNext(), jmshower::RecoJMShower::RecoShowers(), calib::AttenCache::RepresentativePlane(), trk::RLFit::RLFit(), hough::MultiHoughT::Scrub(), earms::ElasticArmsHS::Scrub(), vdt::VertexDT::Scrub(), fuzz::FuzzyKVertex::Scrub(), geo::GeometryBase::SetDetectorSize(), chaninfo::BadChanList::SetRandomBadChannels(), trk::WindowTrackingAlg::SetTrackEndPoints(), trk::KalmanTrackMerge::ShiftInterpolationPoints(), trk::WindowTrackingAlg::ShortTrack(), trk::WindowTrackingAlg::ShortTrackExtraPlane(), trk::WindowTrackingAlg::ShortViewTrack(), skim::SkimmingUtils::SkimmingUtils(), lem::MakeLibrary::SliceMeanPosEWeighted(), murem::TrackCleanUpAlg::SortByDistFromTrack(), photrans::ImprovedTransport::StepAlongHit(), geo::GeometryTest::testCellId(), geo::GeometryTest::testCellIdFromPos(), geo::GeometryTest::testFindCell(), geo::GeometryTest::testFindPlanes(), calib::StopperThreshold::testPath(), geo::GeometryTest::testStepping(), geo::GeometryTest::testUniqueId(), rb::Prong::TotalLength(), dt::Chain::ToTrack(), zcl::FMMTracker::Tracking2D(), trk::CosmicTrackUtilities::TrackResiduals(), calib::AttenCache::TranslateChannelMC(), trk::CosmicTrackUtilities::TruePathLengthInCell(), slid::NuEEnergyAlg::VertexEnergy(), lem::VertexToPlaneAndCell(), dt::View::View(), trk::KalmanTrackMerge::ViewMergeTracks(), rb::Prong::W(), rb::Track::W(), calib::AttenuationFit::writeResults(), and calib::ZBounds().
Definition at line 59 of file Geometry_service.cc.
References om::cout, geo::GeometryBase::DetId(), allTimeWatchdog::endl, geo::GeometryBase::fGDMLFile, geo::GeometryBase::fGDMLFromFCL, geo::GeometryBase::FindGDMLFile(), fLoadedGDMLInfo, geo::GeometryBase::Params::ForceUseFCLOnly, geo::GeometryBase::fParams, geo::GeometryBase::fROOTFile, geo::GeometryBase::fRunNumber, art::DataViewImpl::getManyByType(), geo::GeometryBase::LoadGeometryFile(), geo::GeometryBase::MakeTmpFile(), geo::GeometryBase::RemoveTmpFile(), art::Run::run(), and string.
Referenced by Geometry().
|
protectedinherited |
Method to remove temporary file that holds detector geometry file.
Definition at line 175 of file GeometryBase.cxx.
Referenced by preBeginRun(), ~Geometry(), and geo::GeometryBase::~GeometryBase().
|
inlineinherited |
Definition at line 236 of file GeometryBase.h.
|
inherited |
Definition at line 1508 of file GeometryBase.cxx.
Referenced by red::EWCosmics::analyze(), geo::GeometryBase::calculateMassesLong(), calib::BetheBlochFit::endJob(), red::OverburdenCalculator::onBeginRun(), supernova::SnovaGen::SnovaGen(), and g4n::FLSHitListAction::SteppingAction().
|
inlineinherited |
Definition at line 239 of file GeometryBase.h.
|
protectedinherited |
Get the Detector size
Dimensions of the DetectorBigBox in cm
Definition at line 1350 of file GeometryBase.cxx.
References geo::GeometryBase::DetectorEnclosureBox(), geo::GeometryBase::fDetectorBigBoxXHi, geo::GeometryBase::fDetectorBigBoxXLo, geo::GeometryBase::fDetectorBigBoxYHi, geo::GeometryBase::fDetectorBigBoxYLo, geo::GeometryBase::fDetectorBigBoxZHi, geo::GeometryBase::fDetectorBigBoxZLo, geo::GeometryBase::fIsDetectorBigBoxUsed, x1, submit_syst::x2, y1, and submit_syst::y2.
Referenced by geo::GeometryBase::LoadGeometryFile().
|
overrideprotectedvirtual |
Method to set DetectorID.
Method to set DetectorID
Reimplemented from geo::GeometryBase.
Definition at line 196 of file Geometry_service.cc.
References DEFINE_ART_SERVICE, geo::GeometryBase::fDetId, ds::DetectorService::SetDetector(), and geo::GeometryBase::setDetectorID().
Referenced by Geometry().
|
protectedinherited |
Calculate the detector size based on the geometry. Requires a little bit of work, so do this once when the geometry is updated
If there no Vertical or horizontal planes, then we go get the size from the Detector Enclosure It used to be that once this condition is true, then it we would just throw an exception. However, now Giuseppe Ferone and Denis Perevalov are studying interactions in simple detector, which don't have planes in it. Thus, they don't want the code breaking.
Getting Detector enclosure volume
Lo and Hi ranges of each of the axes. To be filled later
Fill them
Set detector size
Definition at line 1274 of file GeometryBase.cxx.
References APDHVSetting::dummy, geo::GeometryBase::fDetHalfHeight, geo::GeometryBase::fDetHalfWidth, geo::GeometryBase::fDetLength, geo::GeometryBase::fPlanes, and geo::GeometryBase::Plane().
Referenced by geo::GeometryBase::LoadGeometryFile().
|
protectedinherited |
Definition at line 691 of file GeometryBase.cxx.
Referenced by geo::GeometryBase::LoadGeometryFile().
|
inherited |
A typical y-position value at the surface (where earth meets air) for this detector site
geo::Exception | if detector ID is not set properly |
Definition at line 500 of file GeometryBase.cxx.
References geo::GeometryBase::fDetId, makeTrainCVSamples::int, novadaq::cnv::kFARDET, novadaq::cnv::kNDOS, novadaq::cnv::kNEARDET, and novadaq::cnv::kTESTBEAM.
Referenced by evgen::CosmicsGen::produce(), evgen::CosmicPionGen::produce(), and evgen::CosmicsGen::ProjectCosmicsToSurface().
|
inherited |
Return the total mass of the detector
Definition at line 1036 of file GeometryBase.cxx.
References d, Munits::nm, file_size_ana::node, and string.
Referenced by geo::GeometryTest::analyze().
|
inherited |
Return the ranges of x,y and z for the "world volume" that the entire geometry lives in. If any pointers are 0, then those coordinates are ignored.
xlo | : On return, lower bound on x positions |
xhi | : On return, upper bound on x positions |
ylo | : On return, lower bound on y positions |
yhi | : On return, upper bound on y positions |
zlo | : On return, lower bound on z positions |
zhi | : On return, upper bound on z positions |
Definition at line 595 of file GeometryBase.cxx.
References ana::assert(), x1, submit_syst::x2, y1, and submit_syst::y2.
Referenced by evgen::CORSIKAGen::GetSample(), g4n::FLSHitListAction::ParticleProjection(), evgen::CosmicsGen::ProjectCosmicsToSurface(), and geo::GeometryTest::testProject().
|
protectedinherited |
List of all planes.
Definition at line 295 of file GeometryBase.h.
Referenced by geo::GeometryBase::BuildMaps(), and geo::GeometryBase::GetPlanesByView().
|
protectedinherited |
Range of big box.
Definition at line 311 of file GeometryBase.h.
Referenced by geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
Definition at line 321 of file GeometryBase.h.
|
protectedinherited |
Definition at line 321 of file GeometryBase.h.
|
protectedinherited |
Definition at line 321 of file GeometryBase.h.
|
protectedinherited |
Definition at line 321 of file GeometryBase.h.
|
protectedinherited |
Coordinate Transformation class.
Definition at line 289 of file GeometryBase.h.
Referenced by geo::GeometryBase::setDetectorID().
|
protectedinherited |
Dimensions of the DetectorBigBox in cm.
Definition at line 314 of file GeometryBase.h.
Referenced by geo::GeometryBase::DetectorBigBox(), geo::GeometryBase::IntersectsBigBox(), geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::setDetectorBigBox().
|
protectedinherited |
Definition at line 315 of file GeometryBase.h.
Referenced by geo::GeometryBase::DetectorBigBox(), geo::GeometryBase::IntersectsBigBox(), geo::GeometryBase::isInsideDetectorBigBox(), geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::setDetectorBigBox().
|
protectedinherited |
Definition at line 316 of file GeometryBase.h.
Referenced by geo::GeometryBase::DetectorBigBox(), geo::GeometryBase::IntersectsBigBox(), geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::setDetectorBigBox().
|
protectedinherited |
Definition at line 317 of file GeometryBase.h.
Referenced by geo::GeometryBase::DetectorBigBox(), geo::GeometryBase::IntersectsBigBox(), geo::GeometryBase::isInsideDetectorBigBox(), geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::setDetectorBigBox().
|
protectedinherited |
Definition at line 318 of file GeometryBase.h.
Referenced by geo::GeometryBase::DetectorBigBox(), geo::GeometryBase::IntersectsBigBox(), geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::setDetectorBigBox().
|
protectedinherited |
Definition at line 319 of file GeometryBase.h.
Referenced by geo::GeometryBase::DetectorBigBox(), geo::GeometryBase::IntersectsBigBox(), geo::GeometryBase::isInsideDetectorBigBox(), geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::setDetectorBigBox().
|
protectedinherited |
Detector 1/2 height (cm)
Definition at line 300 of file GeometryBase.h.
Referenced by geo::GeometryBase::calculateMassesLong(), geo::GeometryBase::DEdge(), geo::GeometryBase::DetHalfHeight(), geo::GeometryBase::IntersectsDetector(), geo::GeometryBase::LoadGeometryFile(), geo::GeometryBase::setDetectorID(), and geo::GeometryBase::SetDetectorSize().
|
protectedinherited |
Detector 1/2 width (cm)
Definition at line 301 of file GeometryBase.h.
Referenced by geo::GeometryBase::calculateMassesLong(), geo::GeometryBase::DEdge(), geo::GeometryBase::DetHalfWidth(), geo::GeometryBase::IntersectsDetector(), geo::GeometryBase::LoadGeometryFile(), geo::GeometryBase::setDetectorID(), and geo::GeometryBase::SetDetectorSize().
|
protectedinherited |
id for the detector being used
Definition at line 285 of file GeometryBase.h.
Referenced by geo::GeometryBase::BoosterBeamDirection(), geo::GeometryBase::DetHalfHeight(), geo::GeometryBase::DetHalfWidth(), geo::GeometryBase::DetLength(), Geometry(), geo::GeometryBase::NPlanes(), geo::GeometryBase::NuMIBeamDirection(), setDetectorID(), geo::GeometryBase::setDetectorID(), and geo::GeometryBase::SurfaceY().
|
protectedinherited |
Detector length (cm)
Definition at line 299 of file GeometryBase.h.
Referenced by geo::GeometryBase::calculateMassesLong(), geo::GeometryBase::DEdge(), geo::GeometryBase::DetLength(), geo::GeometryBase::IntersectsDetector(), geo::GeometryBase::LoadGeometryFile(), geo::GeometryBase::setDetectorID(), and geo::GeometryBase::SetDetectorSize().
|
protectedinherited |
Definition at line 323 of file GeometryBase.h.
Referenced by geo::GeometryBase::FiducialBox(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
Definition at line 324 of file GeometryBase.h.
Referenced by geo::GeometryBase::FiducialBox(), geo::GeometryBase::isInsideFiducialVolume(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
Definition at line 325 of file GeometryBase.h.
Referenced by geo::GeometryBase::FiducialBox(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
Definition at line 326 of file GeometryBase.h.
Referenced by geo::GeometryBase::FiducialBox(), geo::GeometryBase::isInsideFiducialVolume(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
Definition at line 327 of file GeometryBase.h.
Referenced by geo::GeometryBase::FiducialBox(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
Definition at line 328 of file GeometryBase.h.
Referenced by geo::GeometryBase::FiducialBox(), geo::GeometryBase::isInsideFiducialVolume(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
gdml file holding the geometry
Definition at line 281 of file GeometryBase.h.
Referenced by geo::GeometryBase::ExtractGDML(), geo::GeometryBase::FileBaseName(), geo::GeometryBase::GeometryBase(), geo::GeometryBase::MakeTmpFile(), preBeginRun(), ~Geometry(), and geo::GeometryBase::~GeometryBase().
|
protectedinherited |
keep track of original fcl parameter
Definition at line 283 of file GeometryBase.h.
Referenced by geo::GeometryBase::GeometryBase(), and preBeginRun().
|
protectedinherited |
Unique ID -> Plane,Cell.
Definition at line 293 of file GeometryBase.h.
Referenced by geo::GeometryBase::BuildMaps(), geo::GeometryBase::getPlaneCellMap(), and geo::GeometryBase::LoadGeometryFile().
|
protectedinherited |
Do we need to use the BigBox cut?
Definition at line 310 of file GeometryBase.h.
Referenced by geo::GeometryBase::LoadGeometryFile(), geo::GeometryBase::setDetectorBigBox(), and geo::GeometryBase::setDetectorID().
|
protected |
Definition at line 43 of file Geometry.h.
Referenced by preBeginRun().
|
protectedinherited |
Definition at line 279 of file GeometryBase.h.
Referenced by geo::GeometryBase::GeometryBase(), geo::GeometryBase::MakeTmpFile(), preBeginRun(), and geo::GeometryBase::setDetectorID().
|
protectedinherited |
The detector planes.
Definition at line 291 of file GeometryBase.h.
Referenced by geo::GeometryBase::BuildMaps(), geo::GeometryBase::CountCellsOnLineFast(), geo::GeometryBase::FirstPlaneInMuonCatcher(), geo::GeometryBase::LoadGeometryFile(), geo::GeometryBase::MakePlane(), geo::GeometryBase::NextPlaneInView(), geo::GeometryBase::NextPlaneOtherView(), geo::GeometryBase::NPlanes(), geo::GeometryBase::Plane(), geo::GeometryBase::SetDetectorSize(), and geo::GeometryBase::~GeometryBase().
|
protectedinherited |
Same pointers as fPlanes.
Definition at line 292 of file GeometryBase.h.
Referenced by geo::GeometryBase::FirstPlaneInMuonCatcher(), geo::GeometryBase::LoadGeometryFile(), and geo::GeometryBase::MakePlane().
|
protectedinherited |
root file holding the geometry
Definition at line 282 of file GeometryBase.h.
Referenced by geo::GeometryBase::GeometryBase(), and preBeginRun().
|
protectedinherited |
Run number of configuration.
Definition at line 332 of file GeometryBase.h.
Referenced by preBeginRun().
|
protectedinherited |
folder to store temp geo file
Definition at line 330 of file GeometryBase.h.
|
protectedinherited |
List of X measuring planes.
Definition at line 296 of file GeometryBase.h.
Referenced by geo::GeometryBase::BuildMaps(), and geo::GeometryBase::GetPlanesByView().
|
protectedinherited |
List of Y measuring planes.
Definition at line 297 of file GeometryBase.h.
Referenced by geo::GeometryBase::BuildMaps(), and geo::GeometryBase::GetPlanesByView().